=================================================================== RCS file: /home/cvs/OpenXM_contrib2/asir2000/engine/nd.c,v retrieving revision 1.170 retrieving revision 1.181 diff -u -p -r1.170 -r1.181 --- OpenXM_contrib2/asir2000/engine/nd.c 2009/02/11 03:04:42 1.170 +++ OpenXM_contrib2/asir2000/engine/nd.c 2010/02/05 05:18:38 1.181 @@ -1,4 +1,4 @@ -/* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.169 2009/02/10 06:33:08 noro Exp $ */ +/* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.180 2010/02/05 04:24:00 noro Exp $ */ #include "nd.h" @@ -46,9 +46,10 @@ static int nd_worb_len; static int nd_found,nd_create,nd_notfirst; static int nmv_adv; static int nd_demand; -static int nd_module,nd_ispot,nd_mpos; +static int nd_module,nd_ispot,nd_mpos,nd_pot_nelim; static NODE nd_tracelist; static NODE nd_alltracelist; +static int nd_gentrace,nd_gensyz,nd_nora; NumberField get_numberfield(); UINT *nd_det_compute_bound(NDV **dm,int n,int j); @@ -67,6 +68,7 @@ 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); extern int Denominator,DP_Multiple; @@ -579,6 +581,14 @@ int ndl_module_grlex_compare(UINT *d1,UINT *d2) int i,c; if ( nd_ispot ) { + if ( nd_pot_nelim && MPOS(d1)>=nd_pot_nelim+1 && MPOS(d2) >= nd_pot_nelim+1 ) { + if ( TD(d1) > TD(d2) ) return 1; + else if ( TD(d1) < TD(d2) ) return -1; + if ( c = ndl_lex_compare(d1,d2) ) return c; + if ( MPOS(d1) < MPOS(d2) ) return 1; + else if ( MPOS(d1) > MPOS(d2) ) return -1; + return 0; + } if ( MPOS(d1) < MPOS(d2) ) return 1; else if ( MPOS(d1) > MPOS(d2) ) return -1; } @@ -1325,7 +1335,7 @@ int nd_nf(int mod,ND d,ND g,NDV *ps,int full,NDC dn,ND p = nd_demand ? ndv_load(index) : ps[index]; /* d+g -> div*(d+g)+mul*p */ g = nd_reduce2(mod,d,g,p,mul,dn,&div); - if ( GenTrace ) { + if ( nd_gentrace ) { /* Trace=[div,index,mul,ONE] */ STOQ(index,iq); nmtodp(mod,mul,&dmul); @@ -1335,7 +1345,7 @@ int nd_nf(int mod,ND d,ND g,NDV *ps,int full,NDC dn,ND if ( !mod && g && ((double)(p_mag(HCP(g))) > hmag) ) { hg = HCU(g); nd_removecont2(d,g); - if ( dn || GenTrace ) { + if ( dn || nd_gentrace ) { /* overwrite cont : Trace=[div,index,mul,cont] */ cont = ndc_div(mod,hg,HCU(g)); if ( dn ) { @@ -1344,7 +1354,7 @@ int nd_nf(int mod,ND d,ND g,NDV *ps,int full,NDC dn,ND reductr(nd_vc,(Obj)tr,&tr1); dn->r = (R)tr1; } else divq(dn->z,(Q)cont,&dn->z); } - if ( GenTrace && !UNIQ(cont) ) ARG3(node) = (pointer)cont; + if ( nd_gentrace && !UNIQ(cont) ) ARG3(node) = (pointer)cont; } hmag = ((double)p_mag(HCP(g)))*nd_scale; } @@ -1486,10 +1496,10 @@ int ndv_check_membership(int m,NODE input,int obpe,int Q q; LIST list; - ndv_setup(m,0,cand,GenTrace?1:0,1); + ndv_setup(m,0,cand,nd_gentrace?1:0,1); n = length(cand); - if ( GenTrace ) { nd_alltracelist = 0; nd_tracelist = 0; } + if ( nd_gentrace ) { nd_alltracelist = 0; nd_tracelist = 0; } /* membercheck : list is a subset of Id(cand) ? */ for ( t = input, i = 0; t; t = NEXT(t), i++ ) { again: @@ -1498,13 +1508,13 @@ again: r = ndv_dup_realloc((NDV)BDY(t),obpe,oadv,oepos); else r = (NDV)BDY(t); - d = ndvtond(0,r); - stat = nd_nf(0,0,d,nd_ps,0,0,&nf); + d = ndvtond(m,r); + stat = nd_nf(m,0,d,nd_ps,0,0,&nf); if ( !stat ) { nd_reconstruct(0,0); goto again; } else if ( nf ) return 0; - if ( GenTrace ) { + if ( nd_gentrace ) { nd_tracelist = reverse_node(nd_tracelist); MKLIST(list,nd_tracelist); STOQ(i,q); s = mknode(2,q,list); MKLIST(list,s); @@ -1821,7 +1831,7 @@ int do_diagonalize(int sugar,int m) Q iq; for ( i = nd_psn-1; i >= 0 && SG(nd_psh[i]) == sugar; i-- ) { - if ( GenTrace ) { + if ( nd_gentrace ) { /* Trace = [1,index,1,1] */ STOQ(i,iq); node = mknode(4,ONE,iq,ONE,ONE); MKLIST(l,node); MKNODE(nd_tracelist,l,0); @@ -1837,7 +1847,7 @@ int do_diagonalize(int sugar,int m) ndv_free(nfv); hc = HCU(nf); nd_removecont(m,nf); cont = ndc_div(m,hc,HCU(nf)); - if ( GenTrace ) finalize_tracelist(i,cont); + if ( nd_gentrace ) finalize_tracelist(i,cont); nfv = ndtondv(m,nf); nd_free(nf); nd_bound[i] = ndv_compute_bound(nfv); @@ -1896,7 +1906,7 @@ again: goto again; } #if USE_GEOBUCKET - stat = (m&&!GenTrace)?nd_nf_pbucket(m,h,nd_ps,!Top,&nf) + stat = (m&&!nd_gentrace)?nd_nf_pbucket(m,h,nd_ps,!Top,&nf) :nd_nf(m,0,h,nd_ps,!Top,0,&nf); #else stat = nd_nf(m,0,h,nd_ps,!Top,0,&nf); @@ -1914,7 +1924,7 @@ again: nd_monic(0,&nf); nd_removecont(m,nf); } - if ( GenTrace ) { + if ( nd_gentrace ) { cont = ndc_div(m,hc,HCU(nf)); if ( m || !UNIQ(cont) ) { t = mknode(4,0,0,0,cont); @@ -1937,7 +1947,7 @@ again: g = update_base(g,nh); FREENDP(l); } else { - if ( GenTrace && gensyz ) { + if ( nd_gentrace && gensyz ) { nd_tracelist = reverse_node(nd_tracelist); MKLIST(list,nd_tracelist); STOQ(-1,q); t = mknode(2,q,list); MKLIST(list,t); @@ -1967,7 +1977,7 @@ int do_diagonalize_trace(int sugar,int m) P cont,cont1; for ( i = nd_psn-1; i >= 0 && SG(nd_psh[i]) == sugar; i-- ) { - if ( GenTrace ) { + if ( nd_gentrace ) { /* Trace = [1,index,1,1] */ STOQ(i,iq); node = mknode(4,ONE,iq,ONE,ONE); MKLIST(l,node); MKNODE(nd_tracelist,l,0); @@ -1994,7 +2004,7 @@ int do_diagonalize_trace(int sugar,int m) ndv_free(nfv); hc = HCU(nf); nd_removecont(0,nf); cont = ndc_div(0,hc,HCU(nf)); - if ( GenTrace ) finalize_tracelist(i,cont); + if ( nd_gentrace ) finalize_tracelist(i,cont); nfv = ndtondv(0,nf); nd_free(nf); nd_bound[i] = ndv_compute_bound(nfv); @@ -2116,7 +2126,7 @@ again: nd_removecont(0,nfq); nfqv = ndtondv(0,nfq); nd_free(nfq); nd_removecont(m,nf); nfv = ndtondv(m,nf); nd_free(nf); } - if ( GenTrace ) { + if ( nd_gentrace ) { cont = ndc_div(0,hnfq,HCU(nfqv)); if ( !UNIQ(cont) ) { t = mknode(4,0,0,0,cont); @@ -2190,15 +2200,16 @@ NODE ndv_reduceall(int m,NODE f) union oNDC hc; P cont,cont1; + if ( nd_nora ) return f; n = length(f); ndv_setup(m,0,f,0,1); perm = (int *)MALLOC(n*sizeof(int)); - if ( GenTrace ) { + if ( nd_gentrace ) { for ( t = nd_tracelist, i = 0; i < n; i++, t = NEXT(t) ) perm[i] = QTOS((Q)ARG1(BDY((LIST)BDY(t)))); } for ( i = 0; i < n; ) { - if ( GenTrace ) { + if ( nd_gentrace ) { /* Trace = [1,index,1,1] */ STOQ(i,iq); node = mknode(4,ONE,iq,ONE,ONE); MKLIST(l,node); MKNODE(nd_tracelist,l,0); @@ -2212,7 +2223,7 @@ NODE ndv_reduceall(int m,NODE f) if ( DP_Print ) { printf("."); fflush(stdout); } ndv_free(nd_ps[i]); hc = HCU(nf); nd_removecont(m,nf); - if ( GenTrace ) { + if ( nd_gentrace ) { for ( t = nd_tracelist; t; t = NEXT(t) ) { jq = ARG1(BDY((LIST)BDY(t))); j = QTOS(jq); STOQ(perm[j],jq); ARG1(BDY((LIST)BDY(t))) = jq; @@ -2228,7 +2239,7 @@ NODE ndv_reduceall(int m,NODE f) if ( DP_Print ) { printf("\n"); } for ( a0 = 0, i = 0; i < n; i++ ) { NEXTNODE(a0,a); - if ( !GenTrace ) BDY(a) = (pointer)nd_ps[i]; + if ( !nd_gentrace ) BDY(a) = (pointer)nd_ps[i]; else { for ( j = 0; j < n; j++ ) if ( perm[j] == i ) break; BDY(a) = (pointer)nd_ps[j]; @@ -2244,7 +2255,7 @@ ND_pairs update_pairs( ND_pairs d, NODE /* of index */ if ( !g ) return d; /* for testing */ - if ( gensyz && GenSyz == 2 ) { + if ( gensyz && nd_gensyz == 2 ) { d1 = nd_newpairs(g,t); if ( !d ) return d1; @@ -2573,7 +2584,7 @@ int ndv_newps(int m,NDV a,NDV aq) nd_ps[nd_psn] = 0; } } - if ( GenTrace ) { + if ( nd_gentrace ) { /* reverse the tracelist and append it to alltracelist */ nd_tracelist = reverse_node(nd_tracelist); MKLIST(l,nd_tracelist); STOQ(nd_psn,iq); tn = mknode(2,iq,l); MKLIST(l,tn); @@ -2583,8 +2594,9 @@ int ndv_newps(int m,NDV a,NDV aq) } /* nd_tracelist = [[0,index,div],...,[nd_psn-1,index,div]] */ +/* return 1 if success, 0 if failure (HC(a mod p)) */ -void ndv_setup(int mod,int trace,NODE f,int dont_sort,int dont_removecont) +int ndv_setup(int mod,int trace,NODE f,int dont_sort,int dont_removecont) { int i,j,td,len,max; NODE s,s0,f0,tn; @@ -2638,13 +2650,15 @@ void ndv_setup(int mod,int trace,NODE f,int dont_sort, register_hcf(a); am = nd_ps[i] = ndv_dup(mod,a); ndv_mod(mod,am); + if ( DL_COMPARE(HDL(am),HDL(a)) ) + return 0; ndv_removecont(mod,am); } else { a = nd_ps[i] = ndv_dup(mod,w[i].p); if ( mod || !dont_removecont ) ndv_removecont(mod,a); if ( !mod ) register_hcf(a); } - if ( GenTrace ) { + if ( nd_gentrace ) { STOQ(i,iq); STOQ(w[i].i,jq); node = mknode(3,iq,jq,ONE); if ( !dont_removecont ) ARG2(node) = (pointer)ndc_div(trace?0:mod,hc,HCU(a)); @@ -2663,7 +2677,8 @@ void ndv_setup(int mod,int trace,NODE f,int dont_sort, } } } - if ( GenTrace && nd_tracelist ) NEXT(tn) = 0; + if ( nd_gentrace && nd_tracelist ) NEXT(tn) = 0; + return 1; } struct order_spec *append_block(struct order_spec *spec, @@ -2796,6 +2811,7 @@ void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe 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); @@ -2829,7 +2845,7 @@ void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe } nd_init_ord(ord); mrank = 0; - for ( t = BDY(f), max = 0; t; t = NEXT(t) ) + for ( t = BDY(f), max = 1; t; t = NEXT(t) ) for ( tv = vv; tv; tv = NEXT(tv) ) { if ( nd_module ) { s = BDY((LIST)BDY(t)); @@ -2849,11 +2865,11 @@ void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe ishomo = 1; for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) { if ( nd_module ) { - if ( !m && !GenTrace ) pltozpl((LIST)BDY(t),&dmy,&zpl); + if ( !m && !nd_gentrace ) pltozpl((LIST)BDY(t),&dmy,&zpl); else zpl = (LIST)BDY(t); b = (pointer)pltondv(CO,vv,zpl); } else { - if ( !m && !GenTrace ) ptozp((P)BDY(t),1,&dmy,&zp); + if ( !m && !nd_gentrace ) ptozp((P)BDY(t),1,&dmy,&zp); else zp = (P)BDY(t); b = (pointer)ptondv(CO,vv,zp); } @@ -2864,22 +2880,22 @@ void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe } if ( fd0 ) NEXT(fd) = 0; ndv_setup(m,0,fd0,0,0); - if ( GenTrace ) { + if ( nd_gentrace ) { MKLIST(l1,nd_tracelist); MKNODE(nd_alltracelist,l1,0); } x = f4?nd_f4(m,&perm):nd_gb(m,ishomo,0,0,&perm); nd_demand = 0; x = ndv_reducebase(x,perm); - if ( GenTrace ) { tl1 = nd_alltracelist; nd_alltracelist = 0; } + if ( nd_gentrace ) { tl1 = nd_alltracelist; nd_alltracelist = 0; } x = ndv_reduceall(m,x); - if ( GenTrace ) { + if ( nd_gentrace ) { tl2 = nd_alltracelist; nd_alltracelist = 0; ndv_check_membership(m,fd0,obpe,oadv,oepos,x); - if ( GenTrace ) { + if ( nd_gentrace ) { tl3 = nd_alltracelist; nd_alltracelist = 0; } else tl3 = 0; - nd_gb(m,0,1,GenSyz?1:0,0)!=0; - if ( GenTrace && GenSyz ) { + nd_gb(m,0,1,nd_gensyz?1:0,0)!=0; + if ( nd_gentrace && nd_gensyz ) { tl4 = nd_alltracelist; nd_alltracelist = 0; } else tl4 = 0; } @@ -2892,7 +2908,7 @@ void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe if ( nalg ) r0 = postprocess_algcoef(av,alist,r0); MKLIST(*rp,r0); - if ( GenTrace ) { + if ( nd_gentrace ) { tl1 = reverse_node(tl1); tl2 = reverse_node(tl2); tl3 = reverse_node(tl3); /* tl2 = [[i,[[*,j,*,*],...]],...] */ @@ -2959,7 +2975,7 @@ void nd_gr_postproc(LIST f,LIST v,int m,struct order_s nvar += nalg; } nd_init_ord(ord); - for ( t = BDY(f), max = 0; t; t = NEXT(t) ) + 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); @@ -2985,8 +3001,13 @@ void nd_gr_postproc(LIST f,LIST v,int m,struct order_s return; } } else { +#if 0 + /* bug ? */ for ( t = x; t; t = NEXT(t) ) BDY(t) = (pointer)nd_ps[(long)BDY(t)]; +#else + conv_ilist(0,0,x,&perm); +#endif } x = ndv_reducebase(x,perm); x = ndv_reduceall(m,x); @@ -3025,6 +3046,7 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,int Q jq; nd_module = 0; + parse_nd_option(current_option); if ( DP_Multiple ) nd_scale = ((double)DP_Multiple)/(double)(Denominator?Denominator:1); @@ -3065,7 +3087,7 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,int m = trace > 1 ? trace : get_lprime(mindex); nd_init_ord(ord); mrank = 0; - for ( t = BDY(f), max = 0; t; t = NEXT(t) ) + for ( t = BDY(f), max = 1; t; t = NEXT(t) ) for ( tv = vv; tv; tv = NEXT(tv) ) { if ( nd_module ) { s = BDY((LIST)BDY(t)); @@ -3085,11 +3107,11 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,int ishomo = 1; for ( in0 = 0, fd0 = 0, t = BDY(f); t; t = NEXT(t) ) { if ( nd_module ) { - if ( !GenTrace ) pltozpl((LIST)BDY(t),&dmy,&zpl); + if ( !nd_gentrace ) pltozpl((LIST)BDY(t),&dmy,&zpl); else zpl = (LIST)BDY(t); c = (pointer)pltondv(CO,vv,zpl); } else { - if ( !GenTrace ) ptozp((P)BDY(t),1,&dmy,&zp); + if ( !nd_gentrace ) ptozp((P)BDY(t),1,&dmy,&zp); else zp = (P)BDY(t); c = (pointer)ptondv(CO,vv,zp); } @@ -3117,12 +3139,13 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,int while ( 1 ) { if ( Demand ) nd_demand = 1; - ndv_setup(m,1,fd0,0,0); - if ( GenTrace ) { + if ( nd_gentrace ) { MKLIST(l1,nd_tracelist); MKNODE(nd_alltracelist,l1,0); } - cand = f4?nd_f4_trace(m,&perm):nd_gb_trace(m,ishomo || homo,&perm); - if ( !cand ) { + ret = ndv_setup(m,1,fd0,0,0); + if ( ret ) + cand = f4?nd_f4_trace(m,&perm):nd_gb_trace(m,ishomo || homo,&perm); + if ( !ret || !cand ) { /* failure */ if ( trace > 1 ) { *rp = 0; return; } else m = get_lprime(++mindex); @@ -3136,20 +3159,20 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,int } nd_demand = 0; cand = ndv_reducebase(cand,perm); - if ( GenTrace ) { tl1 = nd_alltracelist; nd_alltracelist = 0; } + if ( nd_gentrace ) { tl1 = nd_alltracelist; nd_alltracelist = 0; } cand = ndv_reduceall(0,cand); cbpe = nd_bpe; - if ( GenTrace ) { tl2 = nd_alltracelist; nd_alltracelist = 0; } + if ( nd_gentrace ) { tl2 = nd_alltracelist; nd_alltracelist = 0; } + get_eg(&eg0); if ( nocheck ) break; - get_eg(&eg0); if ( ret = ndv_check_membership(0,in0,obpe,oadv,oepos,cand) ) { - if ( GenTrace ) { + if ( nd_gentrace ) { tl3 = nd_alltracelist; nd_alltracelist = 0; } else tl3 = 0; /* gbcheck : cand is a GB of Id(cand) ? */ - ret = nd_gb(0,0,1,GenSyz?1:0,0)!=0; - if ( GenTrace && GenSyz ) { + ret = nd_gb(0,0,1,nd_gensyz?1:0,0)!=0; + if ( nd_gentrace && nd_gensyz ) { tl4 = nd_alltracelist; nd_alltracelist = 0; } else tl4 = 0; } @@ -3183,7 +3206,7 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,int if ( nalg ) cand = postprocess_algcoef(av,alist,cand); MKLIST(*rp,cand); - if ( GenTrace ) { + if ( nd_gentrace ) { tl1 = reverse_node(tl1); tl2 = reverse_node(tl2); tl3 = reverse_node(tl3); /* tl2 = [[i,[[*,j,*,*],...]],...] */ @@ -3425,7 +3448,7 @@ void ndv_homogenize(NDV p,int obpe,int oadv,EPOS oepos NMV m,mr0,mr,t; len = p->len; - for ( m = BDY(p), i = 0, max = 0; i < len; NMV_OADV(m), i++ ) + for ( m = BDY(p), i = 0, max = 1; i < len; NMV_OADV(m), i++ ) max = MAX(max,TD(DL(m))); mr0 = nmv_adv>oadv?(NMV)REALLOC(BDY(p),len*nmv_adv):BDY(p); m = (NMV)((char *)mr0+(len-1)*oadv); @@ -3929,7 +3952,7 @@ int nd_sp(int mod,int trace,ND_pairs p,ND *rp) } t1 = ndv_mul_nm(mod,m1,p1); t2 = ndv_mul_nm(mod,m2,p2); *rp = nd_add(mod,t1,t2); - if ( GenTrace ) { + if ( nd_gentrace ) { /* nd_tracelist is initialized */ STOQ(p->i1,iq); nmtodp(mod,m1,&d); node = mknode(4,ONE,iq,d,ONE); MKLIST(hist,node); MKNODE(nd_tracelist,hist,0); @@ -4029,7 +4052,9 @@ void weyl_mul_nm_nmv(int n,int mod,NM m0,NMV m1,NM *ta NEWNM(m); d = DL(m); if ( mod ) { c0 = CM(m0); c1 = CM(m1); DMAR(c0,c1,0,mod,c); CM(m) = c; - } else + } else if ( nd_vc ) + mulp(nd_vc,CP(m0),CP(m1),&CP(m)); + else mulq(CQ(m0),CQ(m1),&CQ(m)); for ( i = 0; i < nd_wpd; i++ ) d[i] = 0; homo = n&1 ? 1 : 0; @@ -4084,7 +4109,9 @@ void weyl_mul_nm_nmv(int n,int mod,NM m0,NMV m1,NM *ta ndl_addto(DL(tab[u]),d); if ( mod ) { c0 = CM(tab[u]); DMAR(c0,c,0,mod,c1); CM(tab[u]) = c1; - } else { + } else if ( nd_vc ) + mulp(nd_vc,CP(tab[u]),(P)q,&CP(tab[u])); + else { mulq(CQ(tab[u]),q,&q1); CQ(tab[u]) = q1; } } @@ -4096,7 +4123,9 @@ void weyl_mul_nm_nmv(int n,int mod,NM m0,NMV m1,NM *ta ndl_add(DL(tab[u]),d,DL(t)); if ( mod ) { c0 = CM(tab[u]); DMAR(c0,c,0,mod,c1); CM(t) = c1; - } else + } else if ( nd_vc ) + mulp(nd_vc,CP(tab[u]),(P)q,&CP(t)); + else mulq(CQ(tab[u]),q,&CQ(t)); *p = t; } @@ -4735,6 +4764,7 @@ void nd_init_ord(struct order_spec *ord) /* module order */ case 256: nd_ispot = ord->ispot; + nd_pot_nelim = ord->pot_nelim; nd_dcomp = -1; switch ( ord->ord.simple ) { case 0: @@ -4755,16 +4785,28 @@ void nd_init_ord(struct order_spec *ord) break; case 257: /* block order */ + nd_ispot = ord->ispot; + nd_pot_nelim = ord->pot_nelim; + nd_dcomp = -1; + nd_isrlex = 0; ndl_compare_function = ndl_module_block_compare; break; case 258: /* matrix order */ + nd_ispot = ord->ispot; + nd_pot_nelim = ord->pot_nelim; + nd_dcomp = -1; + nd_isrlex = 0; nd_matrix_len = ord->ord.matrix.row; nd_matrix = ord->ord.matrix.matrix; ndl_compare_function = ndl_module_matrix_compare; break; case 259: /* composite order */ + nd_ispot = ord->ispot; + nd_pot_nelim = ord->pot_nelim; + nd_dcomp = -1; + nd_isrlex = 0; nd_worb_len = ord->ord.composite.length; nd_worb = ord->ord.composite.w_or_b; ndl_compare_function = ndl_module_composite_compare; @@ -4872,7 +4914,7 @@ void nd_nf_p(P f,LIST g,LIST v,int m,struct order_spec for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ ); /* get the degree bound */ - for ( t = BDY(g), max = 0; t; t = NEXT(t) ) + for ( t = BDY(g), max = 1; t; t = NEXT(t) ) for ( tv = vv; tv; tv = NEXT(tv) ) { e = getdeg(tv->v,(P)BDY(t)); max = MAX(e,max); @@ -5553,6 +5595,109 @@ NODE nd_f4_trace(int m,int **indp) return g; } +NODE nd_f4_pseudo_trace(int m,int **indp) +{ + int i,nh,stat,index; + NODE r,g; + ND_pairs d,l,l0,t; + ND spol,red; + NDV nf,redv,nfqv,nfv; + NM s0,s; + NODE rp0,srp0,nflist; + int nsp,nred,col,rank,len,k,j,a; + UINT c; + UINT **spmat; + UINT *s0vect,*svect,*p,*v; + int *colstat; + IndArray *imat; + int *rhead; + int spcol,sprow; + int sugar; + PGeoBucket bucket; + struct oEGT eg0,eg1,eg_f4; + + g = 0; d = 0; + for ( i = 0; i < nd_psn; i++ ) { + d = update_pairs(d,g,i,0); + g = update_base(g,i); + } + while ( d ) { + get_eg(&eg0); + l = nd_minsugarp(d,&d); + sugar = SG(l); + bucket = create_pbucket(); + stat = nd_sp_f4(m,0,l,bucket); + if ( !stat ) { + for ( t = l; NEXT(t); t = NEXT(t) ); + NEXT(t) = d; d = l; + d = nd_reconstruct(1,d); + continue; + } + if ( bucket->m < 0 ) continue; + col = nd_symbolic_preproc(bucket,0,&s0vect,&rp0); + if ( !col ) { + for ( t = l; NEXT(t); t = NEXT(t) ); + NEXT(t) = d; d = l; + d = nd_reconstruct(1,d); + continue; + } + get_eg(&eg1); init_eg(&eg_f4); add_eg(&eg_f4,&eg0,&eg1); + if ( DP_Print ) + fprintf(asir_out,"sugar=%d,symb=%fsec,", + sugar,eg_f4.exectime+eg_f4.gctime); + nflist = nd_f4_red(m,l,0,s0vect,col,rp0,&l0); + if ( !l0 ) continue; + l = l0; + + /* over Q */ + while ( 1 ) { + bucket = create_pbucket(); + stat = nd_sp_f4(0,1,l,bucket); + if ( !stat ) { + for ( t = l; NEXT(t); t = NEXT(t) ); + NEXT(t) = d; d = l; + d = nd_reconstruct(1,d); + continue; + } + if ( bucket->m < 0 ) continue; + col = nd_symbolic_preproc(bucket,1,&s0vect,&rp0); + if ( !col ) { + for ( t = l; NEXT(t); t = NEXT(t) ); + NEXT(t) = d; d = l; + d = nd_reconstruct(1,d); + continue; + } + nflist = nd_f4_red(0,l,1,s0vect,col,rp0,0); + } + + /* adding new bases */ + for ( r = nflist; r; r = NEXT(r) ) { + nfqv = (NDV)BDY(r); + ndv_removecont(0,nfqv); + if ( !rem(NM(HCQ(nfqv)),m) ) return 0; + if ( nd_nalg ) { + ND nf1; + + nf1 = ndvtond(m,nfqv); + nd_monic(0,&nf1); + nd_removecont(0,nf1); + nfqv = ndtondv(0,nf1); nd_free(nf1); + } + nfv = ndv_dup(0,nfqv); + ndv_mod(m,nfv); + ndv_removecont(m,nfv); + nh = ndv_newps(0,nfv,nfqv); + d = update_pairs(d,g,nh,0); + g = update_base(g,nh); + } + } +#if 0 + fprintf(asir_out,"ndv_alloc=%d\n",ndv_alloc); +#endif + conv_ilist(0,1,g,indp); + return g; +} + NODE nd_f4_red(int m,ND_pairs sp0,int trace,UINT *s0vect,int col,NODE rp0,ND_pairs *nz) { IndArray *imat; @@ -6061,31 +6206,13 @@ void nd_exec_f4_red_dist() int nd_gauss_elim_q(Q **mat0,int *sugar,int row,int col,int *colstat) { - int mod,i,j,t,c,rank,rank0,inv; + int i,j,t,c,rank,inv; int *ci,*ri; Q dn; MAT m,nm; - int **wmat; - /* XXX */ - mod = 99999989; - wmat = (int **)ALLOCA(row*sizeof(int *)); - for ( i = 0; i < row; i++ ) { - wmat[i] = (int *)ALLOCA(col*sizeof(int)); - for ( j = 0; j < col; j++ ) { - if ( mat0[i][j] ) { - t = rem(NM(mat0[i][j]),mod); - if ( SGN(mat0[i][j]) < 0 ) t = mod-t; - wmat[i][j] = t; - } else - wmat[i][j] = 0; - } - } - rank0 = nd_gauss_elim_mod(wmat,sugar,0,row,col,mod,colstat); NEWMAT(m); m->row = row; m->col = col; m->body = (pointer **)mat0; rank = generic_gauss_elim(m,&nm,&dn,&ri,&ci); - if ( rank != rank0 ) - error("afo"); for ( i = 0; i < row; i++ ) for ( j = 0; j < col; j++ ) mat0[i][j] = 0; @@ -6095,19 +6222,6 @@ int nd_gauss_elim_q(Q **mat0,int *sugar,int row,int co for ( j = 0; j < c; j++ ) mat0[i][ci[j]] = (Q)BDY(nm)[i][j]; } - inv = invm(rem(NM(dn),mod),mod); - if ( SGN(dn) < 0 ) inv = mod-inv; - for ( i = 0; i < row; i++ ) - for ( j = 0; j < col; j++ ) { - if ( mat0[i][j] ) { - t = rem(NM(mat0[i][j]),mod); - if ( SGN(mat0[i][j]) < 0 ) t = mod-t; - } else - t = 0; - c = dmar(t,inv,0,mod); - if ( wmat[i][j] != c ) - error("afo"); - } return rank; } @@ -6395,7 +6509,7 @@ void nd_det(int mod,MAT f,P *rp) m = (pointer **)w; } - for ( i = 0, max = 0; i < n; i++ ) + for ( i = 0, max = 1; i < n; i++ ) for ( j = 0; j < n; j++ ) for ( tv = fv; tv; tv = NEXT(tv) ) { e = getdeg(tv->v,(P)m[i][j]); @@ -6403,7 +6517,7 @@ void nd_det(int mod,MAT f,P *rp) } nd_setup_parameters(nvar,max); dm = (NDV **)almat_pointer(n,n); - for ( i = 0, max = 0; i < n; i++ ) + for ( i = 0, max = 1; i < n; i++ ) for ( j = 0; j < n; j++ ) { dm[i][j] = ptondv(CO,fv,m[i][j]); if ( mod ) ndv_mod(mod,dm[i][j]); @@ -6788,4 +6902,24 @@ void conv_ilist(int demand,int trace,NODE g,int **indp BDY(t) = (pointer)(demand?ndv_load(j):(trace?nd_ps_trace[j]:nd_ps[j])); } if ( indp ) *indp = ind; +} + +void parse_nd_option(NODE opt) +{ + NODE t,p; + char *key; + Obj value; + + nd_gentrace = 0; nd_gensyz = 0; nd_nora = 0; + for ( t = opt; t; t = NEXT(t) ) { + p = BDY((LIST)BDY(t)); + key = BDY((STRING)BDY(p)); + value = (Obj)BDY(NEXT(p)); + if ( !strcmp(key,"gentrace") ) + nd_gentrace = value?1:0; + else if ( !strcmp(key,"gensyz") ) + nd_gensyz = value?1:0; + else if ( !strcmp(key,"nora") ) + nd_nora = value?1:0; + } }