=================================================================== RCS file: /home/cvs/OpenXM_contrib2/asir2000/engine/nd.c,v retrieving revision 1.75 retrieving revision 1.95 diff -u -p -r1.75 -r1.95 --- OpenXM_contrib2/asir2000/engine/nd.c 2003/09/19 10:09:42 1.75 +++ OpenXM_contrib2/asir2000/engine/nd.c 2004/03/15 08:44:52 1.95 @@ -1,123 +1,19 @@ -/* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.74 2003/09/19 02:33:12 noro Exp $ */ +/* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.94 2004/03/15 07:30:44 noro Exp $ */ -#include "ca.h" -#include "parse.h" -#include "ox.h" -#include "inline.h" -#include +#include "nd.h" -#if defined(__GNUC__) -#define INLINE inline -#elif defined(VISUAL) -#define INLINE __inline -#else -#define INLINE -#endif - -typedef unsigned int UINT; - -#define USE_GEOBUCKET 1 -#define USE_UNROLL 1 - -#define REDTAB_LEN 32003 - -/* GeoBucket for polynomial addition */ - -typedef struct oPGeoBucket { - int m; - struct oND *body[32]; -} *PGeoBucket; - -/* distributed polynomial; linked list rep. */ -typedef struct oND { - struct oNM *body; - int nv; - int len; - int sugar; -} *ND; - -/* distributed polynomial; array rep. */ -typedef struct oNDV { - struct oNMV *body; - int nv; - int len; - int sugar; -} *NDV; - -typedef union oNDC { - int m; - Q z; - P p; -} *NDC; - -/* monomial; linked list rep. */ -typedef struct oNM { - struct oNM *next; - union oNDC c; - UINT dl[1]; -} *NM; - -/* monomial; array rep. */ -typedef struct oNMV { - union oNDC c; - UINT dl[1]; -} *NMV; - -/* history of reducer */ -typedef struct oRHist { - struct oRHist *next; - int index; - int sugar; - UINT dl[1]; -} *RHist; - -/* S-pair list */ -typedef struct oND_pairs { - struct oND_pairs *next; - int i1,i2; - int sugar; - UINT lcm[1]; -} *ND_pairs; - -/* index and shift count for each exponent */ -typedef struct oEPOS { - int i; /* index */ - int s; /* shift */ -} *EPOS; - -typedef struct oBlockMask { - int n; - struct order_pair *order_pair; - UINT **mask; -} *BlockMask; - -typedef struct oBaseSet { - int len; - NDV *ps; - UINT **bound; -} *BaseSet; - -typedef struct oNM_ind_pair -{ - NM mul; - int index; -} *NM_ind_pair; - -typedef struct oIndArray -{ - char width; - int head; - union { - unsigned char *c; - unsigned short *s; - unsigned int *i; - } index; -} *IndArray; - int (*ndl_compare_function)(UINT *a1,UINT *a2); +int nd_dcomp; +NM _nm_free_list; +ND _nd_free_list; +ND_pairs _ndp_free_list; static int ndv_alloc; +#if 1 static int nd_f4_nsp=0x7fffffff; +#else +static int nd_f4_nsp=50; +#endif static double nd_scale=2; static UINT **nd_bound; static struct order_spec *nd_ord; @@ -129,10 +25,6 @@ static int nd_epw,nd_bpe,nd_wpd,nd_exporigin; static UINT nd_mask[32]; static UINT nd_mask0,nd_mask1; -static NM _nm_free_list; -static ND _nd_free_list; -static ND_pairs _ndp_free_list; - static NDV *nd_ps; static NDV *nd_ps_trace; static RHist *nd_psh; @@ -141,233 +33,9 @@ static int nd_psn,nd_pslen; static RHist *nd_red; static int nd_found,nd_create,nd_notfirst; -static int nm_adv; static int nmv_adv; -static int nd_dcomp; +static int nd_demand; -extern struct order_spec dp_current_spec; -extern VL CO; -extern int Top,Reverse,DP_Print,dp_nelim,do_weyl; -extern int *current_weyl_weight_vector; - -/* fundamental macros */ -#define TD(d) (d[0]) -#define HDL(d) ((d)->body->dl) -#define HTD(d) (TD(HDL(d))) -#define HCM(d) ((d)->body->c.m) -#define HCQ(d) ((d)->body->c.z) -#define HCP(d) ((d)->body->c.p) -#define CM(a) ((a)->c.m) -#define CQ(a) ((a)->c.z) -#define CP(a) ((a)->c.p) -#define DL(a) ((a)->dl) -#define SG(a) ((a)->sugar) -#define LEN(a) ((a)->len) -#define LCM(a) ((a)->lcm) -#define GET_EXP(d,a) (((d)[nd_epos[a].i]>>nd_epos[a].s)&nd_mask0) -#define GET_EXP_MASK(d,a,m) ((((d)[nd_epos[a].i]&(m)[nd_epos[a].i])>>nd_epos[a].s)&nd_mask0) -#define PUT_EXP(r,a,e) ((r)[nd_epos[a].i] |= ((e)<>oepos[a].s)&omask0) -#define PUT_EXP_OLD(r,a,e) ((r)[oepos[a].i] |= ((e)<TD(d2)?1:(TD(d1)0?TD_DL_COMPARE(d1,d2)\ - :(nd_dcomp==0?ndl_lex_compare(d1,d2)\ - :(nd_blockmask?ndl_block_compare(d1,d2)\ - :(*ndl_compare_function)(d1,d2)))) -#else -#define DL_COMPARE(d1,d2)\ -(nd_dcomp>0?TD_DL_COMPARE(d1,d2):(*ndl_compare_function)(d1,d2)) -#endif - -/* allocators */ -#define NEWRHist(r) \ -((r)=(RHist)MALLOC(sizeof(struct oRHist)+(nd_wpd-1)*sizeof(UINT))) -#define NEWND_pairs(m) \ -if(!_ndp_free_list)_NDP_alloc();\ -(m)=_ndp_free_list; _ndp_free_list = NEXT(_ndp_free_list) -#define NEWNM(m)\ -if(!_nm_free_list)_NM_alloc();\ -(m)=_nm_free_list; _nm_free_list = NEXT(_nm_free_list) -#define MKND(n,m,len,d)\ -if(!_nd_free_list)_ND_alloc();\ -(d)=_nd_free_list; _nd_free_list = (ND)BDY(_nd_free_list);\ -NV(d)=(n); LEN(d)=(len); BDY(d)=(m) -#define NEWNDV(d) ((d)=(NDV)MALLOC(sizeof(struct oNDV))) -#define MKNDV(n,m,l,d) NEWNDV(d); NV(d)=(n); BDY(d)=(m); LEN(d) = l; -#define NEWNM_ind_pair(p)\ -((p)=(NM_ind_pair)MALLOC(sizeof(struct oNM_ind_pair))) - -/* allocate and link a new object */ -#define NEXTRHist(r,c) \ -if(!(r)){NEWRHist(r);(c)=(r);}else{NEWRHist(NEXT(c));(c)=NEXT(c);} -#define NEXTNM(r,c) \ -if(!(r)){NEWNM(r);(c)=(r);}else{NEWNM(NEXT(c));(c)=NEXT(c);} -#define NEXTNM2(r,c,s) \ -if(!(r)){(c)=(r)=(s);}else{NEXT(c)=(s);(c)=(s);} -#define NEXTND_pairs(r,c) \ -if(!(r)){NEWND_pairs(r);(c)=(r);}else{NEWND_pairs(NEXT(c));(c)=NEXT(c);} -#define MKNM_ind_pair(p,m,i) (NEWNM_ind_pair(p),(p)->mul=(m),(p)->index=(i)) - -/* deallocators */ -#define FREENM(m) NEXT(m)=_nm_free_list; _nm_free_list=(m) -#define FREENDP(m) NEXT(m)=_ndp_free_list; _ndp_free_list=(m) -#define FREEND(m) BDY(m)=(NM)_nd_free_list; _nd_free_list=(m) - -/* macro for increasing pointer to NMV */ -#define NMV_ADV(m) (m = (NMV)(((char *)m)+nmv_adv)) -#define NMV_OADV(m) (m = (NMV)(((char *)m)+oadv)) -#define NDV_NADV(m) (m = (NMV)(((char *)m)+newadv)) -#define NMV_PREV(m) (m = (NMV)(((char *)m)-nmv_adv)) -#define NMV_OPREV(m) (m = (NMV)(((char *)m)-oadv)) - -/* external functions */ -#if 1 -void GC_gcollect(); -#endif -NODE append_one(NODE,int); - -/* manipulation of coefficients */ -void nd_removecont(int mod,ND p); -void nd_removecont2(ND p1,ND p2); -void removecont_array(Q *c,int n); - -/* GeoBucket functions */ -ND normalize_pbucket(int mod,PGeoBucket g); -int head_pbucket(int mod,PGeoBucket g); -int head_pbucket_q(PGeoBucket g); -void add_pbucket_symbolic(PGeoBucket g,ND d); -void add_pbucket(int mod,PGeoBucket g,ND d); -void free_pbucket(PGeoBucket b); -void mulq_pbucket(PGeoBucket g,Q c); -NM remove_head_pbucket_symbolic(PGeoBucket g); -PGeoBucket create_pbucket(); - -/* manipulation of pairs and bases */ -int nd_newps(int mod,ND a,ND aq); -ND_pairs nd_newpairs( NODE g, int t ); -ND_pairs nd_minp( ND_pairs d, ND_pairs *prest ); -ND_pairs nd_minsugarp( ND_pairs d, ND_pairs *prest ); -NODE update_base(NODE nd,int ndp); -ND_pairs update_pairs( ND_pairs d, NODE /* of index */ g, int t); -ND_pairs equivalent_pairs( ND_pairs d1, ND_pairs *prest ); -ND_pairs crit_B( ND_pairs d, int s ); -ND_pairs crit_M( ND_pairs d1 ); -ND_pairs crit_F( ND_pairs d1 ); -int crit_2( int dp1, int dp2 ); -int ndv_newps(NDV a,NDV aq); - -/* top level functions */ -void nd_gr(LIST f,LIST v,int m,int f4,struct order_spec *ord,LIST *rp); -void nd_gr_trace(LIST f,LIST v,int trace,int homo,struct order_spec *ord,LIST *rp); -NODE nd_f4(int m); -NODE nd_gb(int m,int checkonly); -NODE nd_gb_trace(int m); - -/* ndl functions */ -int ndl_weight(UINT *d); -void ndl_weight_mask(UINT *d); -void ndl_homogenize(UINT *d,UINT *r,int obpe,EPOS oepos,int weight); -void ndl_dehomogenize(UINT *p); -void ndl_reconstruct(UINT *d,UINT *r,int obpe,EPOS oepos); -INLINE int ndl_reducible(UINT *d1,UINT *d2); -INLINE int ndl_lex_compare(UINT *d1,UINT *d2); -INLINE int ndl_block_compare(UINT *d1,UINT *d2); -INLINE int ndl_equal(UINT *d1,UINT *d2); -INLINE void ndl_copy(UINT *d1,UINT *d2); -INLINE void ndl_zero(UINT *d); -INLINE void ndl_add(UINT *d1,UINT *d2,UINT *d); -INLINE void ndl_addto(UINT *d1,UINT *d2); -INLINE void ndl_sub(UINT *d1,UINT *d2,UINT *d); -INLINE int ndl_hash_value(UINT *d); - -/* normal forms */ -INLINE int ndl_find_reducer(UINT *g); -int nd_sp(int mod,int trace,ND_pairs p,ND *nf); -int nd_nf(int mod,ND g,NDV *ps,int full,NDC dn,ND *nf); -int nd_nf_pbucket(int mod,ND g,NDV *ps,int full,ND *nf); - -/* finalizers */ -NODE ndv_reducebase(NODE x); -NODE ndv_reduceall(int m,NODE f); - -/* allocators */ -void nd_free_private_storage(); -void _NM_alloc(); -void _ND_alloc(); -void nd_free(ND p); -void nd_free_redlist(); - -/* printing */ -void ndl_print(UINT *dl); -void nd_print(ND p); -void nd_print_q(ND p); -void ndp_print(ND_pairs d); - - -/* setup, reconstruct */ -void nd_init_ord(struct order_spec *spec); -ND_pairs nd_reconstruct(int mod,int trace,ND_pairs ndp); -void ndv_setup(int mod,int trace,NODE f); -void nd_setup_parameters(int nvar,int max); -BlockMask nd_create_blockmask(struct order_spec *ord); -EPOS nd_create_epos(struct order_spec *ord); -int nd_get_exporigin(struct order_spec *ord); -void ndv_mod(int mod,NDV p); -NDV ndv_dup(int mod,NDV p); -ND nd_dup(ND p); - -/* ND functions */ -int ndv_check_candidate(NODE input,int obpe,int oadv,EPOS oepos,NODE cand); -void nd_mul_c(int mod,ND p,int mul); -void nd_mul_c_q(ND p,Q mul); -void nd_mul_c_p(VL vl,ND p,P mul); -ND nd_remove_head(ND p); -ND nd_separate_head(ND p,ND *head); -int nd_length(ND p); -void nd_append_red(UINT *d,int i); -UINT *ndv_compute_bound(NDV p); -ND nd_copy(ND p); -ND nd_merge(ND p1,ND p2); -ND nd_add(int mod,ND p1,ND p2); -ND nd_add_q(ND p1,ND p2); -ND nd_add_sf(ND p1,ND p2); -INLINE int nd_length(ND p); -NODE nd_f4_red(int m,ND_pairs sp0,UINT *s0vect,int col,NODE rp0); -NODE nd_f4_red_dist(int m,ND_pairs sp0,UINT *s0vect,int col,NODE rp0); - -/* NDV functions */ -ND weyl_ndv_mul_nm(int mod,NM m0,NDV p); -void weyl_mul_nm_nmv(int n,int mod,NM m0,NMV m1,NM *tab,int tlen); -void ndv_mul_c(int mod,NDV p,int mul); -void ndv_mul_c_q(NDV p,Q mul); -ND ndv_mul_nm_symbolic(NM m0,NDV p); -ND ndv_mul_nm(int mod,NM m0,NDV p); -void ndv_realloc(NDV p,int obpe,int oadv,EPOS oepos); -NDV ndv_dup_realloc(NDV p,int obpe,int oadv,EPOS oepos); -void ndv_homogenize(NDV p,int obpe,int oadv,EPOS eops); -void ndv_dehomogenize(NDV p,struct order_spec *spec); -void ndv_removecont(int mod,NDV p); -void ndv_print(NDV p); -void ndv_print_q(NDV p); -void ndv_free(NDV p); - -/* converters */ -ND ptond(VL vl,VL dvl,P p); -NDV ptondv(VL vl,VL dvl,P p); -P ndvtop(int mod,VL vl,VL dvl,NDV p); -NDV ndtondv(int mod,ND p); -ND ndvtond(int mod,NDV p); -int nm_ind_pair_to_vect(int m,UINT *s0,int n,NM_ind_pair pair,UINT *r); -IndArray nm_ind_pair_to_vect_compress(int m,UINT *s0,int n,NM_ind_pair pair); -int nd_to_vect(int mod,UINT *s0,int n,ND d,UINT *r); - void nd_free_private_storage() { _nm_free_list = 0; @@ -776,10 +444,24 @@ INLINE int ndl_equal(UINT *d1,UINT *d2) { int i; - for ( i = 0; i < nd_wpd; i++ ) - if ( *d1++ != *d2++ ) - return 0; - return 1; + switch ( nd_wpd ) { + case 2: + if ( TD(d2) != TD(d1) ) return 0; + if ( d2[1] != d1[1] ) return 0; + return 1; + break; + case 3: + if ( TD(d2) != TD(d1) ) return 0; + if ( d2[1] != d1[1] ) return 0; + if ( d2[2] != d1[2] ) return 0; + return 1; + break; + default: + for ( i = 0; i < nd_wpd; i++ ) + if ( *d1++ != *d2++ ) return 0; + return 1; + break; + } } INLINE void ndl_copy(UINT *d1,UINT *d2) @@ -1191,6 +873,28 @@ ND nd_add(int mod,ND p1,ND p2) } } +/* XXX on opteron, the inlined manipulation of destructive additon of + * two NM seems to make gcc optimizer get confused, so the part is + * done in a function. + */ + +int nm_destructive_add_q(NM *m1,NM *m2,NM *mr0,NM *mr) +{ + NM s; + Q t; + int can; + + addq(CQ(*m1),CQ(*m2),&t); + s = *m1; *m1 = NEXT(*m1); + if ( t ) { + can = 1; NEXTNM2(*mr0,*mr,s); CQ(*mr) = (t); + } else { + can = 2; FREENM(s); + } + s = *m2; *m2 = NEXT(*m2); FREENM(s); + return can; +} + ND nd_add_q(ND p1,ND p2) { int n,c,can; @@ -1206,6 +910,9 @@ ND nd_add_q(ND p1,ND p2) c = DL_COMPARE(DL(m1),DL(m2)); switch ( c ) { case 0: +#if defined(__x86_64__) + can += nm_destructive_add_q(&m1,&m2,&mr0,&mr); +#else addq(CQ(m1),CQ(m2),&t); s = m1; m1 = NEXT(m1); if ( t ) { @@ -1214,6 +921,7 @@ ND nd_add_q(ND p1,ND p2) can += 2; FREENM(s); } s = m2; m2 = NEXT(m2); FREENM(s); +#endif break; case 1: s = m1; m1 = NEXT(m1); NEXTNM2(mr0,mr,s); @@ -1322,7 +1030,10 @@ int nd_nf(int mod,ND g,NDV *ps,int full,NDC dn,ND *rp) nd_free(g); nd_free(d); return 0; } - p = ps[index]; + if ( nd_demand ) + p = ndv_load(index); + else + p = ps[index]; if ( mod == -1 ) CM(mul) = _mulsf(_invsf(HCM(p)),_chsgnsf(HCM(g))); else if ( mod ) { @@ -1381,6 +1092,8 @@ int nd_nf_pbucket(int mod,ND g,NDV *ps,int full,ND *rp Q cg,cred,gcd,zzz; RHist h; double hmag,gmag; + int count = 0; + int hcount = 0; if ( !g ) { *rp = 0; @@ -1396,6 +1109,7 @@ int nd_nf_pbucket(int mod,ND g,NDV *ps,int full,ND *rp while ( 1 ) { hindex = mod?head_pbucket(mod,bucket):head_pbucket_q(bucket); if ( hindex < 0 ) { + if ( DP_Print > 3 ) printf("(%d %d)",count,hcount); if ( d ) SG(d) = sugar; *rp = d; return 1; @@ -1403,6 +1117,8 @@ int nd_nf_pbucket(int mod,ND g,NDV *ps,int full,ND *rp g = bucket->body[hindex]; index = ndl_find_reducer(HDL(g)); if ( index >= 0 ) { + count++; + if ( !d ) hcount++; h = nd_psh[index]; ndl_sub(HDL(g),DL(h),DL(mul)); if ( ndl_check_bound2(index,DL(mul)) ) { @@ -1495,7 +1211,7 @@ again: } if ( DP_Print ) { printf("\n"); } /* gbcheck : cand is a GB of Id(cand) ? */ - if ( !nd_gb(0,1) ) return 0; + if ( !nd_gb(0,0,1) ) return 0; /* XXX */ return 1; } @@ -1728,16 +1444,56 @@ ND normalize_pbucket(int mod,PGeoBucket g) return r; } +void do_diagonalize(int sugar,int m) +{ + int i,nh,stat; + NODE r,g,t; + ND h,nf,s,head; + NDV nfv; + Q q,num,den; + union oNDC dn; + + for ( i = nd_psn-1; i >= 0 && SG(nd_psh[i]) == sugar; i-- ) { + if ( nd_demand ) + nfv = ndv_load(i); + else + nfv = nd_ps[i]; + s = ndvtond(m,nfv); + s = nd_separate_head(s,&head); + nd_nf(m,s,nd_ps,1,&dn,&nf); + if ( !m ) { + NTOQ(NM(dn.z),SGN(dn.z),num); + mulq(HCQ(head),num,&q); HCQ(head) = q; + if ( DN(dn.z) ) { + NTOQ(DN(dn.z),1,den); + nd_mul_c_q(nf,den); + } + } + nf = nd_add(m,head,nf); + ndv_free(nfv); + nd_removecont(m,nf); + nfv = ndtondv(m,nf); + nd_free(nf); + nd_bound[i] = ndv_compute_bound(nfv); + if ( nd_demand ) { + ndv_save(nfv,i); + ndv_free(nfv); + } else + nd_ps[i] = nfv; + } +} + /* return value = 0 => input is not a GB */ -NODE nd_gb(int m,int checkonly) +NODE nd_gb(int m,int ishomo,int checkonly) { int i,nh,sugar,stat; NODE r,g,t; ND_pairs d; ND_pairs l; - ND h,nf; + ND h,nf,s,head; NDV nfv; + Q q,num,den; union oNDC dn; g = 0; d = 0; @@ -1750,6 +1506,8 @@ NODE nd_gb(int m,int checkonly) again: l = nd_minp(d,&d); if ( SG(l) != sugar ) { + if ( ishomo ) do_diagonalize(sugar,m); + sugar = SG(l); if ( DP_Print ) fprintf(asir_out,"%d",sugar); } @@ -1773,7 +1531,7 @@ again: if ( DP_Print ) { printf("+"); fflush(stdout); } nd_removecont(m,nf); nfv = ndtondv(m,nf); nd_free(nf); - nh = ndv_newps(nfv,0); + nh = ndv_newps(m,nfv,0); d = update_pairs(d,g,nh); g = update_base(g,nh); FREENDP(l); @@ -1782,18 +1540,71 @@ again: FREENDP(l); } } - for ( t = g; t; t = NEXT(t) ) BDY(t) = (pointer)nd_ps[(int)BDY(t)]; + if ( nd_demand ) + for ( t = g; t; t = NEXT(t) ) + BDY(t) = (pointer)ndv_load((int)BDY(t)); + else + for ( t = g; t; t = NEXT(t) ) + BDY(t) = (pointer)nd_ps[(int)BDY(t)]; return g; } -NODE nd_gb_trace(int m) +void do_diagonalize_trace(int sugar,int m) { + int i,nh,stat; + NODE r,g,t; + ND h,nf,nfq,s,head; + NDV nfv,nfqv; + Q q,den,num; + union oNDC dn; + + for ( i = nd_psn-1; i >= 0 && SG(nd_psh[i]) == sugar; i-- ) { + /* for nd_ps */ + s = ndvtond(m,nd_ps[i]); + s = nd_separate_head(s,&head); + nd_nf_pbucket(m,s,nd_ps,1,&nf); + nf = nd_add(m,head,nf); + ndv_free(nd_ps[i]); + nd_ps[i] = ndtondv(m,nf); + nd_free(nf); + + /* for nd_ps_trace */ + if ( nd_demand ) + nfv = ndv_load(i); + else + nfv = nd_ps_trace[i]; + s = ndvtond(0,nfv); + s = nd_separate_head(s,&head); + nd_nf(0,s,nd_ps_trace,1,&dn,&nf); + NTOQ(NM(dn.z),SGN(dn.z),num); + mulq(HCQ(head),num,&q); HCQ(head) = q; + if ( DN(dn.z) ) { + NTOQ(DN(dn.z),1,den); + nd_mul_c_q(nf,den); + } + nf = nd_add(0,head,nf); + ndv_free(nfv); + nd_removecont(0,nf); + nfv = ndtondv(0,nf); + nd_free(nf); + nd_bound[i] = ndv_compute_bound(nfv); + if ( nd_demand ) { + ndv_save(nfv,i); + ndv_free(nfv); + } else + nd_ps_trace[i] = nfv; + } +} + +NODE nd_gb_trace(int m,int ishomo) +{ int i,nh,sugar,stat; NODE r,g,t; ND_pairs d; ND_pairs l; - ND h,nf,nfq; + ND h,nf,nfq,s,head; NDV nfv,nfqv; + Q q,den,num; union oNDC dn; g = 0; d = 0; @@ -1806,6 +1617,7 @@ NODE nd_gb_trace(int m) again: l = nd_minp(d,&d); if ( SG(l) != sugar ) { + if ( ishomo ) do_diagonalize_trace(sugar,m); sugar = SG(l); if ( DP_Print ) fprintf(asir_out,"%d",sugar); } @@ -1825,10 +1637,17 @@ again: d = nd_reconstruct(m,1,d); goto again; } else if ( nf ) { - if ( !nd_sp(0,1,l,&h) || !nd_nf(0,h,nd_ps_trace,!Top,0,&nfq) ) { - NEXT(l) = d; d = l; - d = nd_reconstruct(m,1,d); - goto again; + if ( nd_demand ) { + nfqv = ndv_load(nd_psn); + nfq = ndvtond(0,nfqv); + } else + nfq = 0; + if ( !nfq ) { + if ( !nd_sp(0,1,l,&h) || !nd_nf(0,h,nd_ps_trace,!Top,0,&nfq) ) { + NEXT(l) = d; d = l; + d = nd_reconstruct(m,1,d); + goto again; + } } if ( nfq ) { /* m|HC(nfq) => failure */ @@ -1837,7 +1656,7 @@ again: if ( DP_Print ) { printf("+"); fflush(stdout); } nd_removecont(m,nf); nfv = ndtondv(m,nf); nd_free(nf); nd_removecont(0,nfq); nfqv = ndtondv(0,nfq); nd_free(nfq); - nh = ndv_newps(nfv,nfqv); + nh = ndv_newps(0,nfv,nfqv); d = update_pairs(d,g,nh); g = update_base(g,nh); } else { @@ -1848,8 +1667,12 @@ again: } FREENDP(l); } - for ( t = g; t; t = NEXT(t) ) - BDY(t) = (pointer)nd_ps_trace[(int)BDY(t)]; + if ( nd_demand ) + for ( t = g; t; t = NEXT(t) ) + BDY(t) = (pointer)ndv_load((int)BDY(t)); + else + for ( t = g; t; t = NEXT(t) ) + BDY(t) = (pointer)nd_ps_trace[(int)BDY(t)]; return g; } @@ -1870,7 +1693,7 @@ NODE ndv_reduceall(int m,NODE f) NODE t,a0,a; union oNDC dn; NDV *w; - Q q; + Q q,num,den; n = length(f); #if 0 @@ -1889,7 +1712,14 @@ NODE ndv_reduceall(int m,NODE f) nd_reconstruct(m,0,0); else { if ( DP_Print ) { printf("."); fflush(stdout); } - if ( !m ) { mulq(HCQ(head),dn.z,&q); HCQ(head) = q; } + if ( !m ) { + NTOQ(NM(dn.z),SGN(dn.z),num); + mulq(HCQ(head),num,&q); HCQ(head) = q; + if ( DN(dn.z) ) { + NTOQ(DN(dn.z),1,den); + nd_mul_c_q(nf,den); + } + } nf = nd_add(m,head,nf); ndv_free(nd_ps[i]); nd_removecont(m,nf); @@ -2131,11 +1961,18 @@ ND_pairs nd_minp( ND_pairs d, ND_pairs *prest ) return m; } 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); - } + 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); + } + } else { + for ( ml = 0, l = m; p; p = NEXT(l = p) ) + if ( DL_COMPARE(LCM(p),LCM(m)) < 0 ) { + ml = l; m = p; s = SG(m); + } + } if ( !ml ) *prest = NEXT(m); else { NEXT(ml) = NEXT(m); @@ -2170,7 +2007,7 @@ ND_pairs nd_minsugarp( ND_pairs d, ND_pairs *prest ) return dm0; } -int ndv_newps(NDV a,NDV aq) +int ndv_newps(int m,NDV a,NDV aq) { int len; RHist r; @@ -2194,6 +2031,15 @@ int ndv_newps(NDV a,NDV aq) nd_bound[nd_psn] = ndv_compute_bound(a); SG(r) = SG(a); ndl_copy(HDL(a),DL(r)); } + if ( nd_demand ) { + if ( aq ) { + ndv_save(nd_ps_trace[nd_psn],nd_psn); + nd_ps_trace[nd_psn] = 0; + } else { + ndv_save(nd_ps[nd_psn],nd_psn); + nd_ps[nd_psn] = 0; + } + } return nd_psn++; } @@ -2236,6 +2082,15 @@ void ndv_setup(int mod,int trace,NODE f) NEWRHist(r); SG(r) = HTD(a); ndl_copy(HDL(a),DL(r)); nd_bound[i] = ndv_compute_bound(a); nd_psh[i] = r; + if ( nd_demand ) { + if ( trace ) { + ndv_save(nd_ps_trace[i],i); + nd_ps_trace[i] = 0; + } else { + ndv_save(nd_ps[i],i); + nd_ps[i] = 0; + } + } } } @@ -2245,10 +2100,22 @@ void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe NODE fd,fd0,r,r0,t,x,s,xx; int e,max,nvar; NDV b; + int ishomo; + if ( !m && Demand ) nd_demand = 1; + else nd_demand = 0; + ndv_alloc = 0; 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_{gr,f4} : invalid order specification"); + break; + default: + break; + } nd_init_ord(ord); for ( t = BDY(f), max = 0; t; t = NEXT(t) ) for ( tv = vv; tv; tv = NEXT(tv) ) { @@ -2256,14 +2123,18 @@ void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe 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); - x = f4?nd_f4(m):nd_gb(m,0); + x = f4?nd_f4(m):nd_gb(m,ishomo,0); + nd_demand = 0; x = ndv_reducebase(x); x = ndv_reduceall(m,x); for ( r0 = 0, t = x; t; t = NEXT(t) ) { @@ -2277,7 +2148,7 @@ void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe void nd_gr_trace(LIST f,LIST v,int trace,int homo,struct order_spec *ord,LIST *rp) { - struct order_spec ord1; + struct order_spec *ord1; VL tv,fv,vv,vc; NODE fd,fd0,in0,in,r,r0,t,s,cand; int m,nocheck,nvar,mindex,e,max; @@ -2285,13 +2156,24 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru NMV a; P p; EPOS oepos; - int obpe,oadv,wmax,i,len,cbpe; + int obpe,oadv,wmax,i,len,cbpe,ishomo; 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_gr_trace : invalid order specification"); + break; + default: + break; + } nocheck = 0; mindex = 0; + if ( Demand ) nd_demand = 1; + else nd_demand = 0; + /* setup modulus */ if ( trace < 0 ) { trace = -trace; @@ -2306,8 +2188,11 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru nd_init_ord(ord); nd_setup_parameters(nvar,max); obpe = nd_bpe; oadv = nmv_adv; oepos = nd_epos; + ishomo = 1; for ( in0 = 0, fd0 = 0, t = BDY(f); t; t = NEXT(t) ) { c = ptondv(CO,vv,(P)BDY(t)); + if ( ishomo ) + ishomo = ishomo && ndv_ishomo(c); if ( c ) { NEXTNODE(in0,in); BDY(in) = (pointer)c; NEXTNODE(fd0,fd); BDY(fd) = (pointer)ndv_dup(0,c); @@ -2315,38 +2200,41 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru } if ( in0 ) NEXT(in) = 0; if ( fd0 ) NEXT(fd) = 0; - if ( homo ) { + if ( !ishomo && homo ) { for ( t = in0, wmax = 0; t; t = NEXT(t) ) { c = (NDV)BDY(t); len = LEN(c); for ( a = BDY(c), i = 0; i < len; i++, NMV_ADV(a) ) wmax = MAX(TD(DL(a)),wmax); } homogenize_order(ord,nvar,&ord1); - nd_init_ord(&ord1); + nd_init_ord(ord1); nd_setup_parameters(nvar+1,wmax); for ( t = fd0; t; t = NEXT(t) ) ndv_homogenize((NDV)BDY(t),obpe,oadv,oepos); } while ( 1 ) { + if ( Demand ) + nd_demand = 1; ndv_setup(m,1,fd0); - cand = nd_gb_trace(m); + cand = nd_gb_trace(m,ishomo || homo); if ( !cand ) { /* failure */ if ( trace > 1 ) { *rp = 0; return; } else m = get_lprime(++mindex); continue; } - if ( homo ) { + if ( !ishomo && homo ) { /* dehomogenization */ for ( t = cand; t; t = NEXT(t) ) ndv_dehomogenize((NDV)BDY(t),ord); nd_init_ord(ord); nd_setup_parameters(nvar,0); } + nd_demand = 0; cand = ndv_reducebase(cand); cand = ndv_reduceall(0,cand); + cbpe = nd_bpe; if ( nocheck ) break; - cbpe = nd_bpe; if ( ndv_check_candidate(in0,obpe,oadv,oepos,cand) ) /* success */ break; @@ -2357,8 +2245,8 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru /* try the next modulus */ m = get_lprime(++mindex); /* reset the parameters */ - if ( homo ) { - nd_init_ord(&ord1); + if ( !ishomo && homo ) { + nd_init_ord(ord1); nd_setup_parameters(nvar+1,wmax); } else { nd_init_ord(ord); @@ -2589,7 +2477,7 @@ void ndv_dehomogenize(NDV p,struct order_spec *ord) for ( m = BDY(p), i = 0; i < len; NMV_ADV(m), i++ ) ndl_dehomogenize(DL(m)); if ( newwpd != nd_wpd ) { - newadv = sizeof(struct oNMV)+(newwpd-1)*sizeof(UINT); + newadv = ROUND_FOR_ALIGN(sizeof(struct oNMV)+(newwpd-1)*sizeof(UINT)); for ( m = r = BDY(p), i = 0; i < len; NMV_ADV(m), NDV_NADV(r), i++ ) { CQ(r) = CQ(m); for ( j = 0; j < newexporigin; j++ ) DL(r)[j] = DL(m)[j]; @@ -2748,31 +2636,32 @@ 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; + int i,j,n,elen,ord_o,ord_l,l,s,wpd; struct order_pair *op; - int bpe; - if ( !max ) bpe = nd_bpe; - else if ( max < 2 ) bpe = 1; - else if ( max < 4 ) bpe = 2; - else if ( max < 8 ) bpe = 3; - else if ( max < 16 ) bpe = 4; - else if ( max < 32 ) bpe = 5; - else if ( max < 64 ) bpe = 6; - else if ( max < 256 ) bpe = 8; - else if ( max < 1024 ) bpe = 10; - else if ( max < 65536 ) bpe = 16; - else bpe = 32; - if ( bpe != nd_bpe || nvar != nd_nvar ) - nd_free_private_storage(); - nd_bpe = bpe; nd_nvar = nvar; + if ( max ) { + /* XXX */ + if ( do_weyl ) nd_bpe = 32; + else if ( max < 2 ) nd_bpe = 1; + else if ( max < 4 ) nd_bpe = 2; + else if ( max < 8 ) nd_bpe = 3; + else if ( max < 16 ) nd_bpe = 4; + else if ( max < 32 ) nd_bpe = 5; + else if ( max < 64 ) nd_bpe = 6; + else if ( max < 256 ) nd_bpe = 8; + else if ( max < 1024 ) nd_bpe = 10; + else if ( max < 65536 ) nd_bpe = 16; + else nd_bpe = 32; + } nd_epw = (sizeof(UINT)*8)/nd_bpe; elen = nd_nvar/nd_epw+(nd_nvar%nd_epw?1:0); - nd_exporigin = nd_get_exporigin(nd_ord); - nd_wpd = nd_exporigin+elen; - + wpd = nd_exporigin+elen; + if ( wpd != nd_wpd ) { + nd_free_private_storage(); + nd_wpd = wpd; + } if ( nd_bpe < 32 ) { nd_mask0 = (1<i1]; p2 = nd_ps_trace[p->i2]; + if ( !mod && nd_demand ) { + p1 = ndv_load(p->i1); p2 = ndv_load(p->i2); } else { - p1 = nd_ps[p->i1]; p2 = nd_ps[p->i2]; + if ( trace ) { + p1 = nd_ps_trace[p->i1]; p2 = nd_ps_trace[p->i2]; + } else { + p1 = nd_ps[p->i1]; p2 = nd_ps[p->i2]; + } } lcm = LCM(p); NEWNM(m); @@ -3736,7 +3628,7 @@ IndArray nm_ind_pair_to_vect_compress(int mod,UINT *s0 NDV p; unsigned char *ivc; unsigned short *ivs; - UINT *v,*ivi; + UINT *v,*ivi,*s0v; int i,j,len,prev,diff,cdiff; IndArray r; @@ -3745,13 +3637,13 @@ IndArray nm_ind_pair_to_vect_compress(int mod,UINT *s0 p = nd_ps[pair->index]; len = LEN(p); t = (UINT *)ALLOCA(nd_wpd*sizeof(UINT)); - r = (IndArray)MALLOC(sizeof(struct oIndArray)); v = (unsigned int *)ALLOCA(len*sizeof(unsigned int)); 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++ ); v[j] = i; } + r = (IndArray)MALLOC(sizeof(struct oIndArray)); r->head = v[0]; diff = 0; for ( i = 1; i < len; i++ ) { @@ -3777,7 +3669,7 @@ IndArray nm_ind_pair_to_vect_compress(int mod,UINT *s0 } -void ndv_reduce_vect(int m,UINT *svect,int col,IndArray *imat,NM_ind_pair *rp0,int nred) +int ndv_reduce_vect(int m,UINT *svect,int col,IndArray *imat,NM_ind_pair *rp0,int nred) { int i,j,k,len,pos,prev; UINT c,c1,c2,c3,up,lo,dmy; @@ -3788,11 +3680,14 @@ void ndv_reduce_vect(int m,UINT *svect,int col,IndArra NDV redv; NMV mr; NODE rp; + int maxrs; + maxrs = 0; for ( i = 0; i < nred; i++ ) { ivect = imat[i]; k = ivect->head; svect[k] %= m; if ( c = svect[k] ) { + maxrs = MAX(maxrs,rp0[i]->sugar); c = m-c; redv = nd_ps[rp0[i]->index]; len = LEN(redv); mr = BDY(redv); svect[k] = 0; prev = k; @@ -3832,9 +3727,10 @@ void ndv_reduce_vect(int m,UINT *svect,int col,IndArra } for ( i = 0; i < col; i++ ) if ( svect[i] >= (UINT)m ) svect[i] %= m; + return maxrs; } -void ndv_reduce_vect_sf(int m,UINT *svect,int col,IndArray *imat,NM_ind_pair *rp0,int nred) +int ndv_reduce_vect_sf(int m,UINT *svect,int col,IndArray *imat,NM_ind_pair *rp0,int nred) { int i,j,k,len,pos,prev; UINT c,c1,c2,c3,up,lo,dmy; @@ -3845,11 +3741,14 @@ void ndv_reduce_vect_sf(int m,UINT *svect,int col,IndA NDV redv; NMV mr; NODE rp; + int maxrs; + maxrs = 0; for ( i = 0; i < nred; i++ ) { ivect = imat[i]; k = ivect->head; svect[k] %= m; if ( c = svect[k] ) { + maxrs = MAX(maxrs,rp0[i]->sugar); c = _chsgnsf(c); redv = nd_ps[rp0[i]->index]; len = LEN(redv); mr = BDY(redv); svect[k] = 0; prev = k; @@ -3878,6 +3777,7 @@ void ndv_reduce_vect_sf(int m,UINT *svect,int col,IndA } } } + return maxrs; } NDV vect_to_ndv(UINT *vect,int spcol,int col,int *rhead,UINT *s0vect) @@ -3927,7 +3827,7 @@ int nd_symbolic_preproc(PGeoBucket bucket,UINT **s0vec { NODE rp0,rp; NM mul,head,s0,s; - int index,col,i; + int index,col,i,sugar; RHist h; UINT *s0v,*p; NM_ind_pair pair; @@ -3946,7 +3846,8 @@ int nd_symbolic_preproc(PGeoBucket bucket,UINT **s0vec NEWNM(mul); ndl_sub(DL(head),DL(h),DL(mul)); if ( ndl_check_bound2(index,DL(mul)) ) return 0; - MKNM_ind_pair(pair,mul,index); + sugar = TD(DL(mul))+SG(nd_ps[index]); + MKNM_ind_pair(pair,mul,index,sugar); red = ndv_mul_nm_symbolic(mul,nd_ps[index]); add_pbucket_symbolic(bucket,nd_remove_head(red)); NEXTNODE(rp0,rp); BDY(rp) = (pointer)pair; @@ -3971,7 +3872,7 @@ NODE nd_f4(int m) ND spol,red; NDV nf,redv; NM s0,s; - NODE rp0,sp0,srp0,nflist; + NODE rp0,srp0,nflist; int nsp,nred,col,rank,len,k,j,a; UINT c; UINT **spmat; @@ -4004,7 +3905,7 @@ NODE nd_f4(int m) d = nd_reconstruct(m,0,d); continue; } - if ( !sp0 ) continue; + if ( bucket->m < 0 ) continue; col = nd_symbolic_preproc(bucket,&s0vect,&rp0); if ( !col ) { for ( t = l; NEXT(t); t = NEXT(t) ); @@ -4023,9 +3924,8 @@ NODE nd_f4(int m) /* adding new bases */ for ( r = nflist; r; r = NEXT(r) ) { nf = (NDV)BDY(r); - SG(nf) = sugar; ndv_removecont(m,nf); - nh = ndv_newps(nf,0); + nh = ndv_newps(m,nf,0); d = update_pairs(d,g,nh); g = update_base(g,nh); } @@ -4047,8 +3947,10 @@ NODE nd_f4_red(int m,ND_pairs sp0,UINT *s0vect,int col int **spmat; UINT *svect,*v; int *colstat; - struct oEGT eg0,eg1,eg_f4; + struct oEGT eg0,eg1,eg2,eg_f4,eg_f4_1,eg_f4_2; NM_ind_pair *rvect; + int maxrs; + int *spsugar; get_eg(&eg0); for ( sp = sp0, nsp = 0; sp; sp = NEXT(sp), nsp++ ); @@ -4068,39 +3970,51 @@ NODE nd_f4_red(int m,ND_pairs sp0,UINT *s0vect,int col /* elimination (1st step) */ spmat = (int **)ALLOCA(nsp*sizeof(UINT *)); svect = (UINT *)ALLOCA(col*sizeof(UINT)); + spsugar = (int *)ALLOCA(nsp*sizeof(UINT)); for ( a = sprow = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) { nd_sp(m,0,sp,&spol); if ( !spol ) continue; nd_to_vect(m,s0vect,col,spol,svect); - nd_free(spol); - if ( m == -1 ) ndv_reduce_vect_sf(m,svect,col,imat,rvect,nred); - else ndv_reduce_vect(m,svect,col,imat,rvect,nred); + if ( m == -1 ) + maxrs = ndv_reduce_vect_sf(m,svect,col,imat,rvect,nred); + else + maxrs = ndv_reduce_vect(m,svect,col,imat,rvect,nred); for ( i = 0; i < col; i++ ) if ( svect[i] ) break; if ( i < col ) { spmat[sprow] = v = (UINT *)MALLOC_ATOMIC(spcol*sizeof(UINT)); for ( j = k = 0; j < col; j++ ) if ( !rhead[j] ) v[k++] = svect[j]; + spsugar[sprow] = MAX(maxrs,SG(spol)); sprow++; } + nd_free(spol); } + get_eg(&eg1); init_eg(&eg_f4_1); add_eg(&eg_f4_1,&eg0,&eg1); + if ( DP_Print ) { + fprintf(asir_out,"elim1=%fsec,",eg_f4_1.exectime+eg_f4_1.gctime); + fflush(asir_out); + } /* free index arrays */ for ( i = 0; i < nred; i++ ) GC_free(imat[i]->index.c); /* elimination (2nd step) */ colstat = (int *)ALLOCA(spcol*sizeof(int)); if ( m == -1 ) - rank = generic_gauss_elim_sf(spmat,sprow,spcol,m,colstat); + rank = nd_gauss_elim_sf(spmat,spsugar,sprow,spcol,m,colstat); else - rank = generic_gauss_elim_mod(spmat,sprow,spcol,m,colstat); + rank = nd_gauss_elim_mod(spmat,spsugar,sprow,spcol,m,colstat); r0 = 0; for ( i = 0; i < rank; i++ ) { NEXTNODE(r0,r); BDY(r) = (pointer)vect_to_ndv(spmat[i],spcol,col,rhead,s0vect); + SG((NDV)BDY(r)) = spsugar[i]; GC_free(spmat[i]); } for ( ; i < sprow; i++ ) GC_free(spmat[i]); - get_eg(&eg1); init_eg(&eg_f4); add_eg(&eg_f4,&eg0,&eg1); + get_eg(&eg2); init_eg(&eg_f4_2); add_eg(&eg_f4_2,&eg1,&eg2); + init_eg(&eg_f4); add_eg(&eg_f4,&eg0,&eg2); if ( DP_Print ) { + fprintf(asir_out,"elim2=%fsec\n",eg_f4_2.exectime+eg_f4_2.gctime); fprintf(asir_out,"nsp=%d,nred=%d,spmat=(%d,%d),rank=%d ", nsp,nred,sprow,spcol,rank); fprintf(asir_out,"%fsec\n",eg_f4.exectime+eg_f4.gctime); @@ -4220,7 +4134,7 @@ NODE nd_f4_red_dist(int m,ND_pairs sp0,UINT *s0vect,in nd_send_int(nd_wpd); nd_send_int(nmv_adv); - saveobj(nd_write,dp_current_spec.obj); fflush(nd_write); + saveobj(nd_write,dp_current_spec->obj); fflush(nd_write); nd_send_int(nd_psn); for ( i = 0; i < nd_psn; i++ ) nd_send_ndv(nd_ps[i]); @@ -4266,9 +4180,11 @@ void nd_exec_f4_red_dist() ND_pairs *sp0; int *colstat; int a,sprow,rank; - struct order_spec ord; + struct order_spec *ord; Obj ordspec; ND spol; + int maxrs; + int *spsugar; nd_read = iofp[0].in; nd_write = iofp[0].out; @@ -4279,8 +4195,8 @@ void nd_exec_f4_red_dist() nmv_adv = nd_recv_int(); loadobj(nd_read,&ordspec); - create_order_spec(ordspec,&ord); - nd_init_ord(&ord); + create_order_spec(0,ordspec,&ord); + nd_init_ord(ord); nd_setup_parameters(nd_nvar,0); nd_psn = nd_recv_int(); @@ -4327,31 +4243,242 @@ void nd_exec_f4_red_dist() /* elimination (1st step) */ spmat = (int **)MALLOC(nsp*sizeof(UINT *)); svect = (UINT *)MALLOC(col*sizeof(UINT)); + spsugar = (int *)ALLOCA(nsp*sizeof(UINT)); for ( a = sprow = 0; a < nsp; a++ ) { nd_sp(m,0,sp0[a],&spol); if ( !spol ) continue; nd_to_vect(m,s0vect,col,spol,svect); - nd_free(spol); - if ( m == -1 ) ndv_reduce_vect_sf(m,svect,col,imat,rp0,nred); - else ndv_reduce_vect(m,svect,col,imat,rp0,nred); + if ( m == -1 ) + maxrs = ndv_reduce_vect_sf(m,svect,col,imat,rp0,nred); + else + maxrs = ndv_reduce_vect(m,svect,col,imat,rp0,nred); for ( i = 0; i < col; i++ ) if ( svect[i] ) break; if ( i < col ) { spmat[sprow] = v = (UINT *)MALLOC(spcol*sizeof(UINT)); for ( j = k = 0; j < col; j++ ) if ( !rhead[j] ) v[k++] = svect[j]; + spsugar[sprow] = MAX(maxrs,SG(spol)); sprow++; } + nd_free(spol); } /* elimination (2nd step) */ colstat = (int *)ALLOCA(spcol*sizeof(int)); if ( m == -1 ) - rank = generic_gauss_elim_sf(spmat,sprow,spcol,m,colstat); + rank = nd_gauss_elim_sf(spmat,spsugar,sprow,spcol,m,colstat); else - rank = generic_gauss_elim_mod(spmat,sprow,spcol,m,colstat); + rank = nd_gauss_elim_mod(spmat,spsugar,sprow,spcol,m,colstat); nd_send_int(rank); for ( i = 0; i < rank; i++ ) { nf = vect_to_ndv(spmat[i],spcol,col,rhead,s0vect); nd_send_ndv(nf); } fflush(nd_write); +} + +int nd_gauss_elim_mod(int **mat0,int *sugar,int row,int col,int md,int *colstat) +{ + int i,j,k,l,inv,a,rank,s; + unsigned int *t,*pivot,*pk; + unsigned int **mat; + + mat = (unsigned int **)mat0; + for ( rank = 0, j = 0; j < col; j++ ) { + for ( i = rank; i < row; i++ ) + mat[i][j] %= md; + for ( i = rank; i < row; i++ ) + if ( mat[i][j] ) + break; + if ( i == row ) { + colstat[j] = 0; + continue; + } else + colstat[j] = 1; + if ( i != rank ) { + t = mat[i]; mat[i] = mat[rank]; mat[rank] = t; + s = sugar[i]; sugar[i] = sugar[rank]; sugar[rank] = s; + } + pivot = mat[rank]; + s = sugar[rank]; + inv = invm(pivot[j],md); + for ( k = j, pk = pivot+k; k < col; k++, pk++ ) + if ( *pk ) { + if ( *pk >= (unsigned int)md ) + *pk %= md; + DMAR(*pk,inv,0,md,*pk) + } + for ( i = rank+1; i < row; i++ ) { + t = mat[i]; + if ( a = t[j] ) { + sugar[i] = MAX(sugar[i],s); + red_by_vect(md,t+j,pivot+j,md-a,col-j); + } + } + rank++; + } + for ( j = col-1, l = rank-1; j >= 0; j-- ) + if ( colstat[j] ) { + pivot = mat[l]; + s = sugar[l]; + for ( i = 0; i < l; i++ ) { + t = mat[i]; + t[j] %= md; + if ( a = t[j] ) { + sugar[i] = MAX(sugar[i],s); + red_by_vect(md,t+j,pivot+j,md-a,col-j); + } + } + l--; + } + for ( j = 0, l = 0; l < rank; j++ ) + if ( colstat[j] ) { + t = mat[l]; + for ( k = j; k < col; k++ ) + if ( t[k] >= (unsigned int)md ) + t[k] %= md; + l++; + } + return rank; +} + +int nd_gauss_elim_sf(int **mat0,int *sugar,int row,int col,int md,int *colstat) +{ + int i,j,k,l,inv,a,rank,s; + unsigned int *t,*pivot,*pk; + unsigned int **mat; + + mat = (unsigned int **)mat0; + for ( rank = 0, j = 0; j < col; j++ ) { + for ( i = rank; i < row; i++ ) + if ( mat[i][j] ) + break; + if ( i == row ) { + colstat[j] = 0; + continue; + } else + colstat[j] = 1; + if ( i != rank ) { + t = mat[i]; mat[i] = mat[rank]; mat[rank] = t; + s = sugar[i]; sugar[i] = sugar[rank]; sugar[rank] = s; + } + pivot = mat[rank]; + s = sugar[rank]; + inv = _invsf(pivot[j]); + for ( k = j, pk = pivot+k; k < col; k++, pk++ ) + if ( *pk ) + *pk = _mulsf(*pk,inv); + for ( i = rank+1; i < row; i++ ) { + t = mat[i]; + if ( a = t[j] ) { + sugar[i] = MAX(sugar[i],s); + red_by_vect_sf(md,t+j,pivot+j,_chsgnsf(a),col-j); + } + } + rank++; + } + for ( j = col-1, l = rank-1; j >= 0; j-- ) + if ( colstat[j] ) { + pivot = mat[l]; + s = sugar[l]; + for ( i = 0; i < l; i++ ) { + t = mat[i]; + if ( a = t[j] ) { + sugar[i] = MAX(sugar[i],s); + red_by_vect_sf(md,t+j,pivot+j,_chsgnsf(a),col-j); + } + } + l--; + } + return rank; +} + +int ndv_ishomo(NDV p) +{ + NMV m; + int len,h; + + if ( !p ) return 1; + len = LEN(p); + m = BDY(p); + h = TD(DL(m)); + NMV_ADV(m); + for ( len--; len; len--, NMV_ADV(m) ) + if ( TD(DL(m)) != h ) return 0; + return 1; +} + +void ndv_save(NDV p,int index) +{ + FILE *s; + char name[BUFSIZ]; + short id; + int nv,sugar,len,n,i,td,e,j; + NMV m; + unsigned int *dl; + + sprintf(name,"%s/%d",Demand,index); + s = fopen(name,"w"); + savevl(s,0); + if ( !p ) { + saveobj(s,0); + return; + } + id = O_DP; + nv = NV(p); + sugar = SG(p); + len = LEN(p); + write_short(s,&id); write_int(s,&nv); write_int(s,&sugar); + write_int(s,&len); + + for ( m = BDY(p), i = 0; i < len; i++, NMV_ADV(m) ) { + saveobj(s,(Obj)CQ(m)); + dl = DL(m); + td = TD(dl); + write_int(s,&td); + for ( j = 0; j < nv; j++ ) { + e = GET_EXP(dl,j); + write_int(s,&e); + } + } + fclose(s); +} + +NDV ndv_load(int index) +{ + FILE *s; + char name[BUFSIZ]; + short id; + int nv,sugar,len,n,i,td,e,j; + NDV d; + NMV m0,m; + unsigned int *dl; + Obj obj; + + sprintf(name,"%s/%d",Demand,index); + s = fopen(name,"r"); + if ( !s ) return 0; + + skipvl(s); + read_short(s,&id); + if ( !id ) return 0; + read_int(s,&nv); + read_int(s,&sugar); + read_int(s,&len); + + m0 = m = MALLOC(len*nmv_adv); + for ( i = 0; i < len; i++, NMV_ADV(m) ) { + loadobj(s,&obj); CQ(m) = (Q)obj; + dl = DL(m); + ndl_zero(dl); + read_int(s,&td); TD(dl) = td; + for ( j = 0; j < nv; j++ ) { + read_int(s,&e); + PUT_EXP(dl,j,e); + } + if ( nd_blockmask ) ndl_weight_mask(dl); + } + fclose(s); + MKNDV(nv,m0,len,d); + SG(d) = sugar; + return d; }