=================================================================== RCS file: /home/cvs/OpenXM_contrib2/asir2000/engine/nd.c,v retrieving revision 1.126 retrieving revision 1.132 diff -u -p -r1.126 -r1.132 --- OpenXM_contrib2/asir2000/engine/nd.c 2005/02/09 14:30:47 1.126 +++ OpenXM_contrib2/asir2000/engine/nd.c 2006/06/05 01:29:24 1.132 @@ -1,7 +1,8 @@ -/* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.125 2005/02/09 08:32:32 noro Exp $ */ +/* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.131 2006/06/05 01:01:41 noro Exp $ */ #include "nd.h" +int diag_period = 6; int (*ndl_compare_function)(UINT *a1,UINT *a2); int nd_dcomp; NM _nm_free_list; @@ -47,6 +48,7 @@ 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); int nd_monic(int m,ND *p); +NDV plain_vect_to_ndv_q(Q *mat,int col,UINT *s0vect); void nd_free_private_storage() { @@ -1284,7 +1286,7 @@ int ndv_check_candidate(NODE input,int obpe,int oadv,E NODE t,s; union oNDC dn; - ndv_setup(0,0,cand); + ndv_setup(0,0,cand,0); n = length(cand); /* membercheck : list is a subset of Id(cand) ? */ @@ -1718,6 +1720,7 @@ NODE nd_gb_trace(int m,int ishomo) Q q,den,num; union oNDC dn; struct oEGT eg_monic,egm0,egm1; + int diag_count = 0; init_eg(&eg_monic); init_eg(&eg_invdalg); @@ -1732,14 +1735,17 @@ NODE nd_gb_trace(int m,int ishomo) again: l = nd_minp(d,&d); if ( SG(l) != sugar ) { +#if 1 if ( ishomo ) { stat = do_diagonalize_trace(sugar,m); + diag_count = 0; if ( !stat ) { NEXT(l) = d; d = l; d = nd_reconstruct(1,d); goto again; } } +#endif sugar = SG(l); if ( DP_Print ) fprintf(asir_out,"%d",sugar); } @@ -1788,6 +1794,15 @@ again: nd_removecont(m,nf); nfv = ndtondv(m,nf); nd_free(nf); } nh = ndv_newps(0,nfv,nfqv); + if ( ishomo && ++diag_count == diag_period ) { + diag_count = 0; + stat = do_diagonalize_trace(sugar,m); + if ( !stat ) { + NEXT(l) = d; d = l; + d = nd_reconstruct(1,d); + goto again; + } + } d = update_pairs(d,g,nh); g = update_base(g,nh); } else { @@ -1839,7 +1854,7 @@ NODE ndv_reduceall(int m,NODE f) (int (*)(const void *,const void *))ndv_compare); for ( t = f, i = 0; t; i++, t = NEXT(t) ) BDY(t) = (pointer)w[i]; #endif - ndv_setup(m,0,f); + ndv_setup(m,0,f,0); for ( i = 0; i < n; ) { g = ndvtond(m,nd_ps[i]); g = nd_separate_head(g,&head); @@ -2179,7 +2194,7 @@ int ndv_newps(int m,NDV a,NDV aq) return nd_psn++; } -void ndv_setup(int mod,int trace,NODE f) +void ndv_setup(int mod,int trace,NODE f,int dont_sort) { int i,j,td,len,max; NODE s,s0,f0; @@ -2193,8 +2208,9 @@ void ndv_setup(int mod,int trace,NODE f) for ( nd_psn = 0, s = f; s; s = NEXT(s) ) if ( BDY(s) ) nd_psn++; w = (NDV *)ALLOCA(nd_psn*sizeof(NDV)); for ( i = 0, s = f; s; s = NEXT(s) ) if ( BDY(s) ) w[i++] = BDY(s); - qsort(w,nd_psn,sizeof(NDV), - (int (*)(const void *,const void *))ndv_compare); + if ( !dont_sort ) + qsort(w,nd_psn,sizeof(NDV), + (int (*)(const void *,const void *))ndv_compare); nd_pslen = 2*nd_psn; nd_ps = (NDV *)MALLOC(nd_pslen*sizeof(NDV)); nd_ps_trace = (NDV *)MALLOC(nd_pslen*sizeof(NDV)); @@ -2396,7 +2412,7 @@ void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe if ( b ) { NEXTNODE(fd0,fd); BDY(fd) = (pointer)b; } } if ( fd0 ) NEXT(fd) = 0; - ndv_setup(m,0,fd0); + ndv_setup(m,0,fd0,0); x = f4?nd_f4(m):nd_gb(m,ishomo,0); nd_demand = 0; x = ndv_reducebase(x); @@ -2414,6 +2430,86 @@ void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe #endif } +void nd_gr_postproc(LIST f,LIST v,int m,struct order_spec *ord,int do_check,LIST *rp) +{ + VL tv,fv,vv,vc,av; + NODE fd,fd0,r,r0,t,x,s,xx,alist; + int e,max,nvar,i; + NDV b; + int ishomo,nalg; + Alg alpha,dp; + P p; + LIST f1,f2; + Obj obj; + NumberField nf; + struct order_spec *ord1; + + get_vars((Obj)f,&fv); pltovl(v,&vv); + for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ ); + switch ( ord->id ) { + case 1: + if ( ord->nv != nvar ) + error("nd_check : invalid order specification"); + break; + default: + break; + } + nd_nalg = 0; + av = 0; + if ( !m ) { + get_algtree((Obj)f,&av); + for ( nalg = 0, tv = av; tv; tv = NEXT(tv), nalg++ ); + nd_ntrans = nvar; + nd_nalg = nalg; + /* #i -> t#i */ + if ( nalg ) { + preprocess_algcoef(vv,av,ord,f,&ord1,&f1,&alist); + ord = ord1; + f = f1; + } + nvar += nalg; + } + nd_init_ord(ord); + for ( t = BDY(f), max = 0; t; t = NEXT(t) ) + for ( tv = vv; tv; tv = NEXT(tv) ) { + e = getdeg(tv->v,(P)BDY(t)); + max = MAX(e,max); + } + nd_setup_parameters(nvar,max); + ishomo = 1; + for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) { + b = (pointer)ptondv(CO,vv,(P)BDY(t)); + if ( ishomo ) + ishomo = ishomo && ndv_ishomo(b); + if ( m ) ndv_mod(m,b); + if ( b ) { NEXTNODE(fd0,fd); BDY(fd) = (pointer)b; } + } + if ( fd0 ) NEXT(fd) = 0; + ndv_setup(m,0,fd0,0); + for ( x = 0, i = 0; i < nd_psn; i++ ) + x = update_base(x,i); + if ( do_check ) { + x = nd_gb(m,ishomo,1); + if ( !x ) { + *rp = 0; + return; + } + } else { + for ( t = x; t; t = NEXT(t) ) + BDY(t) = (pointer)nd_ps[(int)BDY(t)]; + } + x = ndv_reducebase(x); + x = ndv_reduceall(m,x); + for ( r0 = 0, t = x; t; t = NEXT(t) ) { + NEXTNODE(r0,r); + BDY(r) = ndvtop(m,CO,vv,BDY(t)); + } + if ( r0 ) NEXT(r) = 0; + if ( nalg ) + r0 = postprocess_algcoef(av,alist,r0); + MKLIST(*rp,r0); +} + void nd_gr_trace(LIST f,LIST v,int trace,int homo,struct order_spec *ord,LIST *rp) { VL tv,fv,vv,vc,av; @@ -2501,7 +2597,7 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru while ( 1 ) { if ( Demand ) nd_demand = 1; - ndv_setup(m,1,fd0); + ndv_setup(m,1,fd0,0); cand = nd_gb_trace(m,ishomo || homo); if ( !cand ) { /* failure */ @@ -3952,7 +4048,8 @@ void nd_nf_p(P f,LIST g,LIST v,int m,struct order_spec if ( m ) ndv_mod(m,(NDV)BDY(in)); NEXT(in) = 0; - ndv_setup(m,0,in0); + /* dont sort */ + ndv_setup(m,0,in0,1); nd_psn--; nd_scale=2; while ( 1 ) { @@ -4000,6 +4097,29 @@ int nd_to_vect_q(UINT *s0,int n,ND d,Q *r) return i; } +Q *nm_ind_pair_to_vect(int mod,UINT *s0,int n,NM_ind_pair pair) +{ + NM m; + NMV mr; + UINT *d,*t,*s; + NDV p; + int i,j,len; + Q *r; + + m = pair->mul; + d = DL(m); + p = nd_ps[pair->index]; + len = LEN(p); + r = (Q *)CALLOC(n,sizeof(Q)); + t = (UINT *)ALLOCA(nd_wpd*sizeof(UINT)); + for ( i = j = 0, s = s0, mr = BDY(p); j < len; j++, NMV_ADV(mr) ) { + ndl_add(d,DL(mr),t); + for ( ; !ndl_equal(t,s); s += nd_wpd, i++ ); + r[i] = CQ(mr); + } + return r; +} + IndArray nm_ind_pair_to_vect_compress(int mod,UINT *s0,int n,NM_ind_pair pair) { NM m; @@ -4245,6 +4365,8 @@ NDV vect_to_ndv(UINT *vect,int spcol,int col,int *rhea } } +/* for preprocessed vector */ + NDV vect_to_ndv_q(Q *vect,int spcol,int col,int *rhead,UINT *s0vect) { int j,k,len; @@ -4275,6 +4397,36 @@ NDV vect_to_ndv_q(Q *vect,int spcol,int col,int *rhead } } +/* for plain vector */ + +NDV plain_vect_to_ndv_q(Q *vect,int col,UINT *s0vect) +{ + int j,k,len; + UINT *p; + Q c; + NDV r; + NMV mr0,mr; + + for ( j = 0, len = 0; j < col; j++ ) if ( vect[j] ) len++; + if ( !len ) return 0; + else { + mr0 = (NMV)GC_malloc(nmv_adv*len); +#if 0 + ndv_alloc += nmv_adv*len; +#endif + mr = mr0; + p = s0vect; + for ( j = k = 0; j < col; j++, p += nd_wpd, k++ ) + if ( c = vect[k] ) { + if ( DN(c) ) + error("afo"); + ndl_copy(p,DL(mr)); CQ(mr) = c; NMV_ADV(mr); + } + MKNDV(nd_nvar,mr0,len,r); + return r; + } +} + int nd_sp_f4(int m,ND_pairs l,PGeoBucket bucket) { ND_pairs t; @@ -4394,6 +4546,14 @@ NODE nd_f4(int m) for ( r = nflist; r; r = NEXT(r) ) { nf = (NDV)BDY(r); ndv_removecont(m,nf); + if ( !m && nd_nalg ) { + ND nf1; + + nf1 = ndvtond(m,nf); + nd_monic(0,&nf1); + nd_removecont(m,nf1); + nf = ndtondv(m,nf1); + } nh = ndv_newps(m,nf,0); d = update_pairs(d,g,nh); g = update_base(g,nh); @@ -4508,6 +4668,7 @@ NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s return r0; } +#if 0 NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vect,int col, NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred) { @@ -4575,6 +4736,64 @@ NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vec } return r0; } +#else +void printm(Q **mat,int row,int col) +{ + int i,j; + printf("["); + for ( i = 0; i < row; i++ ) { + for ( j = 0; j < col; j++ ) { + printexpr(CO,mat[i][j]); printf(" "); + } + printf("]\n"); + } +} + +NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vect,int col, + NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred) +{ + int row,a; + int i,j,rank; + NODE r0,r; + ND_pairs sp; + ND spol; + Q **mat; + int *colstat; + int *sugar; + + row = nsp+nred; + /* make the matrix */ + mat = (Q **)ALLOCA(row*sizeof(Q *)); + sugar = (int *)ALLOCA(row*sizeof(int)); + for ( row = a = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) { + nd_sp(0,0,sp,&spol); + if ( !spol ) continue; + mat[row] = (Q *)MALLOC(col*sizeof(Q)); + nd_to_vect_q(s0vect,col,spol,mat[row]); + sugar[row] = SG(spol); + row++; + } + for ( i = 0; i < nred; i++, row++ ) { + mat[row] = nm_ind_pair_to_vect(0,s0vect,col,rvect[i]); + sugar[row] = rvect[i]->sugar; + } + /* elimination */ + colstat = (int *)ALLOCA(col*sizeof(int)); + rank = nd_gauss_elim_q(mat,sugar,row,col,colstat); + r0 = 0; + for ( i = 0; i < rank; i++ ) { + for ( j = 0; j < col; j++ ) if ( mat[i][j] ) break; + if ( j == col ) error("nd_f4_red_q_main : cannot happen"); + if ( rhead[j] ) continue; + NEXTNODE(r0,r); BDY(r) = + (pointer)plain_vect_to_ndv_q(mat[i],col,s0vect); + SG((NDV)BDY(r)) = sugar[i]; + } + if ( r0 ) NEXT(r) = 0; + printf("\n"); + return r0; +} +#endif FILE *nd_write,*nd_read;