=================================================================== RCS file: /home/cvs/OpenXM_contrib2/asir2000/engine/nd.c,v retrieving revision 1.220 retrieving revision 1.231 diff -u -p -r1.220 -r1.231 --- OpenXM_contrib2/asir2000/engine/nd.c 2015/01/13 00:54:54 1.220 +++ OpenXM_contrib2/asir2000/engine/nd.c 2016/12/05 10:29:14 1.231 @@ -1,4 +1,4 @@ -/* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.219 2014/08/19 06:35:01 noro Exp $ */ +/* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.230 2016/12/02 02:12:00 noro Exp $ */ #include "nd.h" @@ -56,12 +56,15 @@ static int nd_found,nd_create,nd_notfirst; static int nmv_adv; static int nd_demand; static int nd_module,nd_ispot,nd_mpos,nd_pot_nelim; +static int nd_module_rank,nd_poly_weight_len; +static int *nd_poly_weight,*nd_module_weight; static NODE nd_tracelist; static NODE nd_alltracelist; static int nd_gentrace,nd_gensyz,nd_nora,nd_newelim,nd_intersect; static int *nd_gbblock; static NODE nd_nzlist,nd_check_splist; static int nd_splist; +static int *nd_sugarweight; NumberField get_numberfield(); UINT *nd_det_compute_bound(NDV **dm,int n,int j); @@ -88,8 +91,11 @@ NDV ndvgztondv(NDV p); ND ndtondgz(ND p); ND ndgztond(ND p); -extern int Denominator,DP_Multiple; +void Pdp_set_weight(NODE,VECT *); +void Pox_cmo_rpc(NODE,Obj *); +extern int Denominator,DP_Multiple,MaxDeg; + #define BLEN (8*sizeof(unsigned long)) typedef struct matrix { @@ -168,6 +174,8 @@ INLINE int nd_length(ND p) } } +extern int dp_negative_weight; + INLINE int ndl_reducible(UINT *d1,UINT *d2) { UINT u1,u2; @@ -175,7 +183,7 @@ INLINE int ndl_reducible(UINT *d1,UINT *d2) if ( nd_module && (MPOS(d1) != MPOS(d2)) ) return 0; - if ( TD(d1) < TD(d2) ) return 0; + if ( !dp_negative_weight && TD(d1) < TD(d2) ) return 0; #if USE_UNROLL switch ( nd_bpe ) { case 3: @@ -454,6 +462,22 @@ int ndl_weight(UINT *d) return t; } +/* for sugarweight */ + +int ndl_weight2(UINT *d) +{ + int t,u; + int i,j; + + for ( i = 0, t = 0; i < nd_nvar; i++ ) { + u = GET_EXP(d,i); + t += nd_sugarweight[i]*u; + } + if ( nd_module && current_module_weight_vector && MPOS(d) ) + t += current_module_weight_vector[MPOS(d)]; + return t; +} + void ndl_weight_mask(UINT *d) { UINT t,u; @@ -644,10 +668,28 @@ int ndl_ww_lex_compare(UINT *d1,UINT *d2) return ndl_lex_compare(d1,d2); } +int ndl_module_weight_compare(UINT *d1,UINT *d2) +{ + int s,j; + + if ( nd_nvar != nd_poly_weight_len ) + error("invalid module weight : the length of polynomial weight != the number of variables"); + s = 0; + for ( j = 0; j < nd_nvar; j++ ) + s += (GET_EXP(d1,j)-GET_EXP(d2,j))*nd_poly_weight[j]; + if ( MPOS(d1) >= 1 && MPOS(d2) >= 1 ) { + s += nd_module_weight[MPOS(d1)-1]-nd_module_weight[MPOS(d2)-1]; + } + if ( s > 0 ) return 1; + else if ( s < 0 ) return -1; + else return 0; +} + int ndl_module_grlex_compare(UINT *d1,UINT *d2) { int i,c; + if ( nd_module_rank && (c = ndl_module_weight_compare(d1,d2)) ) return 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; @@ -674,6 +716,7 @@ int ndl_module_glex_compare(UINT *d1,UINT *d2) { int i,c; + if ( nd_module_rank && (c = ndl_module_weight_compare(d1,d2)) ) return c; if ( nd_ispot ) { if ( MPOS(d1) < MPOS(d2) ) return 1; else if ( MPOS(d1) > MPOS(d2) ) return -1; @@ -692,6 +735,7 @@ int ndl_module_lex_compare(UINT *d1,UINT *d2) { int i,c; + if ( nd_module_rank && (c = ndl_module_weight_compare(d1,d2)) ) return c; if ( nd_ispot ) { if ( MPOS(d1) < MPOS(d2) ) return 1; else if ( MPOS(d1) > MPOS(d2) ) return -1; @@ -708,6 +752,7 @@ int ndl_module_block_compare(UINT *d1,UINT *d2) { int i,c; + if ( nd_module_rank && (c = ndl_module_weight_compare(d1,d2)) ) return c; if ( nd_ispot ) { if ( MPOS(d1) < MPOS(d2) ) return 1; else if ( MPOS(d1) > MPOS(d2) ) return -1; @@ -724,6 +769,7 @@ int ndl_module_matrix_compare(UINT *d1,UINT *d2) { int i,c; + if ( nd_module_rank && (c = ndl_module_weight_compare(d1,d2)) ) return c; if ( nd_ispot ) { if ( MPOS(d1) < MPOS(d2) ) return 1; else if ( MPOS(d1) > MPOS(d2) ) return -1; @@ -740,6 +786,7 @@ int ndl_module_composite_compare(UINT *d1,UINT *d2) { int i,c; + if ( nd_module_rank && (c = ndl_module_weight_compare(d1,d2)) ) return c; if ( nd_ispot ) { if ( MPOS(d1) > MPOS(d2) ) return 1; else if ( MPOS(d1) < MPOS(d2) ) return -1; @@ -1977,6 +2024,7 @@ NODE nd_gb(int m,int ishomo,int checkonly,int gensyz,i while ( d ) { again: l = nd_minp(d,&d); + if ( MaxDeg > 0 && SG(l) > MaxDeg ) break; if ( SG(l) != sugar ) { if ( ishomo ) { diag_count = 0; @@ -2235,6 +2283,7 @@ NODE nd_gb_trace(int m,int ishomo,int **indp) while ( d ) { again: l = nd_minp(d,&d); + if ( MaxDeg > 0 && SG(l) > MaxDeg ) break; if ( SG(l) != sugar ) { #if 1 if ( ishomo ) { @@ -2332,9 +2381,11 @@ again: FREENDP(l); } if ( nd_nalg ) { - print_eg("monic",&eg_monic); - print_eg("invdalg",&eg_invdalg); - print_eg("le",&eg_le); + if ( DP_Print ) { + print_eg("monic",&eg_monic); + print_eg("invdalg",&eg_invdalg); + print_eg("le",&eg_le); + } } conv_ilist(nd_demand,1,g,indp); if ( DP_Print ) { printf("nd_gb_trace done.\n"); fflush(stdout); } @@ -2500,11 +2551,38 @@ ND_pairs nd_newpairs( NODE g, int t ) ndl_lcm(DL(nd_psh[r->i1]),dl,r->lcm); s = SG(nd_psh[r->i1])-TD(DL(nd_psh[r->i1])); SG(r) = MAX(s,ts) + TD(LCM(r)); + /* experimental */ + if ( nd_sugarweight ) + r->sugar2 = ndl_weight2(r->lcm); } if ( r0 ) NEXT(r) = 0; return r0; } +/* ipair = [i1,i2],[i1,i2],... */ +ND_pairs nd_ipairtospair(NODE ipair) +{ + int s1,s2; + NODE tn,t; + ND_pairs r,r0; + + for ( r0 = 0, t = ipair; t; t = NEXT(t) ) { + NEXTND_pairs(r0,r); + tn = BDY((LIST)BDY(t)); + r->i1 = QTOS((Q)ARG0(tn)); + r->i2 = QTOS((Q)ARG1(tn)); + ndl_lcm(DL(nd_psh[r->i1]),DL(nd_psh[r->i2]),r->lcm); + s1 = SG(nd_psh[r->i1])-TD(DL(nd_psh[r->i1])); + s2 = SG(nd_psh[r->i2])-TD(DL(nd_psh[r->i2])); + SG(r) = MAX(s1,s2) + TD(LCM(r)); + /* experimental */ + if ( nd_sugarweight ) + r->sugar2 = ndl_weight2(r->lcm); + } + if ( r0 ) NEXT(r) = 0; + return r0; +} + /* kokokara */ ND_pairs crit_B( ND_pairs d, int s ) @@ -2685,13 +2763,22 @@ ND_pairs nd_minp( ND_pairs d, ND_pairs *prest ) NEXT(m) = 0; return m; } - s = SG(m); if ( !NoSugar ) { - for ( ml = 0, l = m; p; p = NEXT(l = p) ) - if ( (SG(p) < s) - || ((SG(p) == s) && (DL_COMPARE(LCM(p),LCM(m)) < 0)) ) { - ml = l; m = p; s = SG(m); - } + if ( nd_sugarweight ) { + s = m->sugar2; + for ( ml = 0, l = m; p; p = NEXT(l = p) ) + if ( (p->sugar2 < s) + || ((p->sugar2 == s) && (DL_COMPARE(LCM(p),LCM(m)) < 0)) ) { + ml = l; m = p; s = m->sugar2; + } + } else { + s = SG(m); + for ( ml = 0, l = m; p; p = NEXT(l = p) ) + if ( (SG(p) < s) + || ((SG(p) == s) && (DL_COMPARE(LCM(p),LCM(m)) < 0)) ) { + ml = l; m = p; s = SG(m); + } + } } else { for ( ml = 0, l = m; p; p = NEXT(l = p) ) if ( DL_COMPARE(LCM(p),LCM(m)) < 0 ) { @@ -2712,20 +2799,37 @@ ND_pairs nd_minsugarp( ND_pairs d, ND_pairs *prest ) int msugar,i; ND_pairs t,dm0,dm,dr0,dr; - for ( msugar = SG(d), t = NEXT(d); t; t = NEXT(t) ) - if ( SG(t) < msugar ) msugar = SG(t); - dm0 = 0; dr0 = 0; - for ( i = 0, t = d; t; t = NEXT(t) ) - if ( i < nd_f4_nsp && SG(t) == msugar ) { - if ( dm0 ) NEXT(dm) = t; - else dm0 = t; - dm = t; - i++; - } else { - if ( dr0 ) NEXT(dr) = t; - else dr0 = t; - dr = t; - } + if ( nd_sugarweight ) { + for ( msugar = d->sugar2, t = NEXT(d); t; t = NEXT(t) ) + if ( t->sugar2 < msugar ) msugar = t->sugar2; + dm0 = 0; dr0 = 0; + for ( i = 0, t = d; t; t = NEXT(t) ) + if ( i < nd_f4_nsp && t->sugar2 == msugar ) { + if ( dm0 ) NEXT(dm) = t; + else dm0 = t; + dm = t; + i++; + } else { + if ( dr0 ) NEXT(dr) = t; + else dr0 = t; + dr = t; + } + } else { + for ( msugar = SG(d), t = NEXT(d); t; t = NEXT(t) ) + if ( SG(t) < msugar ) msugar = SG(t); + dm0 = 0; dr0 = 0; + for ( i = 0, t = d; t; t = NEXT(t) ) + if ( i < nd_f4_nsp && SG(t) == msugar ) { + if ( dm0 ) NEXT(dm) = t; + else dm0 = t; + dm = t; + i++; + } else { + if ( dr0 ) NEXT(dr) = t; + else dr0 = t; + dr = t; + } + } NEXT(dm) = 0; if ( dr0 ) NEXT(dr) = 0; *prest = dr0; @@ -3020,6 +3124,8 @@ 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); + 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++ ); switch ( ord->id ) { case 1: @@ -3534,6 +3640,7 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,int for ( t = fd0; t; t = NEXT(t) ) ndv_homogenize((NDV)BDY(t),obpe,oadv,oepos,ompos); } + if ( MaxDeg > 0 ) nocheck = 1; while ( 1 ) { tl1 = tl2 = tl3 = tl4 = 0; if ( Demand ) @@ -5246,7 +5353,16 @@ NODE ndv_reducebase(NODE x,int *perm) void nd_init_ord(struct order_spec *ord) { - nd_module = (ord->id >= 256); + nd_module = (ord->id >= 256); + if ( nd_module ) { + nd_dcomp = -1; + nd_ispot = ord->ispot; + nd_pot_nelim = ord->pot_nelim; + nd_poly_weight_len = ord->nv; + nd_poly_weight = ord->top_weight; + nd_module_rank = ord->module_rank; + nd_module_weight = ord->module_top_weight; + } nd_matrix = 0; nd_matrix_len = 0; switch ( ord->id ) { @@ -5302,9 +5418,6 @@ 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: nd_isrlex = 1; @@ -5324,17 +5437,11 @@ 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; @@ -5342,9 +5449,6 @@ void nd_init_ord(struct order_spec *ord) 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; @@ -6150,7 +6254,7 @@ NODE nd_f4(int m,int **indp) ND spol,red; NDV nf,redv; NM s0,s; - NODE rp0,srp0,nflist,nzlist; + NODE rp0,srp0,nflist,nzlist,nzlist_t; int nsp,nred,col,rank,len,k,j,a,i1s,i2s; UINT c; UINT **spmat; @@ -6168,42 +6272,36 @@ NODE nd_f4(int m,int **indp) #endif g = 0; d = 0; for ( i = 0; i < nd_psn; i++ ) { - d = update_pairs(d,g,i,0); + if ( !nd_nzlist ) d = update_pairs(d,g,i,0); g = update_base(g,i); } nzlist = 0; - while ( d ) { + nzlist_t = nd_nzlist; + while ( d || nzlist_t ) { get_eg(&eg0); - l = nd_minsugarp(d,&d); - sugar = SG(l); if ( nd_nzlist ) { - for ( tn = nd_nzlist; tn; tn = NEXT(tn) ) { - node = BDY((LIST)BDY(tn)); - if ( QTOS((Q)ARG0(node)) == sugar ) break; + node = BDY((LIST)BDY(nzlist_t)); + sugar = ARG0(node); + tn = BDY((LIST)ARG1(node)); + if ( !tn ) { + nzlist_t = NEXT(nzlist_t); + continue; } - if ( tn ) { - for ( t = l, ll0 = 0; t; t = NEXT(t) ) { - for ( tn = BDY((LIST)ARG1(node)); tn; tn = NEXT(tn) ) { - i1s = QTOS((Q)ARG0(BDY((LIST)BDY(tn)))); - i2s = QTOS((Q)ARG1(BDY((LIST)BDY(tn)))); - if ( t->i1 == i1s && t->i2 == i2s ) break; - } - if ( tn ) { - if ( !ll0 ) ll0 = t; - else NEXT(ll) = t; - ll = t; - } - } - if ( ll0 ) NEXT(ll) = 0; - l = ll0; - } else l = 0; + /* tn = [[i1,i2],...] */ + l = nd_ipairtospair(tn); + } else { + l = nd_minsugarp(d,&d); + sugar = nd_sugarweight?l->sugar2:SG(l); + if ( MaxDeg > 0 && sugar > MaxDeg ) break; } 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(0,d); + if ( !nd_nzlist ) { + for ( t = l; NEXT(t); t = NEXT(t) ); + NEXT(t) = d; d = l; + d = nd_reconstruct(0,d); + } continue; } if ( bucket->m < 0 ) continue; @@ -6232,7 +6330,7 @@ NODE nd_f4(int m,int **indp) nf = ndtondv(m,nf1); } nh = ndv_newps(m,nf,0,1); - d = update_pairs(d,g,nh,0); + if ( !nd_nzlist ) d = update_pairs(d,g,nh,0); g = update_base(g,nh); } if ( nd_gentrace ) { @@ -6246,6 +6344,7 @@ NODE nd_f4(int m,int **indp) STOQ(sugar,sugarq); node = mknode(2,sugarq,l0); MKLIST(l1,node); MKNODE(node,l1,nzlist); nzlist = node; } + if ( nd_nzlist ) nzlist_t = NEXT(nzlist_t); } if ( nd_gentrace ) { MKLIST(l0,reverse_node(nzlist)); @@ -6288,6 +6387,7 @@ NODE nd_f4_trace(int m,int **indp) get_eg(&eg0); l = nd_minsugarp(d,&d); sugar = SG(l); + if ( MaxDeg > 0 && sugar > MaxDeg ) break; bucket = create_pbucket(); stat = nd_sp_f4(m,0,l,bucket); if ( !stat ) { @@ -6597,7 +6697,9 @@ init_eg(&eg_search); } } mat->row = i; - fprintf(asir_out,"%dx%d,",mat->row,mat->col); fflush(asir_out); + if ( DP_Print ) { + fprintf(asir_out,"%dx%d,",mat->row,mat->col); fflush(asir_out); + } size = ((col+BLEN-1)/BLEN)*sizeof(unsigned long); v = CALLOC((col+BLEN-1)/BLEN,sizeof(unsigned long)); for ( rp = rp0, i = 0; rp; rp = NEXT(rp), i++ ) { @@ -6651,7 +6753,9 @@ init_eg(&eg_search); for ( i = 0; i < col; i++ ) rhead[i] = 0; /* construction of index arrays */ - fprintf(stderr,"%dx%d,",nsp+nred,col); + if ( DP_Print ) { + fprintf(stderr,"%dx%d,",nsp+nred,col); + } rvect = (NM_ind_pair *)ALLOCA(nred*sizeof(NM_ind_pair)); s0hash = (int *)ALLOCA(col*sizeof(int)); for ( i = 0, s = s0vect; i < col; i++, s += nd_wpd ) @@ -6665,7 +6769,7 @@ init_eg(&eg_search); r0 = nd_f4_red_main(m,sp0,nsp,s0vect,col,rvect,rhead,imat,nred,nz); else r0 = nd_f4_red_gz_main(sp0,nsp,trace,s0vect,col,rvect,rhead,imat,nred); -print_eg("search",&eg_search); + if ( DP_Print ) print_eg("search",&eg_search); return r0; } @@ -7638,7 +7742,9 @@ void nd_det(int mod,MAT f,P *rp) if ( mod ) ndv_mod(mod,d); chsgnq(ONE,&mone); for ( j = 0, sgn = 1; j < n; j++ ) { - if ( DP_Print ) fprintf(stderr,".",j); + if ( DP_Print ) { + fprintf(stderr,".",j); + } for ( i = j; i < n && !dm[i][j]; i++ ); if ( i == n ) { *rp = 0; @@ -7697,7 +7803,9 @@ void nd_det(int mod,MAT f,P *rp) } d = mjj; } - if ( DP_Print ) fprintf(stderr,"\n",k); + if ( DP_Print ) { + fprintf(stderr,"\n",k); + } if ( sgn < 0 ) if ( mod ) ndv_mul_c(mod,d,mod-1); @@ -8018,13 +8126,15 @@ void conv_ilist(int demand,int trace,NODE g,int **indp void parse_nd_option(NODE opt) { NODE t,p,u; - int i,s; + int i,s,n; char *key; Obj value; nd_gentrace = 0; nd_gensyz = 0; nd_nora = 0; nd_gbblock = 0; nd_newelim = 0; nd_intersect = 0; nd_nzlist = 0; nd_splist = 0; nd_check_splist = 0; + nd_sugarweight = 0; + for ( t = opt; t; t = NEXT(t) ) { p = BDY((LIST)BDY(t)); key = BDY((STRING)BDY(p)); @@ -8058,6 +8168,13 @@ void parse_nd_option(NODE opt) nd_splist = value?1:0; else if ( !strcmp(key,"check_splist") ) { nd_check_splist = BDY((LIST)value); + } else if ( !strcmp(key,"sugarweight") ) { + nd_sugarweight = BDY((LIST)value); + u = BDY((LIST)value); + n = length(u); + nd_sugarweight = MALLOC(n*sizeof(int)); + for ( i = 0; i < n; i++, u = NEXT(u) ) + nd_sugarweight[i] = QTOS((Q)BDY(u)); } } }