=================================================================== RCS file: /home/cvs/OpenXM_contrib2/asir2000/builtin/gr.c,v retrieving revision 1.24 retrieving revision 1.40 diff -u -p -r1.24 -r1.40 --- OpenXM_contrib2/asir2000/builtin/gr.c 2001/09/07 08:54:57 1.24 +++ OpenXM_contrib2/asir2000/builtin/gr.c 2001/11/19 01:40:04 1.40 @@ -45,104 +45,37 @@ * DEVELOPER SHALL HAVE NO LIABILITY IN CONNECTION WITH THE USE, * PERFORMANCE OR NON-PERFORMANCE OF THE SOFTWARE. * - * $OpenXM: OpenXM_contrib2/asir2000/builtin/gr.c,v 1.23 2001/09/05 08:09:10 noro Exp $ + * $OpenXM: OpenXM_contrib2/asir2000/builtin/gr.c,v 1.39 2001/11/19 00:57:10 noro Exp $ */ #include "ca.h" #include "parse.h" #include "base.h" #include "ox.h" -#define ITOS(p) (((unsigned int)(p))&0x7fffffff) -#define STOI(i) ((P)((unsigned int)(i)|0x80000000)) +#if defined(__GNUC__) +#define INLINE inline +#elif defined(VISUAL) +#define INLINE __inline +#else +#define INLINE +#endif -#define NEXTVL(r,c) \ -if(!(r)){NEWVL(r);(c)=(r);}else{NEWVL(NEXT(c));(c)=NEXT(c);} - #define HMAG(p) (p_mag(BDY(p)->c)) -struct dp_pairs { - int dp1, dp2; - DL lcm; - int sugar; - struct dp_pairs *next; -}; +#define NEWDP_pairs ((DP_pairs)MALLOC(sizeof(struct dp_pairs))) -typedef struct dp_pairs *DP_pairs; +static DP_pairs collect_pairs_of_hdlcm( DP_pairs d1, DP_pairs *prest ); +double get_rtime(); -#define NEWDPP(a) ((a)=(DP_pairs)MALLOC(sizeof(struct dp_pairs))) - -#define NEXTDPP(r,c) \ -if(!(r)){NEWDPP(r);(c)=(r);}else{NEWDPP(NEXT(c));(c)=NEXT(c);} - struct oEGT eg_nf,eg_nfm; struct oEGT eg_znfm,eg_pz,eg_np,eg_ra,eg_mc,eg_gc; int TP,NBP,NMP,NFP,NDP,ZR,NZR; -#define NEWDP_pairs ((DP_pairs)MALLOC(sizeof(struct dp_pairs))) - extern int (*cmpdl)(); extern int do_weyl; extern DP_Print; -void dp_imul_d(DP,Q,DP *); -void print_stat(void); -void init_stat(void); -int dp_load_t(int,DP *); -void dp_load(int,DP *); -void dp_save(int,Obj,char *); -void dp_make_flaglist(LIST *); -void dp_set_flag(Obj,Obj); -int membercheck(NODE,NODE); -int gbcheck(NODE); -int dl_redble(DL,DL); -NODE remove_reducibles(NODE,int); -NODE updbase(NODE,int); -DP_pairs criterion_F(DP_pairs); -int criterion_2(int,int); -static DP_pairs collect_pairs_of_hdlcm(DP_pairs,DP_pairs *); -DP_pairs criterion_M(DP_pairs); -DP_pairs criterion_B(DP_pairs,int); -DP_pairs newpairs(NODE,int); -DP_pairs updpairs(DP_pairs,NODE,int); -void _dp_nf(NODE,DP,DP *,int,DP *); -void _dp_nf_z(NODE,DP,DP *,int,int,DP *); -NODE gb_mod(NODE,int); -NODE gbd(NODE,int,NODE,NODE); -NODE gb(NODE,int,NODE); -NODE gb_f4(NODE); -NODE gb_f4_mod(NODE,int); -DP_pairs minp(DP_pairs, DP_pairs *); -void minsugar(DP_pairs,DP_pairs *,DP_pairs *); -NODE append_one(NODE,int); -void reducebase_dehomo(NODE,NODE *); -int newps_mod(DP,int); -int newps_nosave(DP,int,NODE); -int newps(DP,int,NODE); -void reduceall_mod(NODE,int,NODE *); -void reduceall(NODE,NODE *); -NODE NODE_sortbi(NODE,int); -NODE NODE_sortbi_insert(int, NODE,int); -NODE NODE_sortb(NODE,int); -NODE NODE_sortb_insert(DP,NODE,int); -void prim_part(DP,int,DP *); -void setup_arrays(NODE,int,NODE *); -int validhc(P,int,NODE); -void vlminus(VL,VL,VL *); -void printsubst(NODE); -void makesubst(VL,NODE *); -void pltovl(LIST,VL *); -void printdl(DL); -int DPPlength(DP_pairs); -void dp_gr_mod_main(LIST,LIST,Num,int,struct order_spec *,LIST *); -void dp_gr_main(LIST,LIST,Num,int,int,struct order_spec *,LIST *); -void dp_f4_main(LIST,LIST,struct order_spec *,LIST *); -void dp_f4_mod_main(LIST,LIST,int,struct order_spec *,LIST *); -double get_rtime(); -void _dpmod_to_vect(DP,DL *,int *); -void dp_to_vect(DP,DL *,Q *); -NODE dp_dllist(DP f); -NODE symb_merge(NODE,NODE,int),_symb_merge(NODE,NODE,int); extern int dp_nelim; extern int dp_fcoeffs; static DP *ps,*psm; @@ -182,9 +115,11 @@ int doing_f4; NODE TraceList; NODE AllTraceList; -int eqdl(nv,dl1,dl2) -int nv; -DL dl1,dl2; +void Pox_cmo_rpc(NODE,Obj *); +void Pox_rpc(NODE,Obj *); +void Pox_pop_local(NODE,Obj *); + +INLINE int eqdl(int nv,DL dl1,DL dl2) { int i; int *b1,*b2; @@ -202,10 +137,7 @@ DL dl1,dl2; /* b[] should be cleared */ -void _dpmod_to_vect(f,at,b) -DP f; -DL *at; -int *b; +void _dpmod_to_vect(DP f,DL *at,int *b) { int i,nv; MP m; @@ -217,35 +149,39 @@ int *b; } } -/* create compressed poly */ +/* [t,findex] -> tf -> compressed vector */ -void _dpmod_to_vect_compress(f,at,b) -DP f; -DL *at; -CDP *b; +void _tf_to_vect_compress(NODE tf,DL *at,CDP *b) { - int i,j,nv,len; + int i,j,k,nv,len; + DL t,s,d1; + DP f; MP m; CDP r; + t = (DL)BDY(tf); + f = ps[(int)BDY(NEXT(tf))]; + nv = f->nv; for ( m = BDY(f), len = 0; m; m = NEXT(m), len++ ); r = (CDP)MALLOC(sizeof(struct oCDP)); r->len = len; - r->body = (CMP)MALLOC(sizeof(struct oCMP)*len); + r->psindex = (int)BDY(NEXT(tf)); + r->body = (unsigned int *)MALLOC_ATOMIC(sizeof(unsigned int)*len); + NEWDL_NOINIT(s,nv); for ( m = BDY(f), i = j = 0; m; m = NEXT(m), j++ ) { - for ( ; !eqdl(nv,m->dl,at[i]); i++ ); - r->body[j].index = i; - r->body[j].c = ITOS(m->c); + d1 = m->dl; + s->td = t->td+d1->td; + for ( k = 0; k < nv; k++ ) + s->d[k] = t->d[k]+d1->d[k]; + for ( ; !eqdl(nv,s,at[i]); i++ ); + r->body[j] = i; } *b = r; } -void dp_to_vect(f,at,b) -DP f; -DL *at; -Q *b; +void dp_to_vect(DP f,DL *at,Q *b) { int i,nv; MP m; @@ -257,8 +193,7 @@ Q *b; } } -NODE dp_dllist(f) -DP f; +NODE dp_dllist(DP f) { MP m; NODE mp,mp0; @@ -273,9 +208,32 @@ DP f; return mp0; } -void pdl(f) -NODE f; +NODE mul_dllist(DL d,DP f) { + MP m; + NODE mp,mp0; + DL t,d1; + int i,nv; + + if ( !f ) + return 0; + nv = NV(f); + mp0 = 0; + for ( m = BDY(f); m; m = NEXT(m) ) { + NEXTNODE(mp0,mp); + NEWDL_NOINIT(t,nv); + d1 = m->dl; + t->td = d->td+d1->td; + for ( i = 0; i < nv; i++ ) + t->d[i] = d->d[i]+d1->d[i]; + BDY(mp) = (pointer)t; + } + NEXT(mp) = 0; + return mp0; +} + +void pdl(NODE f) +{ while ( f ) { printdl(BDY(f)); f = NEXT(f); } @@ -283,12 +241,7 @@ NODE f; printf("\n"); } -void dp_gr_main(f,v,homo,modular,field,ord,rp) -LIST f,v; -Num homo; -int modular,field; -struct order_spec *ord; -LIST *rp; +void dp_gr_main(LIST f,LIST v,Num homo,int modular,int field,struct order_spec *ord,LIST *rp) { int i,mindex,m,nochk; struct order_spec ord1; @@ -388,12 +341,7 @@ LIST *rp; fprintf(asir_out,"\nMax_mag=%d\n",Max_mag); } -void dp_gr_mod_main(f,v,homo,m,ord,rp) -LIST f,v; -Num homo; -int m; -struct order_spec *ord; -LIST *rp; +void dp_gr_mod_main(LIST f,LIST v,Num homo,int m,struct order_spec *ord,LIST *rp) { struct order_spec ord1; VL fv,vv,vc; @@ -458,15 +406,11 @@ extern struct oEGT eg_red_mod; MKLIST(*rp,r0); } -void dp_f4_main(f,v,ord,rp) -LIST f,v; -struct order_spec *ord; -LIST *rp; +void dp_f4_main(LIST f,LIST v,struct order_spec *ord,LIST *rp) { - int i,mindex,m,nochk; - struct order_spec ord1; + int homogen; VL fv,vv,vc; - NODE fd,fd0,fi,fi0,r,r0,t,subst,x,s,xx; + NODE fd,fd0,r,r0,t,x,s,xx; dp_fcoeffs = 0; get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&vc); @@ -475,13 +419,17 @@ LIST *rp; if ( ord->id && NVars != ord->nv ) error("dp_f4_main : invalid order specification"); initd(ord); - for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) { + for ( fd0 = 0, t = BDY(f), homogen = 1; t; t = NEXT(t) ) { NEXTNODE(fd0,fd); ptod(CO,vv,(P)BDY(t),(DP *)&BDY(fd)); + if ( homogen ) + homogen = dp_homogeneous(BDY(fd)); } if ( fd0 ) NEXT(fd) = 0; setup_arrays(fd0,0,&s); x = gb_f4(s); - reduceall(x,&xx); x = xx; + if ( !homogen ) { + reduceall(x,&xx); x = xx; + } for ( r0 = 0; x; x = NEXT(x) ) { NEXTNODE(r0,r); dp_load((int)BDY(x),&ps[(int)BDY(x)]); dtop(CO,vv,ps[(int)BDY(x)],(P *)&BDY(r)); @@ -490,17 +438,12 @@ LIST *rp; MKLIST(*rp,r0); } -void dp_f4_mod_main(f,v,m,ord,rp) -LIST f,v; -int m; -struct order_spec *ord; -LIST *rp; +void dp_f4_mod_main(LIST f,LIST v,int m,struct order_spec *ord,LIST *rp) { - int i; - struct order_spec ord1; + int homogen; VL fv,vv,vc; DP b,c,c1; - NODE fd,fd0,fi,fi0,r,r0,t,subst,x,s,xx; + NODE fd,fd0,r,r0,t,x,s,xx; dp_fcoeffs = 0; get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&vc); @@ -509,8 +452,10 @@ LIST *rp; if ( ord->id && NVars != ord->nv ) error("dp_f4_mod_main : invalid order specification"); initd(ord); - for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) { + for ( fd0 = 0, t = BDY(f), homogen = 1; t; t = NEXT(t) ) { ptod(CO,vv,(P)BDY(t),&b); + if ( homogen ) + homogen = dp_homogeneous(b); _dp_mod(b,m,0,&c); _dp_monic(c,m,&c1); if ( c ) { @@ -519,32 +464,37 @@ LIST *rp; } if ( fd0 ) NEXT(fd) = 0; setup_arrays(fd0,m,&s); - x = gb_f4_mod(s,m); - reduceall_mod(x,m,&xx); x = xx; + init_stat(); + if ( do_weyl ) + x = gb_f4_mod_old(s,m); + else + x = gb_f4_mod(s,m); + if ( !homogen ) { + reduceall_mod(x,m,&xx); x = xx; + } for ( r0 = 0; x; x = NEXT(x) ) { NEXTNODE(r0,r); _dtop_mod(CO,vv,ps[(int)BDY(x)],(P *)&BDY(r)); } if ( r0 ) NEXT(r) = 0; MKLIST(*rp,r0); + print_stat(); } -NODE gb_f4(f) -NODE f; +NODE gb_f4(NODE f) { - int i,j,k,nh,row,col,nv; + int i,k,nh,row,col,nv; NODE r,g,gall; NODE s,s0; DP_pairs d,dm,dr,t; - DP h,nf,nf1,f1,f2,f21,f21r,sp,sp1,sd,sdm,tdp; + DP nf,nf1,f2,sp,sd,tdp; MP mp,mp0; - NODE blist,bt,nt; + NODE blist,bt; DL *ht,*at; MAT mat,nm; - int *colstat; int *rind,*cind; int rank,nred; Q dn; - struct oEGT tmp0,tmp1,tmp2,eg_split_symb,eg_split_elim; + struct oEGT tmp0,tmp1,eg_split_symb; extern struct oEGT eg_mod,eg_elim,eg_chrem,eg_gschk,eg_intrat,eg_symb; init_eg(&eg_mod); init_eg(&eg_elim); init_eg(&eg_chrem); @@ -649,33 +599,39 @@ NODE f; /* initial bases are monic */ -NODE gb_f4_mod(f,m) -NODE f; -int m; +unsigned int **psca; + +NODE gb_f4_mod(NODE f,int m) { int i,j,k,nh,row,col,nv; NODE r,g,gall; NODE s,s0; DP_pairs d,dm,dr,t; - DP h,nf,f1,f2,f21,f21r,sp,sp1,sd,sdm,tdp; + DP nf,sp,sd,tdp; MP mp,mp0; - NODE blist,bt,nt; - DL *ht,*at,*st; + NODE blist,bt,bt1,dt; + DL *at,*st; int **spmat; CDP *redmat; - int *colstat,*w; - int rank,nred,nsp,nonzero,spcol; + int *colstat,*w,*w1; + int rank,nred,nsp,nsp0,nonzero,spcol; int *indred,*isred; CDP ri; - struct oEGT tmp0,tmp1,tmp2,eg_split_symb,eg_split_elim1,eg_split_elim2; + int pscalen; + struct oEGT tmp0,tmp1,eg_split_symb,eg_split_elim1,eg_split_elim2; extern struct oEGT eg_symb,eg_elim1,eg_elim2; + /* initialize coeffcient array list of ps[] */ + pscalen = pslen; + psca = (unsigned int **)MALLOC(pscalen*sizeof(unsigned int *)); + init_eg(&eg_symb); init_eg(&eg_elim1); init_eg(&eg_elim2); for ( gall = g = 0, d = 0, r = f; r; r = NEXT(r) ) { i = (int)BDY(r); d = updpairs(d,g,i); g = updbase(g,i); gall = append_one(gall,i); + dptoca(ps[i],&psca[i]); } if ( gall ) nv = ((DP)ps[(int)BDY(gall)])->nv; @@ -688,32 +644,223 @@ int m; /* asph : sum of all head terms of spoly */ for ( t = dm; t; t = NEXT(t) ) { _dp_sp_mod(ps[t->dp1],ps[t->dp2],m,&sp); +/* fprintf(stderr,"splen=%d-",dp_nt(sp)); */ if ( sp ) { MKNODE(bt,sp,blist); blist = bt; s0 = symb_merge(s0,dp_dllist(sp),nv); +/* fprintf(stderr,"%d-",length(s0)); */ } } + if ( DP_Print ) + fprintf(asir_out,"initial spmat : %d x %d ",length(blist),length(s0)); /* s0 : all the terms appeared in symbolic reduction */ -#if 0 for ( s = s0, nred = 0; s; s = NEXT(s) ) { - for ( j = psn-1; j >= 0; j-- ) - if ( _dl_redble(BDY(ps[j])->dl,BDY(s),nv) ) + for ( r = gall; r; r = NEXT(r) ) + if ( _dl_redble(BDY(ps[(int)BDY(r)])->dl,BDY(s),nv) ) break; - if ( j >= 0 ) { + if ( r ) { dltod(BDY(s),nv,&tdp); - dp_subd(tdp,ps[j],&sd); - for ( k = 0, i = 0; k < nv; k++ ) - if ( BDY(sd)->dl->d[k] ) - i++; - fprintf(stderr,"%c ",i<=1 ? 'o' : 'x'); - _dp_mod(sd,m,0,&sdm); - mulmd_dup(m,sdm,ps[j],&f2); - MKNODE(bt,f2,blist); blist = bt; - s = symb_merge(s,dp_dllist(f2),nv); + dp_subd(tdp,ps[(int)BDY(r)],&sd); + dt = mul_dllist(BDY(sd)->dl,ps[(int)BDY(r)]); +/* fprintf(stderr,"[%d]",length(dt)); */ + /* list of [t,f] */ + bt1 = mknode(2,BDY(sd)->dl,BDY(r)); + MKNODE(bt,bt1,blist); blist = bt; + symb_merge(s,dt,nv); +/* fprintf(stderr,"%d-",length(s)); */ nred++; } } -#else +/* fprintf(stderr,"\n"); */ + if ( DP_Print ) + fprintf(asir_out,"number of reducers : %d\n",nred); + + /* the first nred polys in blist are reducers */ + /* row = the number of all the polys */ + for ( r = blist, row = 0; r; r = NEXT(r), row++ ); + + /* col = number of all terms */ + for ( s = s0, col = 0; s; s = NEXT(s), col++ ); + + /* head terms of all terms */ + at = (DL *)MALLOC(col*sizeof(DL)); + for ( s = s0, i = 0; i < col; s = NEXT(s), i++ ) + at[i] = (DL)BDY(s); + + /* store coefficients separately in spmat and redmat */ + nsp = row-nred; + + /* reducer matrix */ + /* indred : register the position of the head term */ + redmat = (CDP *)MALLOC(nred*sizeof(CDP)); + for ( i = 0, r = blist; i < nred; r = NEXT(r), i++ ) + _tf_to_vect_compress(BDY(r),at,&redmat[i]); + + /* register the position of the head term */ + indred = (int *)MALLOC_ATOMIC(nred*sizeof(int)); + bzero(indred,nred*sizeof(int)); + isred = (int *)MALLOC_ATOMIC(col*sizeof(int)); + bzero(isred,col*sizeof(int)); + for ( i = 0; i < nred; i++ ) { + ri = redmat[i]; + indred[i] = ri->body[0]; + isred[indred[i]] = 1; + } + + spcol = col-nred; + /* head terms not in ht */ + st = (DL *)MALLOC(spcol*sizeof(DL)); + for ( j = 0, k = 0; j < col; j++ ) + if ( !isred[j] ) + st[k++] = at[j]; + get_eg(&tmp1); add_eg(&eg_symb,&tmp0,&tmp1); + init_eg(&eg_split_symb); add_eg(&eg_split_symb,&tmp0,&tmp1); + + get_eg(&tmp1); + /* spoly matrix; stored in reduced form; terms in ht[] are omitted */ + spmat = (int **)MALLOC(nsp*sizeof(int *)); + w = (int *)MALLOC_ATOMIC(col*sizeof(int)); + + /* skip reducers in blist */ + for ( i = 0, r = blist; i < nred; r = NEXT(r), i++ ); + for ( i = 0; r; r = NEXT(r) ) { + bzero(w,col*sizeof(int)); + _dpmod_to_vect(BDY(r),at,w); + reduce_sp_by_red_mod_compress(w,redmat,indred,nred,col,m); + for ( j = 0; j < col; j++ ) + if ( w[j] ) + break; + if ( j < col ) { + w1 = (int *)MALLOC_ATOMIC(spcol*sizeof(int)); + for ( j = 0, k = 0; j < col; j++ ) + if ( !isred[j] ) + w1[k++] = w[j]; + spmat[i] = w1; + i++; + } + } + /* update nsp */ + nsp0 = nsp; + nsp = i; + + /* XXX free redmat explicitly */ + for ( k = 0; k < nred; k++ ) { + GC_free(BDY(redmat[k])); + GC_free(redmat[k]); + } + + get_eg(&tmp0); add_eg(&eg_elim1,&tmp1,&tmp0); + init_eg(&eg_split_elim1); add_eg(&eg_split_elim1,&tmp1,&tmp0); + + colstat = (int *)MALLOC_ATOMIC(spcol*sizeof(int)); + bzero(colstat,spcol*sizeof(int)); + for ( i = 0, nonzero=0; i < nsp; i++ ) + for ( j = 0; j < spcol; j++ ) + if ( spmat[i][j] ) + nonzero++; + if ( DP_Print && nsp ) + fprintf(asir_out,"spmat : %d x %d (nonzero=%f%%)...", + nsp,spcol,((double)nonzero*100)/(nsp*spcol)); + if ( nsp ) + rank = generic_gauss_elim_mod(spmat,nsp,spcol,m,colstat); + else + rank = 0; + get_eg(&tmp1); add_eg(&eg_elim2,&tmp0,&tmp1); + init_eg(&eg_split_elim2); add_eg(&eg_split_elim2,&tmp0,&tmp1); + + if ( DP_Print ) { + fprintf(asir_out,"done rank = %d\n",rank,row,col); + print_eg("Symb",&eg_split_symb); + print_eg("Elim1",&eg_split_elim1); + print_eg("Elim2",&eg_split_elim2); + fprintf(asir_out,"\n"); + } + + NZR += rank; + ZR += nsp0-rank; + + if ( !rank ) + continue; + + for ( j = 0, i = 0; j < spcol; j++ ) + if ( colstat[j] ) { + mp0 = 0; + NEXTMP(mp0,mp); mp->dl = st[j]; mp->c = STOI(1); + for ( k = j+1; k < spcol; k++ ) + if ( !colstat[k] && spmat[i][k] ) { + NEXTMP(mp0,mp); mp->dl = st[k]; + mp->c = STOI(spmat[i][k]); + } + NEXT(mp) = 0; + MKDP(nv,mp0,nf); nf->sugar = dm->sugar; + nh = newps_mod(nf,m); + if ( nh == pscalen ) { + psca = (unsigned int **) + REALLOC(psca,2*pscalen*sizeof(unsigned int *)); + pscalen *= 2; + } + dptoca(ps[nh],&psca[nh]); + d = updpairs(d,g,nh); + g = updbase(g,nh); + gall = append_one(gall,nh); + i++; + } + + /* XXX free spmat[] explicitly */ + for ( j = 0; j < nsp; j++ ) { + GC_free(spmat[j]); + } + } + if ( DP_Print ) { + print_eg("Symb",&eg_symb); + print_eg("Elim1",&eg_elim1); + print_eg("Elim2",&eg_elim2); + fflush(asir_out); + } + return g; +} + +NODE gb_f4_mod_old(NODE f,int m) +{ + int i,j,k,nh,row,col,nv; + NODE r,g,gall; + NODE s,s0; + DP_pairs d,dm,dr,t; + DP nf,f2,sp,sd,sdm,tdp; + MP mp,mp0; + NODE blist,bt; + DL *ht,*at,*st; + int **spmat,**redmat; + int *colstat,*w; + int rank,nred,nsp,nonzero,spcol; + int *indred,*isred,*ri; + struct oEGT tmp0,tmp1,eg_split_symb,eg_split_elim1,eg_split_elim2; + extern struct oEGT eg_symb,eg_elim1,eg_elim2; + + init_eg(&eg_symb); init_eg(&eg_elim1); init_eg(&eg_elim2); + for ( gall = g = 0, d = 0, r = f; r; r = NEXT(r) ) { + i = (int)BDY(r); + d = updpairs(d,g,i); + g = updbase(g,i); + gall = append_one(gall,i); + } + if ( gall ) + nv = ((DP)ps[(int)BDY(gall)])->nv; + while ( d ) { + get_eg(&tmp0); + minsugar(d,&dm,&dr); d = dr; + if ( DP_Print ) + fprintf(asir_out,"sugar=%d\n",dm->sugar); + blist = 0; s0 = 0; + /* asph : sum of all head terms of spoly */ + for ( t = dm; t; t = NEXT(t) ) { + _dp_sp_mod(ps[t->dp1],ps[t->dp2],m,&sp); + if ( sp ) { + MKNODE(bt,sp,blist); blist = bt; + s0 = symb_merge(s0,dp_dllist(sp),nv); + } + } + /* s0 : all the terms appeared in symbolic redunction */ for ( s = s0, nred = 0; s; s = NEXT(s) ) { for ( r = gall; r; r = NEXT(r) ) if ( _dl_redble(BDY(ps[(int)BDY(r)])->dl,BDY(s),nv) ) @@ -728,8 +875,6 @@ int m; nred++; } } -#endif - fprintf(stderr,"\n"); get_eg(&tmp1); add_eg(&eg_symb,&tmp0,&tmp1); init_eg(&eg_split_symb); add_eg(&eg_split_symb,&tmp0,&tmp1); @@ -755,9 +900,9 @@ int m; nsp = row-nred; /* reducer matrix */ - redmat = (CDP *)MALLOC(nred*sizeof(CDP)); + redmat = (int **)almat(nred,col); for ( i = 0, r = blist; i < nred; r = NEXT(r), i++ ) - _dpmod_to_vect_compress(BDY(r),at,&redmat[i]); + _dpmod_to_vect(BDY(r),at,redmat[i]); /* XXX */ /* reduce_reducers_mod(redmat,nred,col,m); */ /* register the position of the head term */ @@ -767,8 +912,9 @@ int m; bzero(isred,col*sizeof(int)); for ( i = 0; i < nred; i++ ) { ri = redmat[i]; - indred[i] = ri->body[0].index; - isred[indred[i]] = 1; + for ( j = 0; j < col && !ri[j]; j++ ); + indred[i] = j; + isred[j] = 1; } spcol = col-nred; @@ -778,14 +924,13 @@ int m; if ( !isred[j] ) st[k++] = at[j]; - get_eg(&tmp1); /* spoly matrix; stored in reduced form; terms in ht[] are omitted */ spmat = almat(nsp,spcol); w = (int *)MALLOC(col*sizeof(int)); for ( ; i < row; r = NEXT(r), i++ ) { bzero(w,col*sizeof(int)); _dpmod_to_vect(BDY(r),at,w); - reduce_sp_by_red_mod_compress(w,redmat,indred,nred,col,m); + reduce_sp_by_red_mod(w,redmat,indred,nred,col,m); for ( j = 0, k = 0; j < col; j++ ) if ( !isred[j] ) spmat[i-nred][k++] = w[j]; @@ -843,8 +988,7 @@ int m; return g; } -int DPPlength(n) -DP_pairs n; +int DPPlength(DP_pairs n) { int i; @@ -852,8 +996,7 @@ DP_pairs n; return i; } -void printdl(dl) -DL dl; +void printdl(DL dl) { int i; @@ -863,9 +1006,7 @@ DL dl; fprintf(asir_out,"%d>>",dl->d[i]); } -void pltovl(l,vl) -LIST l; -VL *vl; +void pltovl(LIST l,VL *vl) { NODE n; VL r,r0; @@ -878,9 +1019,7 @@ VL *vl; *vl = r0; } -void makesubst(v,s) -VL v; -NODE *s; +void makesubst(VL v,NODE *s) { NODE r,r0; Q q; @@ -899,8 +1038,7 @@ NODE *s; *s = r0; } -void printsubst(s) -NODE s; +void printsubst(NODE s) { fputc('[',asir_out); while ( s ) { @@ -914,8 +1052,7 @@ NODE s; fprintf(asir_out,"]\n"); return; } -void vlminus(v,w,d) -VL v,w,*d; +void vlminus(VL v,VL w,VL *d) { int i,j,n,m; V *va,*wa; @@ -945,10 +1082,7 @@ VL v,w,*d; *d = r0; } -int validhc(a,m,s) -P a; -int m; -NODE s; +int validhc(P a,int m,NODE s) { P c,c1; V v; @@ -963,9 +1097,7 @@ NODE s; return c1 ? 1 : 0; } -void setup_arrays(f,m,r) -NODE f,*r; -int m; +void setup_arrays(NODE f,int m,NODE *r) { int i; NODE s,s0,f0; @@ -993,7 +1125,7 @@ int m; STRING fname; LIST input; NODE arg,t,t1; - Obj dmy; + Obj obj; t = 0; for ( i = psn-1; i >= 0; i-- ) { @@ -1006,7 +1138,7 @@ int m; STOQ(OXCheck,q); MKSTR(fname,"register_input"); arg = mknode(3,q,fname,input); - Pox_cmo_rpc(arg,&dmy); + Pox_cmo_rpc(arg,&obj); } else if ( OXCheck < 0 ) { MKNODE(AllTraceList,input,0); } @@ -1018,9 +1150,7 @@ int m; *r = s0; } -void prim_part(f,m,r) -DP f,*r; -int m; +void prim_part(DP f,int m,DP *r) { P d,t; @@ -1046,10 +1176,7 @@ int m; } } -NODE /* of DP */ NODE_sortb_insert( newdp, nd, dec ) -DP newdp; -NODE /* of DP */ nd; -int dec; +NODE /* of DP */ NODE_sortb_insert( DP newdp, NODE /* of DP */ nd, int dec ) { register NODE last, p; register DL newdl = BDY(newdp)->dl; @@ -1068,9 +1195,7 @@ int dec; return nd; } -NODE NODE_sortb( node, dec ) -NODE node; -int dec; +NODE NODE_sortb( NODE node, int dec ) { register NODE nd, ans; @@ -1079,10 +1204,7 @@ int dec; return ans; } -NODE /* of index */ NODE_sortbi_insert( newdpi, nd, dec ) -int newdpi; -NODE /* of index */ nd; -int dec; +NODE /* of index */ NODE_sortbi_insert( int newdpi, NODE /* of index */ nd, int dec ) { register NODE last, p; register DL newdl = psh[newdpi]; @@ -1101,9 +1223,7 @@ int dec; return nd; } -NODE NODE_sortbi( node, dec ) -NODE node; -int dec; +NODE NODE_sortbi( NODE node, int dec ) { register NODE nd, ans; @@ -1112,9 +1232,7 @@ int dec; return ans; } -void reduceall(in,h) -NODE in; -NODE *h; +void reduceall(NODE in,NODE *h) { NODE r,t,top; int n,i,j; @@ -1167,10 +1285,7 @@ NODE *h; fprintf(asir_out,"\n"); } -void reduceall_mod(in,m,h) -NODE in; -int m; -NODE *h; +void reduceall_mod(NODE in,int m,NODE *h) { NODE r,t,top; int n,i,j; @@ -1215,10 +1330,7 @@ NODE *h; fprintf(asir_out,"\n"); } -int newps(a,m,subst) -DP a; -int m; -NODE subst; +int newps(DP a,int m,NODE subst) { if ( m && !validhc(!a?0:BDY(a)->c,m,subst) ) return -1; @@ -1250,7 +1362,7 @@ NODE subst; NODE arg; Q q1,q2; STRING fname; - Obj dmy; + Obj obj; /* reverse the TraceList */ tn = TraceList; @@ -1263,7 +1375,7 @@ NODE subst; MKSTR(fname,"check_trace"); STOQ(psn,q2); arg = mknode(5,q1,fname,a,q2,trace); - Pox_cmo_rpc(arg,&dmy); + Pox_cmo_rpc(arg,&obj); } else if ( OXCheck < 0 ) { STOQ(psn,q1); tn = mknode(2,q1,trace); @@ -1277,10 +1389,7 @@ NODE subst; return psn++; } -int newps_nosave(a,m,subst) -DP a; -int m; -NODE subst; +int newps_nosave(DP a,int m,NODE subst) { if ( m && !validhc(!a?0:BDY(a)->c,m,subst) ) return -1; @@ -1302,9 +1411,7 @@ NODE subst; return psn++; } -int newps_mod(a,m) -DP a; -int m; +int newps_mod(DP a,int m) { if ( psn == pslen ) { pslen *= 2; @@ -1319,8 +1426,7 @@ int m; return psn++; } -void reducebase_dehomo(f,g) -NODE f,*g; +void reducebase_dehomo(NODE f,NODE *g) { int n,i,j,k; int *r; @@ -1366,9 +1472,7 @@ NODE f,*g; *g = top; } -NODE append_one(f,n) -NODE f; -int n; +NODE append_one(NODE f,int n) { NODE t; @@ -1381,8 +1485,7 @@ int n; } } -DP_pairs minp( d, prest ) -DP_pairs d, *prest; +DP_pairs minp( DP_pairs d, DP_pairs *prest ) { register DP_pairs m, ml, p, l; register DL lcm; @@ -1407,9 +1510,7 @@ DP_pairs d, *prest; return m; } -void minsugar(d,dm,dr) -DP_pairs d; -DP_pairs *dm,*dr; +void minsugar(DP_pairs d,DP_pairs *dm,DP_pairs *dr) { int msugar; DP_pairs t,dm0,dr0,dmt,drt; @@ -1434,18 +1535,15 @@ DP_pairs *dm,*dr; *dm = dm0; *dr = dr0; } -NODE gb(f,m,subst) -NODE f; -int m; -NODE subst; +NODE gb(NODE f,int m,NODE subst) { int i,nh,prev,mag; NODE r,g,gall; - DP_pairs d,d1; + DP_pairs d; DP_pairs l; DP h,nf,nfm,dp1,dp2; MP mp; - struct oEGT tnf0,tnf1,tnfm0,tnfm1,tpz0,tpz1,tsp0,tsp1,tspm0,tspm1,tnp0,tnp1,tmp0,tmp1; + struct oEGT tnf0,tnf1,tnfm0,tnfm1,tpz0,tpz1,tnp0,tnp1; int skip_nf_flag; double t_0; Q q; @@ -1484,7 +1582,6 @@ NODE subst; if ( Demand ) { if ( dp_load_t(psn,&nf) ) { skip_nf_flag = 1; - tnf1=tsp1; goto skip_nf; } else { skip_nf_flag = 0; @@ -1565,16 +1662,14 @@ skip_nf: return g; } -NODE gb_mod(f,m) -NODE f; -int m; +NODE gb_mod(NODE f,int m) { int i,nh,prev; NODE r,g,gall; - DP_pairs d,d1; + DP_pairs d; DP_pairs l; DP h,nf; - struct oEGT tnfm0,tnfm1,tspm0,tspm1,tmp0,tmp1,tpz0,tpz1; + struct oEGT tnfm0,tnfm1,tpz0,tpz1; prev = 1; for ( gall = g = 0, d = 0, r = f; r; r = NEXT(r) ) { @@ -1629,13 +1724,9 @@ int m; return g; } -DP_pairs updpairs( d, g, t) -DP_pairs d; -NODE /* of index */ g; -int t; +DP_pairs updpairs( DP_pairs d, NODE /* of index */ g, int t) { register DP_pairs d1, dd, nd; - struct oEGT tup0,tup1; int dl,dl1; if ( !g ) return d; @@ -1670,9 +1761,7 @@ int t; return d; } -DP_pairs newpairs( g, t ) -NODE /* of index */ g; -register int t; +DP_pairs newpairs( NODE /* of index */ g, int t ) { register NODE r; register DL tdl = psh[t]; @@ -1698,9 +1787,7 @@ register int t; return last; } -DP_pairs criterion_B( d, s ) -register DP_pairs d; -int s; +DP_pairs criterion_B( DP_pairs d, int s ) { register DP_pairs dd, p; register DL tij, t = psh[s], dltmp; @@ -1723,8 +1810,7 @@ int s; return dd; } -DP_pairs criterion_M( d1 ) -DP_pairs d1; +DP_pairs criterion_M( DP_pairs d1 ) { register DP_pairs dd, e, d3, d2, p; register DL itdl, jtdl; @@ -1766,8 +1852,7 @@ DP_pairs d1; return dd; } -static DP_pairs collect_pairs_of_hdlcm( d1, prest ) -DP_pairs d1, *prest; +static DP_pairs collect_pairs_of_hdlcm( DP_pairs d1, DP_pairs *prest ) { register DP_pairs w, p, r, s; register DL ti; @@ -1791,8 +1876,7 @@ DP_pairs d1, *prest; return w; } -int criterion_2( dp1, dp2 ) -int dp1, dp2; +int criterion_2( int dp1, int dp2 ) { register int i, *d1, *d2; @@ -1802,8 +1886,7 @@ int dp1, dp2; return 1; } -DP_pairs criterion_F( d1 ) -DP_pairs d1; +DP_pairs criterion_F( DP_pairs d1 ) { DP_pairs rest, head; register DP_pairs last, p, r, w; @@ -1826,18 +1909,14 @@ DP_pairs d1; return head; } -NODE updbase(g,t) -NODE g; -int t; +NODE updbase(NODE g,int t) { g = remove_reducibles(g,t); g = append_one(g,t); return g; } -NODE /* of index */ remove_reducibles( nd, newdp ) -NODE /* of index */ nd; -int newdp; +NODE /* of index */ remove_reducibles(NODE /* of index */ nd, int newdp ) { register DL dl, dln; register NODE last, p, head; @@ -1858,8 +1937,7 @@ int newdp; return head; } -int dl_redble( dl1, dl2 ) -DL dl1, dl2; +int dl_redble(DL dl1,DL dl2) { register int n, *d1, *d2; @@ -1868,8 +1946,7 @@ DL dl1, dl2; return 1; } -int dl_weight(dl) -DL dl; +int dl_weight(DL dl) { int n,w,i; @@ -1879,8 +1956,7 @@ DL dl; return w; } -int gbcheck(f) -NODE f; +int gbcheck(NODE f) { int i; NODE r,g,gall; @@ -1918,9 +1994,42 @@ NODE f; return 1; } -int membercheck(f,x) -NODE f,x; +void gbcheck_list(NODE f,int n,VECT *gp,LIST *pp) { + int i; + NODE r,g,gall,u,u0,t; + VECT vect; + LIST pair; + DP_pairs d,l; + Q q1,q2; + + /* we need the following settings */ + NVars = CNVars = n; + setup_arrays(f,0,&r); + for ( gall = g = 0, d = 0; r; r = NEXT(r) ) { + i = (int)BDY(r); + d = updpairs(d,g,i); + g = updbase(g,i); + gall = append_one(gall,i); + } + NEWVECT(vect); vect->len = psn; vect->body = (pointer)ps; + *gp = vect; + + for ( u0 = 0, l = d; l; l = NEXT(l) ) { + NEXTNODE(u0,u); + STOQ(l->dp1,q1); + STOQ(l->dp2,q2); + t = mknode(2,q1,q2); + MKLIST(pair,t); + BDY(u) = (pointer)pair; + } + if ( u0 ) + NEXT(u) = 0; + MKLIST(*pp,u0); +} + +int membercheck(NODE f,NODE x) +{ DP g; struct oEGT tmp0,tmp1; @@ -1946,8 +2055,7 @@ NODE f,x; return 1; } -void dp_set_flag(name,value) -Obj name,value; +void dp_set_flag(Obj name,Obj value) { char *n; int v; @@ -2002,8 +2110,7 @@ Obj name,value; OXCheck = v; } -void dp_make_flaglist(list) -LIST *list; +void dp_make_flaglist(LIST *list) { Q v; STRING name,path; @@ -2038,10 +2145,7 @@ LIST *list; #define DELIM '/' -void dp_save(index,p,prefix) -int index; -Obj p; -char *prefix; +void dp_save(int index,Obj p,char *prefix) { FILE *fp; char path[BUFSIZ]; @@ -2055,9 +2159,7 @@ char *prefix; savevl(fp,VC); saveobj(fp,p); fclose(fp); } -void dp_load(index,p) -int index; -DP *p; +void dp_load(int index,DP *p) { FILE *fp; char path[BUFSIZ]; @@ -2072,9 +2174,7 @@ DP *p; } } -int dp_load_t(index,p) -int index; -DP *p; +int dp_load_t(int index,DP *p) { FILE *fp; char path[BUFSIZ]; @@ -2091,7 +2191,7 @@ void init_stat() { init_eg(&eg_nf); init_eg(&eg_nfm); init_eg(&eg_znfm); init_eg(&eg_pz); init_eg(&eg_np); init_eg(&eg_ra); init_eg(&eg_mc); init_eg(&eg_gc); - ZR = NZR = TP = NBP = NFP = NDP = 0; + ZR = NZR = TP = NMP = NBP = NFP = NDP = 0; } void print_stat() { @@ -2114,10 +2214,7 @@ extern int GenTrace; extern NODE TraceList; extern int mpi_mag; -void dp_mulc_d(p,c,r) -DP p; -P c; -DP *r; +void dp_mulc_d(DP p,P c,DP *r) { if ( Dist && BDY(Dist) && HMAG(p) > mpi_mag @@ -2130,12 +2227,7 @@ DP *r; } } -void _dp_nf(b,g,ps,full,rp) -NODE b; -DP g; -DP *ps; -int full; -DP *rp; +void _dp_nf(NODE b,DP g,DP *ps,int full,DP *rp) { DP u,p,d,s,t,mult; P coef; @@ -2193,25 +2285,15 @@ DP *rp; *rp = d; } -void _dp_nf_z(b,g,ps,full,multiple,r) -NODE b; -DP g; -DP *ps; -int full,multiple; -DP *r; +void _dp_nf_z(NODE b,DP g,DP *ps,int full,int multiple,DP *r) { - DP u,dp,rp,t,t1,t2,red,shift; + DP u,dp,rp,t,t1,red,shift; Q dc,rc,dcq,rcq,cont,hr,hred,cr,cred,mcred,c,gcd,cq; - N gn,tn,cn; NODE l; - MP m,mr; int hmag,denom; int sugar,psugar; - NODE dist; STRING imul; - int kara_bit; - double get_rtime(); - double t_0,t_00,tt,ttt,t_p,t_m,t_g,t_a; + double t_0,tt,t_p,t_m,t_g,t_a; LIST hist; NODE node; Q rcred,mrcred; @@ -2240,9 +2322,9 @@ DP *r; tt = get_rtime(); t_p += tt-t_0; dp_subd(rp,red,&shift); - dp_mulc_d(rp,cr,&t); + dp_mulc_d(rp,(P)cr,&t); chsgnp((P)cred,(P *)&mcred); - dp_mulc_d(red,mcred,&t1); + dp_mulc_d(red,(P)mcred,&t1); muld(CO,shift,t1,&t1); addd(CO,t,t1,&u); t_m += get_rtime()-tt; @@ -2337,10 +2419,7 @@ final: void imulv(); -void dp_imul_d(p,q,rp) -DP p; -Q q; -DP *rp; +void dp_imul_d(DP p,Q q,DP *rp) { int nsep,ndist,i,j,k,l,n; double t0,t1,t2; @@ -2349,8 +2428,8 @@ DP *rp; VECT c,cs,ri; VECT *r; MP m; - NODE tn,dist,n0,n1,n2; - Obj dmy; + NODE tn,dist,n0; + Obj obj; STRING imul; extern LIST Dist; @@ -2371,7 +2450,7 @@ DP *rp; r = (VECT *)CALLOC(nsep,sizeof(VECT *)); for ( i = 0, tn = dist, b = BDY(cs); i < ndist; i++, tn = NEXT(tn) ) { n0 = mknode(4,BDY(tn),imul,b[i],q); - Pox_rpc(n0,&dmy); + Pox_rpc(n0,&obj); } t1 = get_rtime(); im_t_s += t1 - t0; @@ -2379,7 +2458,7 @@ DP *rp; t1 = get_rtime(); for ( i = 0, tn = dist; i < ndist; i++, tn = NEXT(tn) ) { MKNODE(n0,BDY(tn),0); - Pox_pop_local(n0,&r[i]); + Pox_pop_local(n0,&obj); r[i] = (VECT)obj; if ( OID(r[i]) == O_ERR ) { printexpr(CO,(Obj)r[i]); error("dp_imul_d : aborted"); @@ -2396,10 +2475,7 @@ DP *rp; dp_vtod(s,p,rp); } -void imulv(w,c,rp) -VECT w; -Q c; -VECT *rp; +void imulv(VECT w,Q c,VECT *rp) { int n,i; VECT r; @@ -2408,5 +2484,21 @@ VECT *rp; MKVECT(r,n); *rp = r; for ( i = 0; i < n; i++ ) mulq((Q)BDY(w)[i],(Q)c,(Q *)&BDY(r)[i]); +} + +void dptoca(DP p,unsigned int **rp) +{ + int i; + MP m; + unsigned int *r; + + if ( !p ) + *rp = 0; + else { + for ( m = BDY(p), i = 0; m; m = NEXT(m), i++ ); + *rp = r = (unsigned int *)MALLOC_ATOMIC(i*sizeof(unsigned int)); + for ( m = BDY(p), i = 0; m; m = NEXT(m), i++ ) + r[i] = ITOS(C(m)); + } }