=================================================================== RCS file: /home/cvs/OpenXM_contrib2/asir2018/engine/nd.c,v retrieving revision 1.42 retrieving revision 1.46 diff -u -p -r1.42 -r1.46 --- OpenXM_contrib2/asir2018/engine/nd.c 2020/12/03 07:58:54 1.42 +++ OpenXM_contrib2/asir2018/engine/nd.c 2021/01/25 00:39:52 1.46 @@ -1,7 +1,9 @@ -/* $OpenXM: OpenXM_contrib2/asir2018/engine/nd.c,v 1.41 2020/11/26 03:55:23 noro Exp $ */ +/* $OpenXM: OpenXM_contrib2/asir2018/engine/nd.c,v 1.45 2021/01/11 08:37:44 noro Exp $ */ #include "nd.h" +void print_siglist(NODE l); + int Nnd_add,Nf4_red,NcriB,NcriMF,Ncri2,Npairs; struct oEGT eg_search,f4_symb,f4_conv,f4_elim1,f4_elim2; @@ -67,7 +69,7 @@ static NODE nd_tracelist; static NODE nd_alltracelist; static int nd_gentrace,nd_gensyz,nd_nora,nd_newelim,nd_intersect,nd_lf,nd_norb; static int nd_f4_td,nd_sba_f4step,nd_sba_pot,nd_sba_largelcm,nd_sba_dontsort,nd_sba_redundant_check; -static int nd_top; +static int nd_top,nd_sba_syz,nd_sba_inputisgb; static int *nd_gbblock; static NODE nd_nzlist,nd_check_splist; static int nd_splist; @@ -76,6 +78,20 @@ static int nd_f4red,nd_rank0,nd_last_nonzero; static DL *nd_sba_hm; static NODE *nd_sba_pos; +struct comp_sig_spec { + int n; + // current_i <-> oldv[i] + int *oldv; + int *weight; + struct order_pair *order_pair; + int block_length; + int **matrix; + int row; + int (*cmpdl)(int n,DL d1,DL d2); +}; + +struct comp_sig_spec *nd_sba_modord; + NumberField get_numberfield(); UINT *nd_det_compute_bound(NDV **dm,int n,int j); void nd_det_reconstruct(NDV **dm,int n,int j,NDV d); @@ -93,15 +109,19 @@ P ndc_div(int mod,union oNDC a,union oNDC b); P ndctop(int mod,union oNDC c); void finalize_tracelist(int i,P cont); void conv_ilist(int demand,int trace,NODE g,int **indp); -void parse_nd_option(NODE opt); +void parse_nd_option(VL vl,NODE opt); void dltondl(int n,DL dl,UINT *r); DP ndvtodp(int mod,NDV p); DP ndtodp(int mod,ND p); DPM ndvtodpm(int mod,NDV p); +NDV dptondv(int mod,DP p); NDV dpmtondv(int mod,DPM p); +int dp_getdeg(DP p); int dpm_getdeg(DPM p,int *rank); void dpm_ptozp(DPM p,Z *cont,DPM *r); int compdmm(int nv,DMM a,DMM b); +DPM sigtodpm(SIG s); +SIG dup_sig(SIG sig); void Pdp_set_weight(NODE,VECT *); void Pox_cmo_rpc(NODE,Obj *); @@ -794,13 +814,16 @@ int _eqdl(int n,DL d1,DL d2); int ndl_module_schreyer_compare(UINT *m1,UINT *m2) { - int pos1,pos2,t,j; + int pos1,pos2,t,j,retpot; DMM *in; DMMstack s; static DL d1=0; static DL d2=0; static int dlen=0; + extern int ReversePOT; + if ( ReversePOT ) retpot = -1; + else retpot = 1; pos1 = MPOS(m1); pos2 = MPOS(m2); if ( pos1 == pos2 ) return (*ndl_base_compare_function)(m1,m2); if ( nd_nvar > dlen ) { @@ -817,8 +840,8 @@ int ndl_module_schreyer_compare(UINT *m1,UINT *m2) _addtodl(nd_nvar,in[pos1]->dl,d1); _addtodl(nd_nvar,in[pos2]->dl,d2); if ( in[pos1]->pos == in[pos2]->pos && _eqdl(nd_nvar,d1,d2)) { - if ( pos1 < pos2 ) return 1; - else if ( pos1 > pos2 ) return -1; + if ( pos1 < pos2 ) return retpot; + else if ( pos1 > pos2 ) return -retpot; else return 0; } pos1 = in[pos1]->pos; @@ -831,20 +854,20 @@ LAST: case 0: t = (*dl_base_compare_function)(nd_nvar,d1,d2); if ( t ) return t; - else if ( pos1 < pos2 ) return 1; - else if ( pos1 > pos2 ) return -1; + else if ( pos1 < pos2 ) return retpot; + else if ( pos1 > pos2 ) return -retpot; else return 0; break; case 1: - if ( pos1 < pos2 ) return 1; - else if ( pos1 > pos2 ) return -1; + if ( pos1 < pos2 ) return retpot; + else if ( pos1 > pos2 ) return -retpot; else return (*dl_base_compare_function)(nd_nvar,d1,d2); break; case 2: if ( d1->td > d2->td ) return 1; else if ( d1->td < d2->td ) return -1; - else if ( pos1 < pos2 ) return 1; - else if ( pos1 > pos2 ) return -1; + else if ( pos1 < pos2 ) return retpot; + else if ( pos1 > pos2 ) return -retpot; else return (*dl_base_compare_function)(nd_nvar,d1,d2); break; default: @@ -1238,6 +1261,13 @@ void print_sig(SIG s) fprintf(asir_out,">>*e%d",s->pos); } +void print_siglist(NODE l) +{ + for ( ; l; l = NEXT(l) ) + print_sig((SIG)l->body); +} + + // assuming increasing order wrt signature INLINE int ndl_find_reducer_s(UINT *dg,SIG sig) @@ -2589,6 +2619,8 @@ NODE insert_sig(NODE l,SIG s) else if ( _dl_redble(sig,DL(t),nd_nvar) ) // remove p prev->next = p->next; + else + prev = p; } else prev = p; } @@ -2629,7 +2661,7 @@ int small_lcm(ND_pairs l) int i; NODE t; static DL lcm,mul,quo; - static int nvar; + static int nvar = 0; if ( nd_sba_largelcm ) return 0; if ( nvar < nd_nvar ) { @@ -2672,7 +2704,7 @@ ND_pairs find_smallest_lcm(ND_pairs l) ND_pairs r; struct oSIG sig1; static DL mul,quo,minlm; - static int nvar; + static int nvar = 0; if ( nvar < nd_nvar ) { nvar = nd_nvar; @@ -2747,8 +2779,37 @@ struct oEGT eg_create,eg_newpairs,eg_merge; NODE conv_ilist_s(int demand,int trace,int **indp); -NODE nd_sba_buch(int m,int ishomo,int **indp) +// S(fj*ei-fi*ej) + +void _subdl(int,DL,DL,DL); + +SIG trivial_sig(int i,int j) { + static DL lcm; + static struct oSIG sigi,sigj; + static int nvar = 0; + SIG sig; + + if ( nvar != nd_nvar ) { + nvar = nd_nvar; NEWDL(lcm,nvar); NEWDL(sigi.dl,nvar); NEWDL(sigj.dl,nvar); + } + if ( nd_sba_inputisgb != 0 ) { + lcm_of_DL(nd_nvar,nd_sba_hm[i],nd_sba_hm[j],lcm); + sigi.pos = i; _subdl(nd_nvar,lcm,nd_sba_hm[i],sigi.dl); + sigj.pos = j; _subdl(nd_nvar,lcm,nd_sba_hm[j],sigj.dl); + if ( comp_sig(&sigi,&sigj) > 0 ) sig = dup_sig(&sigi); + else sig = dup_sig(&sigj); + } else { + sigi.pos = i; _copydl(nd_nvar,nd_sba_hm[j],sigi.dl); + sigj.pos = j; _copydl(nd_nvar,nd_sba_hm[i],sigj.dl); + if ( comp_sig(&sigi,&sigj) > 0 ) sig = dup_sig(&sigi); + else sig = dup_sig(&sigj); + } + return sig; +} + +NODE nd_sba_buch(int m,int ishomo,int **indp,NODE *syzp) +{ int i,j,nh,sugar,stat,pos; NODE r,t,g; ND_pairs d; @@ -2761,6 +2822,7 @@ NODE nd_sba_buch(int m,int ishomo,int **indp) LIST list; SIG sig; NODE *syzlist; + int ngen; int Nnominimal,Nredundant; DL lcm,quo,mul; struct oEGT eg1,eg2,eg_update,eg_remove,eg_large,eg_nf,eg_nfzero; @@ -2773,10 +2835,10 @@ init_eg(&eg_remove); Nnominimal = 0; Nredundant = 0; d = 0; + ngen = nd_psn; for ( i = 0; i < nd_psn; i++ ) for ( j = i+1; j < nd_psn; j++ ) { - NEWSIG(sig); sig->pos = j; - _copydl(nd_nvar,nd_sba_hm[i],sig->dl); + sig = trivial_sig(i,j); syzlist[sig->pos] = insert_sig(syzlist[sig->pos],sig); } for ( i = 0; i < nd_psn; i++ ) { @@ -2819,6 +2881,8 @@ again: } stat = nd_sp(m,0,l,&h); #else +// if ( l->sig->dl->td == 0 ) +// if ( DP_Print ) print_sig(l->sig); l1 = find_smallest_lcm(l); if ( l1 == 0 ) { if ( DP_Print ) fprintf(asir_out,"M"); @@ -2907,6 +2971,20 @@ get_eg(&eg2); add_eg(&eg_remove,&eg1,&eg2); print_eg("nfzero",&eg_nfzero); printf("\n"); } + if ( nd_sba_syz ) { + NODE hsyz,tsyz,prev; + + hsyz = 0; + for ( i = 0; i < ngen; i++ ) { + tsyz = syzlist[i]; + for ( prev = 0; tsyz != 0; prev = tsyz, tsyz = NEXT(tsyz)) + BDY(tsyz) = (pointer)sigtodpm((SIG)BDY(tsyz)); + if ( prev != 0 ) { + prev->next = hsyz; hsyz = syzlist[i]; + } + } + *syzp = hsyz; + } else *syzp = 0; return g; } @@ -3390,15 +3468,208 @@ ND_pairs nd_newpairs( NODE g, int t ) return r0; } +int sig_cmpdl_op(int n,DL d1,DL d2) +{ + int e1,e2,i,j,l; + int *t1,*t2; + int len,head; + struct order_pair *pair; + + len = nd_sba_modord->block_length; + pair = nd_sba_modord->order_pair; + + head = 0; + for ( i = 0, t1 = d1->d, t2 = d2->d; i < len; i++ ) { + l = pair[i].length; + switch ( pair[i].order ) { + case 0: + for ( j = 0, e1 = e2 = 0; j < l; j++ ) { + e1 += t1[j]; + e2 += t2[j]; + } + if ( e1 > e2 ) + return 1; + else if ( e1 < e2 ) + return -1; + else { + for ( j = l - 1; j >= 0 && t1[j] == t2[j]; j-- ); + if ( j >= 0 ) + return t1[j] < t2[j] ? 1 : -1; + } + break; + case 1: + for ( j = 0, e1 = e2 = 0; j < l; j++ ) { + e1 += t1[j]; + e2 += t2[j]; + } + if ( e1 > e2 ) + return 1; + else if ( e1 < e2 ) + return -1; + else { + for ( j = 0; j < l && t1[j] == t2[j]; j++ ); + if ( j < l ) + return t1[j] > t2[j] ? 1 : -1; + } + break; + case 2: + for ( j = 0; j < l && t1[j] == t2[j]; j++ ); + if ( j < l ) + return t1[j] > t2[j] ? 1 : -1; + break; + default: + error("sig_cmpdl_op : invalid order"); break; + } + t1 += l; t2 += l; head += l; + } + return 0; +} + +int sig_cmpdl_mat(int n,DL d1,DL d2) +{ + int *v,*t1,*t2; + int s,i,j,len; + int **matrix; + static int *w; + static int nvar = 0; + + if ( nvar != n ) { + nvar = n; w = (int *)MALLOC(n*sizeof(int)); + } + for ( i = 0, t1 = d1->d, t2 = d2->d; i < n; i++ ) + w[i] = t1[i]-t2[i]; + len = nd_sba_modord->row; + matrix = nd_sba_modord->matrix; + for ( j = 0; j < len; j++ ) { + v = matrix[j]; + for ( i = 0, s = 0; i < n; i++ ) + s += v[i]*w[i]; + if ( s > 0 ) + return 1; + else if ( s < 0 ) + return -1; + } + return 0; +} + +struct comp_sig_spec *create_comp_sig_spec(VL current_vl,VL old_vl,Obj ord,Obj weight) +{ + struct comp_sig_spec *spec; + VL ovl,vl; + V ov; + int i,j,n,nvar,s; + NODE node,t,tn; + struct order_pair *l; + MAT m; + Obj **b; + int **w; + int *a; + + spec = (struct comp_sig_spec *)MALLOC(sizeof(struct comp_sig_spec)); + for ( i = 0, vl = current_vl; vl; vl = NEXT(vl), i++ ); + spec->n = nvar = i; + if ( old_vl != 0 ) { + spec->oldv = (int *)MALLOC(nvar*sizeof(int)); + for ( i = 0, ovl = old_vl; i < nvar; ovl = NEXT(ovl), i++ ) { + ov = ovl->v; + for ( j = 0, vl = current_vl; vl; vl = NEXT(vl), j++ ) + if ( ov == vl->v ) break; + spec->oldv[i] = j; + } + } else + spec->oldv = 0; + if ( !ord || NUM(ord) ) { + switch ( ZTOS((Z)ord) ) { + case 0: + spec->cmpdl = cmpdl_revgradlex; break; + case 1: + spec->cmpdl = cmpdl_gradlex; break; + case 2: + spec->cmpdl = cmpdl_lex; break; + default: + error("create_comp_sig_spec : invalid spec"); break; + } + } else if ( OID(ord) == O_LIST ) { + node = BDY((LIST)ord); + for ( n = 0, t = node; t; t = NEXT(t), n++ ); + l = (struct order_pair *)MALLOC_ATOMIC(n*sizeof(struct order_pair)); + for ( i = 0, t = node, s = 0; i < n; t = NEXT(t), i++ ) { + tn = BDY((LIST)BDY(t)); l[i].order = ZTOS((Q)BDY(tn)); + tn = NEXT(tn); l[i].length = ZTOS((Q)BDY(tn)); + s += l[i].length; + } + if ( s != nvar ) + error("create_comp_sig_spec : invalid spec"); + spec->order_pair = l; + spec->block_length = n; + spec->cmpdl = sig_cmpdl_op; + } else if ( OID(ord) == O_MAT ) { + m = (MAT)ord; b = (Obj **)BDY(m); + if ( m->col != nvar ) + error("create_comp_sig_spec : invalid spec"); + w = almat(m->row,m->col); + for ( i = 0; i < m->row; i++ ) + for ( j = 0; j < m->col; j++ ) + w[i][j] = ZTOS((Q)b[i][j]); + spec->row = m->row; + spec->matrix = w; + spec->cmpdl = sig_cmpdl_mat; + } else + error("create_comp_sig_spec : invalid spec"); + if ( weight != 0 ) { + node = BDY((LIST)weight); + a = (int *)MALLOC(nvar*sizeof(int)); + for ( i = 0; i < nvar; i++, node = NEXT(node) ) + a[i] = ZTOS((Z)BDY(node)); + spec->weight = a; + } + return spec; +} + +#define SIG_MUL_WEIGHT(a,i) (weight?(a)*weight[i]:(a)) + +int comp_sig_monomial(int n,DL d1,DL d2) +{ + static DL m1,m2; + static int nvar = 0; + int *oldv,*weight; + int i,w1,w2; + + if ( nvar != n ) { + nvar = n; NEWDL(m1,nvar); NEWDL(m2,nvar); + } + if ( !nd_sba_modord ) + return (*cmpdl)(n,d1,d2); + else { + weight = nd_sba_modord->weight; + oldv = nd_sba_modord->oldv; + if ( oldv ) { + for ( i = 0; i < n; i++ ) { + m1->d[i] = d1->d[oldv[i]]; m2->d[i] = d2->d[oldv[i]]; + } + } else { + for ( i = 0; i < n; i++ ) { + m1->d[i] = d1->d[i]; m2->d[i] = d2->d[i]; + } + } + for ( i = 0, w1 = w2 = 0; i < n; i++ ) { + w1 += SIG_MUL_WEIGHT(m1->d[i],i); + w2 += SIG_MUL_WEIGHT(m2->d[i],i); + } + m1->td = w1; m2->td = w2; + return (*nd_sba_modord->cmpdl)(n,m1,m2); + } +} + int comp_sig(SIG s1,SIG s2) { if ( nd_sba_pot ) { if ( s1->pos > s2->pos ) return 1; else if ( s1->pos < s2->pos ) return -1; - else return (*cmpdl)(nd_nvar,s1->dl,s2->dl); + else return comp_sig_monomial(nd_nvar,s1->dl,s2->dl); } else { static DL m1,m2; - static int nvar; + static int nvar = 0; int ret; if ( nvar != nd_nvar ) { @@ -3406,7 +3677,7 @@ int comp_sig(SIG s1,SIG s2) } _adddl(nd_nvar,s1->dl,nd_sba_hm[s1->pos],m1); _adddl(nd_nvar,s2->dl,nd_sba_hm[s2->pos],m2); - ret = (*cmpdl)(nd_nvar,m1,m2); + ret = comp_sig_monomial(nd_nvar,m1,m2); if ( ret != 0 ) return ret; else if ( s1->pos > s2->pos ) return 1; else if ( s1->pos < s2->pos ) return -1; @@ -3569,7 +3840,7 @@ ND_pairs nd_newpairs_s(int t, NODE *syz) int ts,ret,i; ND_pairs r,r0,_sp,sp; SIG spsig,tsig; - static int nvar; + static int nvar = 0; static SIG _sig1,_sig2; struct oEGT eg1,eg2,eg3,eg4; @@ -3968,6 +4239,24 @@ int ndv_newps(int m,NDV a,NDV aq) return nd_psn++; } +// find LM wrt the specified modord +void ndv_lm_modord(NDV p,DL d) +{ + NMV m; + DL tmp; + int len,i,ret; + + NEWDL(tmp,nd_nvar); + m = BDY(p); len = LEN(p); + _ndltodl(DL(m),d); // printdl(d); printf("->"); + for ( i = 1, NMV_ADV(m); i < len; i++, NMV_ADV(m) ) { + _ndltodl(DL(m),tmp); + ret = comp_sig_monomial(nd_nvar,tmp,d); + if ( ret > 0 ) _copydl(nd_nvar,tmp,d); + } +// printdl(d); printf("\n"); +} + /* nd_tracelist = [[0,index,div],...,[nd_psn-1,index,div]] */ /* return 1 if success, 0 if failure (HC(a mod p)) */ @@ -4086,7 +4375,10 @@ int ndv_setup(int mod,int trace,NODE f,int dont_sort,i if ( nd_demand ) nd_ps_trace_sym[i]->sig = sig; } NEWDL(nd_sba_hm[i],nd_nvar); - _ndltodl(DL(nd_psh[i]),nd_sba_hm[i]); + if ( nd_sba_modord ) + ndv_lm_modord(nd_ps[i],nd_sba_hm[i]); + else + _ndltodl(DL(nd_psh[i]),nd_sba_hm[i]); } nd_sba_pos = (NODE *)MALLOC(nd_psn*sizeof(NODE)); for ( i = 0; i < nd_psn; i++ ) { @@ -4232,7 +4524,6 @@ void nd_gr(LIST f,LIST v,int m,int homo,int retdp,int nd_module = 0; if ( !m && Demand ) nd_demand = 1; else nd_demand = 0; - parse_nd_option(current_option); if ( DP_Multiple ) nd_scale = ((double)DP_Multiple)/(double)(Denominator?Denominator:1); @@ -4240,6 +4531,7 @@ void nd_gr(LIST f,LIST v,int m,int homo,int retdp,int ndv_alloc = 0; #endif get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc); + parse_nd_option(vv,current_option); if ( m && nd_vc ) error("nd_{gr,f4} : computation over Fp(X) is unsupported. Use dp_gr_mod_main()."); for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ ); @@ -4285,8 +4577,13 @@ void nd_gr(LIST f,LIST v,int m,int homo,int retdp,int } } } else { - e = getdeg(tv->v,(P)BDY(t)); - max = MAX(e,max); + if ( OID(BDY(t)) == O_DP ) { + e = dp_getdeg((DP)BDY(t)); + max = MAX(e,max); + } else { + e = getdeg(tv->v,(P)BDY(t)); + max = MAX(e,max); + } } } nd_setup_parameters(nvar,nd_nzlist?0:max); @@ -4307,9 +4604,17 @@ void nd_gr(LIST f,LIST v,int m,int homo,int retdp,int b = (pointer)pltondv(CO,vv,zpl); } } else { - if ( !m && !nd_gentrace ) ptozp((P)BDY(t),1,&dmy,&zp); - else zp = (P)BDY(t); - b = (pointer)ptondv(CO,vv,zp); + if ( OID(BDY(t)) == O_DP ) { + DP zdp; + + if ( !m && !nd_gentrace ) dp_ptozp((DP)BDY(t),&zdp); + else zdp = (DP)BDY(t); + b = (pointer)dptondv(m,zdp); + } else { + if ( !m && !nd_gentrace ) ptozp((P)BDY(t),1,&dmy,&zp); + else zp = (P)BDY(t); + b = (pointer)ptondv(CO,vv,zp); + } } if ( ishomo ) ishomo = ishomo && ndv_ishomo(b); @@ -4439,7 +4744,7 @@ NODE nd_sba_f4(int m,int **indp); void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int f4,struct order_spec *ord,LIST *rp) { VL tv,fv,vv,vc,av; - NODE fd,fd0,r,r0,t,x,s,xx; + NODE fd,fd0,r,r0,t,x,s,xx,nd,syz; int e,max,nvar,i; NDV b; int ishomo,nalg,wmax,len; @@ -4455,11 +4760,11 @@ void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int nd_module = 0; nd_demand = 0; - parse_nd_option(current_option); Nsamesig = 0; if ( DP_Multiple ) nd_scale = ((double)DP_Multiple)/(double)(Denominator?Denominator:1); get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc); + parse_nd_option(vv,current_option); if ( m && nd_vc ) error("nd_sba : computation over Fp(X) is unsupported. Use dp_gr_mod_main()."); for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ ); @@ -4477,17 +4782,30 @@ void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int initd(ord); for ( t = BDY(f), max = 1; t; t = NEXT(t) ) { for ( tv = vv; tv; tv = NEXT(tv) ) { - e = getdeg(tv->v,(P)BDY(t)); - max = MAX(e,max); + if ( OID(BDY(t)) == O_DP ) { + e = dp_getdeg((DP)BDY(t)); + max = MAX(e,max); + } else { + e = getdeg(tv->v,(P)BDY(t)); + max = MAX(e,max); + } } } nd_setup_parameters(nvar,max); obpe = nd_bpe; oadv = nmv_adv; oepos = nd_epos; ompos = nd_mpos; ishomo = 1; for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) { - if ( !m ) ptozp((P)BDY(t),1,&dmy,&zp); - else zp = (P)BDY(t); - b = (pointer)ptondv(CO,vv,zp); + if ( OID(BDY(t)) == O_DP ) { + DP zdp; + + if ( !m ) dp_ptozp((DP)BDY(t),&zdp); + else zdp = (DP)BDY(t); + b = (pointer)dptondv(m,zdp); + } else { + if ( !m ) ptozp((P)BDY(t),1,&dmy,&zp); + else zp = (P)BDY(t); + b = (pointer)ptondv(CO,vv,zp); + } if ( ishomo ) ishomo = ishomo && ndv_ishomo(b); if ( m ) ndv_mod(m,b); @@ -4511,7 +4829,7 @@ void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int } ndv_setup(m,0,fd0,nd_sba_dontsort,0,1); - x = f4 ? nd_sba_f4(m,&perm) : nd_sba_buch(m,ishomo || homo,&perm); + x = f4 ? nd_sba_f4(m,&perm) : nd_sba_buch(m,ishomo || homo,&perm,&syz); if ( !x ) { *rp = 0; return; } @@ -4534,7 +4852,16 @@ void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int else BDY(r) = ndvtop(m,CO,vv,BDY(t)); } if ( r0 ) NEXT(r) = 0; - MKLIST(*rp,r0); + if ( nd_sba_syz ) { + LIST gb,hsyz; + NODE nd; + + MKLIST(gb,r0); + MKLIST(hsyz,syz); + nd = mknode(2,gb,hsyz); + MKLIST(*rp,nd); + } else + MKLIST(*rp,r0); get_eg(&eg1); init_eg(&egconv); add_eg(&egconv,&eg0,&eg1); print_eg("conv",&egconv); fprintf(asir_out,"\n"); } @@ -4555,8 +4882,8 @@ void nd_gr_postproc(LIST f,LIST v,int m,struct order_s struct order_spec *ord1; int *perm; - parse_nd_option(current_option); get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc); + parse_nd_option(vv,current_option); for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ ); switch ( ord->id ) { case 1: @@ -4703,8 +5030,8 @@ void nd_gr_recompute_trace(LIST f,LIST v,int m,struct int len,n,j; NDV *db,*pb; - parse_nd_option(current_option); get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc); + parse_nd_option(vv,current_option); for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ ); switch ( ord->id ) { case 1: @@ -4803,7 +5130,8 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,int NcriB = NcriMF = Ncri2 = 0; nd_module = 0; nd_lf = 0; - parse_nd_option(current_option); + get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc); + parse_nd_option(vv,current_option); if ( nd_lf ) { if ( f4 ) nd_f4_lf_trace(f,v,trace,homo,ord,rp); @@ -4814,7 +5142,6 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,int if ( DP_Multiple ) nd_scale = ((double)DP_Multiple)/(double)(Denominator?Denominator:1); - get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc); for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ ); switch ( ord->id ) { case 1: @@ -4868,8 +5195,13 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,int } } } else { + if ( OID(BDY(t)) == O_DP ) { + e = dp_getdeg((DP)BDY(t)); + max = MAX(e,max); + } else { e = getdeg(tv->v,(P)BDY(t)); max = MAX(e,max); + } } } nd_setup_parameters(nvar,max); @@ -4890,9 +5222,17 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,int c = (pointer)pltondv(CO,vv,zpl); } } else { - if ( !nd_gentrace ) ptozp((P)BDY(t),1,&dmy,&zp); - else zp = (P)BDY(t); - c = (pointer)ptondv(CO,vv,zp); + if ( OID(BDY(t)) == O_DP ) { + DP zdp; + + if ( !nd_gentrace ) dp_ptozp((DP)BDY(t),&zdp); + else zdp = (DP)BDY(t); + c = (pointer)dptondv(m,zdp); + } else { + if ( !nd_gentrace ) ptozp((P)BDY(t),1,&dmy,&zp); + else zp = (P)BDY(t); + c = (pointer)ptondv(CO,vv,zp); + } } if ( ishomo ) ishomo = ishomo && ndv_ishomo(c); @@ -5628,8 +5968,10 @@ int nd_get_exporigin(struct order_spec *ord) void nd_setup_parameters(int nvar,int max) { int i,j,n,elen,ord_o,ord_l,l,s,wpd; struct order_pair *op; + extern int CNVars; nd_nvar = nvar; + CNVars = nvar; if ( max ) { /* XXX */ if ( do_weyl ) nd_bpe = 32; @@ -6759,6 +7101,32 @@ int nmv_comp(NMV a,NMV b) return -t; } +NDV dptondv(int mod,DP p) +{ + NDV d; + NMV m,m0; + MP t; + MP *a; + int i,len,n; + + if ( !p ) return 0; + for ( t = BDY(p), len = 0; t; t = NEXT(t), len++ ); + n = p->nv; + if ( mod > 0 || mod == -1 ) + m0 = m = (NMV)MALLOC_ATOMIC_IGNORE_OFF_PAGE(len*nmv_adv); + else + m0 = m = MALLOC(len*nmv_adv); + for ( i = 0, t = BDY(p); i < len; i++, NMV_ADV(m), t = NEXT(t) ) { + dltondl(n,t->dl,DL(m)); + TD(DL(m)) = ndl_weight(DL(m)); + CZ(m) = (Z)t->c; + } + qsort(m0,len,nmv_adv,(int (*)(const void *,const void *))nmv_comp); + MKNDV(NV(p),m0,len,d); + SG(d) = SG(p); + return d; +} + NDV dpmtondv(int mod,DPM p) { NDV d; @@ -6835,6 +7203,21 @@ DP ndvtodp(int mod,NDV p) return d; } +DPM sigtodpm(SIG s) +{ + DMM m; + DPM d; + + NEWDMM(m); + m->c = (Obj)ONE; + m->dl = s->dl; + m->pos = s->pos+1; + m->next = 0; + MKDPM(nd_nvar,m,d); + SG(d) = s->dl->td; + return d; +} + DPM ndvtodpm(int mod,NDV p) { DMM m,m0; @@ -9907,12 +10290,13 @@ NODE conv_ilist_s(int demand,int trace,int **indp) return g0; } -void parse_nd_option(NODE opt) +void parse_nd_option(VL vl,NODE opt) { NODE t,p,u; int i,s,n; char *key; Obj value; + VL oldvl; nd_gentrace = 0; nd_gensyz = 0; nd_nora = 0; nd_norb = 0; nd_gbblock = 0; nd_newelim = 0; nd_intersect = 0; nd_nzlist = 0; @@ -9920,6 +10304,7 @@ void parse_nd_option(NODE opt) nd_sugarweight = 0; nd_f4red =0; nd_rank0 = 0; nd_f4_td = 0; nd_sba_f4step = 2; nd_sba_pot = 0; nd_sba_largelcm = 0; nd_sba_dontsort = 0; nd_top = 0; nd_sba_redundant_check = 0; + nd_sba_syz = 0; nd_sba_modord = 0; nd_sba_inputisgb = 0; for ( t = opt; t; t = NEXT(t) ) { p = BDY((LIST)BDY(t)); @@ -9978,17 +10363,33 @@ void parse_nd_option(NODE opt) } else if ( !strcmp(key,"sba_f4step") ) { nd_sba_f4step = value?ZTOS((Q)value):0; } else if ( !strcmp(key,"sba_pot") ) { - nd_sba_pot = value?1:0; + nd_sba_pot = ZTOS((Q)value); } else if ( !strcmp(key,"sba_largelcm") ) { nd_sba_largelcm = value?1:0; } else if ( !strcmp(key,"sba_dontsort") ) { nd_sba_dontsort = value?1:0; + } else if ( !strcmp(key,"sba_syz") ) { + nd_sba_syz = value?1:0; + } else if ( !strcmp(key,"sba_modord") ) { + // value=[vlist,ordspec,weight] + u = BDY((LIST)value); + pltovl((LIST)ARG0(u),&oldvl); + nd_sba_modord = create_comp_sig_spec(vl,oldvl,(Obj)ARG1(u),argc(u)==3?ARG2(u):0); + } else if ( !strcmp(key,"sba_gbinput") ) { + nd_sba_inputisgb = value?1:0; + if ( nd_sba_inputisgb != 0 ) { + // value=[vlist,ordspec,weight] + u = BDY((LIST)value); + pltovl((LIST)ARG0(u),&oldvl); + nd_sba_modord = create_comp_sig_spec(vl,oldvl,(Obj)ARG1(u),argc(u)==3?ARG2(u):0); + } } else if ( !strcmp(key,"sba_redundant_check") ) { nd_sba_redundant_check = value?1:0; } else if ( !strcmp(key,"top") ) { nd_top = value?1:0; } } + if ( nd_sba_syz ) nd_sba_dontsort = 1; } ND mdptond(DP d); @@ -10193,8 +10594,8 @@ MAT nd_btog(LIST f,LIST v,int mod,struct order_spec *o if ( mod == -2 ) return nd_btog_lf(f,v,ord,tlist,rp); - parse_nd_option(current_option); get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc); + parse_nd_option(vv,current_option); for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ ); switch ( ord->id ) { case 1: @@ -10262,8 +10663,8 @@ MAT nd_btog_lf(LIST f,LIST v,struct order_spec *ord,LI LM lm; Z lf,inv; - parse_nd_option(current_option); get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc); + parse_nd_option(vv,current_option); for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ ); switch ( ord->id ) { case 1: @@ -10333,8 +10734,8 @@ VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp if ( mod == -2 ) error("nd_btog_one : not implemented yet for a large finite field"); - parse_nd_option(current_option); get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc); + parse_nd_option(vv,current_option); for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ ); switch ( ord->id ) { case 1: @@ -10447,8 +10848,8 @@ void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s Q jq,bpe; nd_module = 0; - parse_nd_option(current_option); get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc); + parse_nd_option(vv,current_option); if ( nd_vc ) error("nd_f4_lf_trace : computation over a rational function field is not implemented"); for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ );