=================================================================== RCS file: /home/cvs/OpenXM_contrib2/asir2000/engine/nd.c,v retrieving revision 1.88 retrieving revision 1.111 diff -u -p -r1.88 -r1.111 --- OpenXM_contrib2/asir2000/engine/nd.c 2003/12/24 02:20:19 1.88 +++ OpenXM_contrib2/asir2000/engine/nd.c 2004/09/21 07:19:01 1.111 @@ -1,123 +1,16 @@ -/* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.87 2003/11/05 08:02:45 noro Exp $ */ +/* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.110 2004/09/21 05:23:14 noro Exp $ */ -#include "ca.h" -#include "parse.h" -#include "ox.h" -#include "base.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,sugar; -} *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; +#if 0 static int ndv_alloc; +#endif #if 1 static int nd_f4_nsp=0x7fffffff; #else @@ -134,253 +27,20 @@ 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; static int nd_psn,nd_pslen; - static RHist *nd_red; - +static int *nd_work_vector; +static int **nd_matrix; +static int nd_matrix_len; +static struct weight_or_block *nd_worb; +static int nd_worb_len; 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 char *Demand; -extern VL CO; -extern int Top,Reverse,DP_Print,dp_nelim,do_weyl,NoSugar; -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,s) (NEWNM_ind_pair(p),(p)->mul=(m),(p)->index=(i),(p)->sugar = (s)) - -/* 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(int m,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 ishomo,int checkonly); -NODE nd_gb_trace(int m,int ishomo); - -/* 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); -void ndv_save(NDV p,int index); -NDV ndv_load(int index); - -/* 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); - -/* elimination */ -int nd_gauss_elim_mod(int **mat0,int *sugar,int row,int col,int md,int *colstat); -int nd_gauss_elim_sf(int **mat0,int *sugar,int row,int col,int md,int *colstat); - void nd_free_private_storage() { _nm_free_list = 0; @@ -767,6 +427,84 @@ int ndl_block_compare(UINT *d1,UINT *d2) return 0; } +int ndl_matrix_compare(UINT *d1,UINT *d2) +{ + int i,j,s; + int *v; + + for ( j = 0; j < nd_nvar; j++ ) + nd_work_vector[j] = GET_EXP(d1,j)-GET_EXP(d2,j); + for ( i = 0; i < nd_matrix_len; i++ ) { + v = nd_matrix[i]; + for ( j = 0, s = 0; j < nd_nvar; j++ ) + s += v[j]*nd_work_vector[j]; + if ( s > 0 ) return 1; + else if ( s < 0 ) return -1; + } + return 0; +} + +int ndl_composite_compare(UINT *d1,UINT *d2) +{ + int i,j,s,start,end,len,o; + int *v; + struct sparse_weight *sw; + + for ( j = 0; j < nd_nvar; j++ ) + nd_work_vector[j] = GET_EXP(d1,j)-GET_EXP(d2,j); + for ( i = 0; i < nd_worb_len; i++ ) { + len = nd_worb[i].length; + switch ( nd_worb[i].type ) { + case IS_DENSE_WEIGHT: + v = nd_worb[i].body.dense_weight; + for ( j = 0, s = 0; j < len; j++ ) + s += v[j]*nd_work_vector[j]; + if ( s > 0 ) return 1; + else if ( s < 0 ) return -1; + break; + case IS_SPARSE_WEIGHT: + sw = nd_worb[i].body.sparse_weight; + for ( j = 0, s = 0; j < len; j++ ) + s += sw[j].value*nd_work_vector[sw[j].pos]; + if ( s > 0 ) return 1; + else if ( s < 0 ) return -1; + break; + case IS_BLOCK: + o = nd_worb[i].body.block.order; + start = nd_worb[i].body.block.start; + switch ( o ) { + case 0: + end = start+len; + for ( j = start, s = 0; j < end; j++ ) + s += MUL_WEIGHT(nd_work_vector[j],j); + if ( s > 0 ) return 1; + else if ( s < 0 ) return -1; + for ( j = end-1; j >= start; j-- ) + if ( nd_work_vector[j] < 0 ) return 1; + else if ( nd_work_vector[j] > 0 ) return -1; + break; + case 1: + end = start+len; + for ( j = start, s = 0; j < end; j++ ) + s += MUL_WEIGHT(nd_work_vector[j],j); + if ( s > 0 ) return 1; + else if ( s < 0 ) return -1; + for ( j = start; j < end; j++ ) + if ( nd_work_vector[j] > 0 ) return 1; + else if ( nd_work_vector[j] < 0 ) return -1; + break; + case 2: + for ( j = start; j < end; j++ ) + if ( nd_work_vector[j] > 0 ) return 1; + else if ( nd_work_vector[j] < 0 ) return -1; + break; + } + break; + } + } + return 0; +} + /* TDH -> WW -> TD-> RL */ int ndl_ww_lex_compare(UINT *d1,UINT *d2) @@ -1218,6 +956,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; @@ -1233,6 +993,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 ) { @@ -1241,6 +1004,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); @@ -1523,7 +1287,7 @@ again: d = ndvtond(0,r); stat = nd_nf(0,d,nd_ps,0,0,&nf); if ( !stat ) { - nd_reconstruct(0,0,0); + nd_reconstruct(0,0); goto again; } else if ( nf ) return 0; if ( DP_Print ) { printf("."); fflush(stdout); } @@ -1763,6 +1527,45 @@ 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 ishomo,int checkonly) @@ -1786,43 +1589,15 @@ NODE nd_gb(int m,int ishomo,int checkonly) again: l = nd_minp(d,&d); if ( SG(l) != sugar ) { - if ( ishomo ) { - 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; - } - } + if ( ishomo ) do_diagonalize(sugar,m); + sugar = SG(l); if ( DP_Print ) fprintf(asir_out,"%d",sugar); } stat = nd_sp(m,0,l,&h); if ( !stat ) { NEXT(l) = d; d = l; - d = nd_reconstruct(m,0,d); + d = nd_reconstruct(0,d); goto again; } #if USE_GEOBUCKET @@ -1832,7 +1607,7 @@ again: #endif if ( !stat ) { NEXT(l) = d; d = l; - d = nd_reconstruct(m,0,d); + d = nd_reconstruct(0,d); goto again; } else if ( nf ) { if ( checkonly ) return 0; @@ -1857,6 +1632,53 @@ again: return g; } +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; @@ -1878,51 +1700,14 @@ NODE nd_gb_trace(int m,int ishomo) again: l = nd_minp(d,&d); if ( SG(l) != sugar ) { - if ( ishomo ) { - 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; - } - } + if ( ishomo ) do_diagonalize_trace(sugar,m); sugar = SG(l); if ( DP_Print ) fprintf(asir_out,"%d",sugar); } stat = nd_sp(m,0,l,&h); if ( !stat ) { NEXT(l) = d; d = l; - d = nd_reconstruct(m,1,d); + d = nd_reconstruct(1,d); goto again; } #if USE_GEOBUCKET @@ -1932,7 +1717,7 @@ again: #endif if ( !stat ) { NEXT(l) = d; d = l; - d = nd_reconstruct(m,1,d); + d = nd_reconstruct(1,d); goto again; } else if ( nf ) { if ( nd_demand ) { @@ -1943,7 +1728,7 @@ again: 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); + d = nd_reconstruct(1,d); goto again; } } @@ -2007,7 +1792,7 @@ NODE ndv_reduceall(int m,NODE f) g = nd_separate_head(g,&head); stat = nd_nf(m,g,nd_ps,1,&dn,&nf); if ( !stat ) - nd_reconstruct(m,0,0); + nd_reconstruct(0,0); else { if ( DP_Print ) { printf("."); fflush(stdout); } if ( !m ) { @@ -2403,7 +2188,9 @@ void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe if ( !m && Demand ) nd_demand = 1; else nd_demand = 0; +#if 0 ndv_alloc = 0; +#endif get_vars((Obj)f,&fv); pltovl(v,&vv); for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ ); switch ( ord->id ) { @@ -2441,12 +2228,14 @@ void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe } if ( r0 ) NEXT(r) = 0; MKLIST(*rp,r0); +#if 0 fprintf(asir_out,"ndv_alloc=%d\n",ndv_alloc); +#endif } 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; @@ -2505,7 +2294,7 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru 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); @@ -2544,7 +2333,7 @@ void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru m = get_lprime(++mindex); /* reset the parameters */ if ( !ishomo && homo ) { - nd_init_ord(&ord1); + nd_init_ord(ord1); nd_setup_parameters(nvar+1,wmax); } else { nd_init_ord(ord); @@ -2775,7 +2564,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]; @@ -2790,7 +2579,7 @@ void removecont_array(Q *c,int n) { struct oVECT v; Q d0,d1,a,u,u1,gcd; - int i; + int i,j; N qn,rn,gn; Q *q,*r; @@ -2919,17 +2708,46 @@ UINT *ndv_compute_bound(NDV p) return t; } +UINT *nd_compute_bound(ND p) +{ + UINT *d1,*d2,*t; + UINT u; + int i,j,k,l,len,ind; + NM m; + + if ( !p ) + return 0; + d1 = (UINT *)ALLOCA(nd_wpd*sizeof(UINT)); + d2 = (UINT *)ALLOCA(nd_wpd*sizeof(UINT)); + len = LEN(p); + m = BDY(p); ndl_copy(DL(m),d1); m = NEXT(m); + for ( m = NEXT(m); m; m = NEXT(m) ) { + ndl_lcm(DL(m),d1,d2); + t = d1; d1 = d2; d2 = t; + } + l = nd_nvar+31; + t = (UINT *)MALLOC_ATOMIC(l*sizeof(UINT)); + for ( i = nd_exporigin, ind = 0; i < nd_wpd; i++ ) { + u = d1[i]; + k = (nd_epw-1)*nd_bpe; + for ( j = 0; j < nd_epw; j++, k -= nd_bpe, ind++ ) + t[ind] = (u>>k)&nd_mask0; + } + for ( ; ind < l; ind++ ) t[ind] = 0; + return t; +} + int nd_get_exporigin(struct order_spec *ord) { switch ( ord->id ) { - case 0: + case 0: case 2: return 1; case 1: /* block order */ /* d[0]:weight d[1]:w0,...,d[nd_exporigin-1]:w(n-1) */ return ord->ord.block.length+1; - case 2: - error("nd_get_exporigin : matrix order is not supported yet."); + case 3: + error("nd_get_exporigin : composite order is not supported yet."); } } @@ -2971,13 +2789,13 @@ void nd_setup_parameters(int nvar,int max) { nd_mask[nd_epw-i-1] = (nd_mask0<<(i*nd_bpe)); nd_mask1 |= (1<<(nd_bpe-1))<<(i*nd_bpe); } - nm_adv = sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT); - nmv_adv = sizeof(struct oNMV)+(nd_wpd-1)*sizeof(UINT); + nmv_adv = ROUND_FOR_ALIGN(sizeof(struct oNMV)+(nd_wpd-1)*sizeof(UINT)); nd_epos = nd_create_epos(nd_ord); nd_blockmask = nd_create_blockmask(nd_ord); + nd_work_vector = (int *)REALLOC(nd_work_vector,nd_nvar*sizeof(int)); } -ND_pairs nd_reconstruct(int mod,int trace,ND_pairs d) +ND_pairs nd_reconstruct(int trace,ND_pairs d) { int i,obpe,oadv,h; static NM prev_nm_free_list; @@ -3384,6 +3202,54 @@ ND ndv_mul_nm(int mod,NM m0,NDV p) } } +ND nd_quo(int mod,PGeoBucket bucket,NDV d) +{ + NM mq0,mq; + NMV tm; + Q q; + int i,nv,sg,c,c1,c2,hindex; + ND p,t,r; + N tnm; + + if ( !p ) return 0; + else { + nv = NV(d); + mq0 = 0; + tm = (NMV)ALLOCA(nmv_adv); + while ( 1 ) { + hindex = mod?head_pbucket(mod,bucket):head_pbucket_q(bucket); + if ( hindex < 0 ) break; + p = bucket->body[hindex]; + NEXTNM(mq0,mq); + ndl_sub(HDL(p),HDL(d),DL(mq)); + ndl_copy(DL(mq),DL(tm)); + if ( mod ) { + c1 = invm(HCM(d),mod); c2 = HCM(p); + DMAR(c1,c2,0,mod,c); CM(mq) = c; + CM(tm) = mod-c; + } else { + divsn(NM(HCQ(p)),NM(HCQ(d)),&tnm); + NTOQ(tnm,SGN(HCQ(p))*SGN(HCQ(d)),CQ(mq)); + chsgnq(CQ(mq),&CQ(tm)); + } + t = ndv_mul_nmv_trunc(mod,tm,d,HDL(d)); + bucket->body[hindex] = nd_remove_head(p); + t = nd_remove_head(t); + add_pbucket(mod,bucket,t); + } + if ( !mq0 ) + r = 0; + else { + NEXT(mq) = 0; + for ( i = 0, mq = mq0; mq; mq = NEXT(mq), i++ ); + MKND(nv,mq0,i,r); + /* XXX */ + SG(r) = HTD(r); + } + return r; + } +} + void ndv_realloc(NDV p,int obpe,int oadv,EPOS oepos) { NMV m,mr,mr0,t; @@ -3533,7 +3399,7 @@ ND ptond(VL vl,VL dvl,P p) w = (DCP *)ALLOCA(k*sizeof(DCP)); for ( dc = DC(p), j = 0; j < k; dc = NEXT(dc), j++ ) w[j] = dc; for ( i = 0, tvl = dvl, v = VR(p); - vl && tvl->v != v; tvl = NEXT(tvl), i++ ); + tvl && tvl->v != v; tvl = NEXT(tvl), i++ ); if ( !tvl ) { for ( j = k-1, s = 0, MKV(v,x); j >= 0; j-- ) { t = ptond(vl,dvl,COEF(w[j])); @@ -3606,7 +3472,9 @@ NDV ndtondv(int mod,ND p) m0 = m = (NMV)GC_malloc_atomic_ignore_off_page(len*nmv_adv); else m0 = m = MALLOC(len*nmv_adv); +#if 0 ndv_alloc += nmv_adv*len; +#endif for ( t = BDY(p), i = 0; t; t = NEXT(t), i++, NMV_ADV(m) ) { ndl_copy(DL(t),DL(m)); CQ(m) = CQ(t); @@ -3726,14 +3594,29 @@ void nd_init_ord(struct order_spec *ord) } break; case 1: + /* block order */ /* XXX */ nd_dcomp = -1; nd_isrlex = 0; ndl_compare_function = ndl_block_compare; break; case 2: - error("nd_init_ord : matrix order is not supported yet."); + /* matrix order */ + /* XXX */ + nd_dcomp = -1; + nd_isrlex = 0; + nd_matrix_len = ord->ord.matrix.row; + nd_matrix = ord->ord.matrix.matrix; + ndl_compare_function = ndl_matrix_compare; break; + case 3: + /* composite order */ + 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_composite_compare; + break; } nd_ord = ord; } @@ -3744,7 +3627,8 @@ BlockMask nd_create_blockmask(struct order_spec *ord) UINT *t; BlockMask bm; - if ( !ord->id ) + /* we only create mask table for block order */ + if ( ord->id != 1 ) return 0; n = ord->ord.block.length; bm = (BlockMask)MALLOC(sizeof(struct oBlockMask)); @@ -3802,7 +3686,14 @@ EPOS nd_create_epos(struct order_spec *ord) } break; case 2: - error("nd_create_epos : matrix order is not supported yet."); + /* matrix order */ + case 3: + /* composite order */ + for ( i = 0; i < nd_nvar; i++ ) { + epos[i].i = nd_exporigin + i/nd_epw; + epos[i].s = (nd_epw-(i%nd_epw)-1)*nd_bpe; + } + break; } return epos; } @@ -3854,7 +3745,7 @@ void nd_nf_p(P f,LIST g,LIST v,int m,struct order_spec stat = nd_nf(m,nd,nd_ps,1,0,&nf); if ( !stat ) { nd_psn++; - nd_reconstruct(m,0,0); + nd_reconstruct(0,0); nd_psn--; } else break; @@ -3878,47 +3769,22 @@ int nd_to_vect(int mod,UINT *s0,int n,ND d,UINT *r) return i; } -int ndv_to_vect(int mod,UINT *s0,int n,NDV d,UINT *r) +int nd_to_vect_q(UINT *s0,int n,ND d,Q *r) { - NMV m; + NM m; UINT *t,*s; - int i,j,len; + int i; for ( i = 0; i < n; i++ ) r[i] = 0; - m = BDY(d); - len = LEN(d); - for ( i = j = 0, s = s0; j < len; j++, NMV_ADV(m)) { + for ( i = 0, s = s0, m = BDY(d); m; m = NEXT(m) ) { t = DL(m); for ( ; !ndl_equal(t,s); s += nd_wpd, i++ ); - r[i] = CM(m); + r[i] = CQ(m); } for ( i = 0; !r[i]; i++ ); return i; } -int nm_ind_pair_to_vect(int mod,UINT *s0,int n,NM_ind_pair pair,UINT *r) -{ - NM m; - NMV mr; - UINT *d,*t,*s; - NDV p; - int i,j,len; - - m = pair->mul; - d = DL(m); - p = nd_ps[pair->index]; - t = (UINT *)ALLOCA(nd_wpd*sizeof(UINT)); - for ( i = 0; i < n; i++ ) r[i] = 0; - len = LEN(p); - 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] = CM(mr); - } - for ( i = 0; !r[i]; i++ ); - return i; -} - IndArray nm_ind_pair_to_vect_compress(int mod,UINT *s0,int n,NM_ind_pair pair) { NM m; @@ -3968,6 +3834,63 @@ IndArray nm_ind_pair_to_vect_compress(int mod,UINT *s0 } +int ndv_reduce_vect_q(Q *svect,int col,IndArray *imat,NM_ind_pair *rp0,int nred) +{ + int i,j,k,len,pos,prev; + Q cs,mcs,c1,c2,cr,gcd,t; + IndArray ivect; + unsigned char *ivc; + unsigned short *ivs; + unsigned int *ivi; + NDV redv; + NMV mr; + NODE rp; + int maxrs; + + maxrs = 0; + for ( i = 0; i < nred; i++ ) { + ivect = imat[i]; + k = ivect->head; + if ( svect[k] ) { + maxrs = MAX(maxrs,rp0[i]->sugar); + redv = nd_ps[rp0[i]->index]; + len = LEN(redv); mr = BDY(redv); + igcd_cofactor(svect[k],CQ(mr),&gcd,&cs,&cr); + chsgnq(cs,&mcs); + if ( !UNIQ(cr) ) { + for ( j = 0; j < col; j++ ) { + mulq(svect[j],cr,&c1); svect[j] = c1; + } + } + svect[k] = 0; prev = k; + switch ( ivect->width ) { + case 1: + ivc = ivect->index.c; + for ( j = 1, NMV_ADV(mr); j < len; j++, NMV_ADV(mr) ) { + pos = prev+ivc[j]; prev = pos; + mulq(CQ(mr),mcs,&c2); addq(svect[pos],c2,&t); svect[pos] = t; + } + break; + case 2: + ivs = ivect->index.s; + for ( j = 1, NMV_ADV(mr); j < len; j++, NMV_ADV(mr) ) { + pos = prev+ivs[j]; prev = pos; + mulq(CQ(mr),mcs,&c2); addq(svect[pos],c2,&t); svect[pos] = t; + } + break; + case 4: + ivi = ivect->index.i; + for ( j = 1, NMV_ADV(mr); j < len; j++, NMV_ADV(mr) ) { + pos = prev+ivi[j]; prev = pos; + mulq(CQ(mr),mcs,&c2); addq(svect[pos],c2,&t); svect[pos] = t; + } + break; + } + } + } + return maxrs; +} + 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; @@ -4091,7 +4014,9 @@ NDV vect_to_ndv(UINT *vect,int spcol,int col,int *rhea if ( !len ) return 0; else { mr0 = (NMV)GC_malloc_atomic_ignore_off_page(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 ) @@ -4105,6 +4030,36 @@ NDV vect_to_ndv(UINT *vect,int spcol,int col,int *rhea } } +NDV vect_to_ndv_q(Q *vect,int spcol,int col,int *rhead,UINT *s0vect) +{ + int j,k,len; + UINT *p; + Q c; + NDV r; + NMV mr0,mr; + + for ( j = 0, len = 0; j < spcol; 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 ) + if ( !rhead[j] ) { + 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; @@ -4184,9 +4139,9 @@ NODE nd_f4(int m) PGeoBucket bucket; struct oEGT eg0,eg1,eg_f4; - if ( !m ) - error("nd_f4 : not implemented"); +#if 0 ndv_alloc = 0; +#endif g = 0; d = 0; for ( i = 0; i < nd_psn; i++ ) { d = update_pairs(d,g,i); @@ -4201,7 +4156,7 @@ NODE nd_f4(int m) if ( !stat ) { for ( t = l; NEXT(t); t = NEXT(t) ); NEXT(t) = d; d = l; - d = nd_reconstruct(m,0,d); + d = nd_reconstruct(0,d); continue; } if ( bucket->m < 0 ) continue; @@ -4209,7 +4164,7 @@ NODE nd_f4(int m) if ( !col ) { for ( t = l; NEXT(t); t = NEXT(t) ); NEXT(t) = d; d = l; - d = nd_reconstruct(m,0,d); + d = nd_reconstruct(0,d); continue; } get_eg(&eg1); init_eg(&eg_f4); add_eg(&eg_f4,&eg0,&eg1); @@ -4230,30 +4185,23 @@ NODE nd_f4(int m) } } for ( r = g; r; r = NEXT(r) ) BDY(r) = (pointer)nd_ps[(int)BDY(r)]; +#if 0 fprintf(asir_out,"ndv_alloc=%d\n",ndv_alloc); +#endif return g; } NODE nd_f4_red(int m,ND_pairs sp0,UINT *s0vect,int col,NODE rp0) { IndArray *imat; - int nsp,nred,spcol,sprow,a; + int nsp,nred,i; int *rhead; - int i,j,k,l,rank; - NODE rp,r0,r; + NODE r0,rp; ND_pairs sp; - ND spol; - int **spmat; - UINT *svect,*v; - int *colstat; - 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++ ); - nred = length(rp0); spcol = col-nred; + nred = length(rp0); imat = (IndArray *)ALLOCA(nred*sizeof(IndArray)); rhead = (int *)ALLOCA(col*sizeof(int)); for ( i = 0; i < col; i++ ) rhead[i] = 0; @@ -4265,7 +4213,30 @@ NODE nd_f4_red(int m,ND_pairs sp0,UINT *s0vect,int col imat[i] = nm_ind_pair_to_vect_compress(m,s0vect,col,rvect[i]); rhead[imat[i]->head] = 1; } + if ( m ) + r0 = nd_f4_red_main(m,sp0,nsp,s0vect,col,rvect,rhead,imat,nred); + else + r0 = nd_f4_red_q_main(sp0,nsp,s0vect,col,rvect,rhead,imat,nred); + return r0; +} +NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s0vect,int col, + NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred) +{ + int spcol,sprow,a; + int i,j,k,l,rank; + NODE r0,r; + ND_pairs sp; + ND spol; + int **spmat; + UINT *svect,*v; + int *colstat; + struct oEGT eg0,eg1,eg2,eg_f4,eg_f4_1,eg_f4_2; + int maxrs; + int *spsugar; + + spcol = col-nred; + get_eg(&eg0); /* elimination (1st step) */ spmat = (int **)ALLOCA(nsp*sizeof(UINT *)); svect = (UINT *)ALLOCA(col*sizeof(UINT)); @@ -4309,6 +4280,7 @@ NODE nd_f4_red(int m,ND_pairs sp0,UINT *s0vect,int col SG((NDV)BDY(r)) = spsugar[i]; GC_free(spmat[i]); } + if ( r0 ) NEXT(r) = 0; for ( ; i < sprow; i++ ) GC_free(spmat[i]); 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); @@ -4321,6 +4293,74 @@ NODE nd_f4_red(int m,ND_pairs sp0,UINT *s0vect,int col return r0; } +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 spcol,sprow,a; + int i,j,k,l,rank; + NODE r0,r; + ND_pairs sp; + ND spol; + Q **spmat; + Q *svect,*v; + int *colstat; + struct oEGT eg0,eg1,eg2,eg_f4,eg_f4_1,eg_f4_2; + int maxrs; + int *spsugar; + + spcol = col-nred; + get_eg(&eg0); + /* elimination (1st step) */ + spmat = (Q **)ALLOCA(nsp*sizeof(Q *)); + svect = (Q *)ALLOCA(col*sizeof(Q)); + spsugar = (int *)ALLOCA(nsp*sizeof(Q)); + for ( a = sprow = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) { + nd_sp(0,0,sp,&spol); + if ( !spol ) continue; + nd_to_vect_q(s0vect,col,spol,svect); + maxrs = ndv_reduce_vect_q(svect,col,imat,rvect,nred); + for ( i = 0; i < col; i++ ) if ( svect[i] ) break; + if ( i < col ) { + spmat[sprow] = v = (Q *)MALLOC(spcol*sizeof(Q)); + 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)); + rank = nd_gauss_elim_q(spmat,spsugar,sprow,spcol,colstat); + r0 = 0; + for ( i = 0; i < rank; i++ ) { + NEXTNODE(r0,r); BDY(r) = + (pointer)vect_to_ndv_q(spmat[i],spcol,col,rhead,s0vect); + SG((NDV)BDY(r)) = spsugar[i]; +/* GC_free(spmat[i]); */ + } + if ( r0 ) NEXT(r) = 0; + +/* for ( ; i < sprow; i++ ) GC_free(spmat[i]); */ + 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); + } + return r0; +} + FILE *nd_write,*nd_read; void nd_send_int(int a) { @@ -4384,7 +4424,9 @@ NDV nd_recv_ndv() if ( !len ) return 0; else { m0 = m = (NMV)GC_malloc_atomic_ignore_off_page(nmv_adv*len); +#if 0 ndv_alloc += len*nmv_adv; +#endif for ( i = 0; i < len; i++, NMV_ADV(m) ) { CM(m) = nd_recv_int(); nd_recv_intarray(DL(m),nd_wpd); @@ -4433,7 +4475,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]); @@ -4479,7 +4521,7 @@ 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; @@ -4494,8 +4536,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(); @@ -4575,6 +4617,58 @@ void nd_exec_f4_red_dist() fflush(nd_write); } +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 *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,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; + c = col-rank; + for ( i = 0; i < rank; i++ ) { + mat0[i][ri[i]] = dn; + 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; +} + 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; @@ -4780,4 +4874,155 @@ NDV ndv_load(int index) MKNDV(nv,m0,len,d); SG(d) = sugar; return d; +} + +void nd_det(int mod,MAT f,P *rp) +{ + VL fv,tv; + int n,i,j,max,e,nvar,sgn,k0,l0,len0,len,k,l,a; + pointer **m; + Q mone; + NDV **dm; + NDV *t,*mi,*mj; + NDV d,s,mij,mjj; + ND u; + NMV nmv; + PGeoBucket bucket; + struct order_spec *ord; + + create_order_spec(0,0,&ord); + nd_init_ord(ord); + get_vars((Obj)f,&fv); + if ( f->row != f->col ) + error("nd_det : non-square matrix"); + n = f->row; + for ( nvar = 0, tv = fv; tv; tv = NEXT(tv), nvar++ ); + m = f->body; + for ( i = 0, max = 0; i < n; i++ ) + for ( j = 0; j < n; j++ ) + for ( tv = fv; tv; tv = NEXT(tv) ) { + e = getdeg(tv->v,(P)m[i][j]); + max = MAX(e,max); + } + nd_setup_parameters(nvar,1024); + dm = (NDV **)almat_pointer(n,n); + for ( i = 0, max = 0; 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]); + if ( dm[i][j] && !LEN(dm[i][j]) ) dm[i][j] = 0; + } + d = ptondv(CO,fv,(P)ONE); + if ( mod ) ndv_mod(mod,d); + chsgnq(ONE,&mone); + for ( j = 0, sgn = 1; j < n; j++ ) { + if ( DP_Print ) fprintf(stderr,"j=%d\n",j); + for ( i = j; i < n && !dm[i][j]; i++ ); + if ( i == n ) { + *rp = 0; + return; + } + k0 = i; l0 = j; len0 = LEN(dm[k0][l0]); + for ( k = j; k < n; k++ ) + for ( l = j; l < n; l++ ) + if ( dm[k][l] && LEN(dm[k][l]) < len0 ) { + k0 = k; l0 = l; len0 = LEN(dm[k][l]); + } + if ( k0 != j ) { + t = dm[j]; dm[j] = dm[k0]; dm[k0] = t; + sgn = -sgn; + } + if ( l0 != j ) { + for ( k = j; k < n; k++ ) { + s = dm[k][j]; dm[k][j] = dm[k][l0]; dm[k][l0] = s; + } + sgn = -sgn; + } + for ( i = j+1, mj = dm[j], mjj = mj[j]; i < n; i++ ) { + if ( DP_Print ) fprintf(stderr," i=%d\n ",i); + mi = dm[i]; mij = mi[j]; + if ( mod ) + ndv_mul_c(mod,mij,mod-1); + else + ndv_mul_c_q(mij,mone); + for ( k = j+1; k < n; k++ ) { + if ( DP_Print ) fprintf(stderr,"k=%d ",k); + bucket = create_pbucket(); + if ( mi[k] ) { + nmv = BDY(mjj); len = LEN(mjj); + for ( a = 0; a < len; a++, NMV_ADV(nmv) ) { + u = ndv_mul_nmv_trunc(mod,nmv,mi[k],DL(BDY(d))); + add_pbucket(mod,bucket,u); + } + } + if ( mj[k] && mij ) { + nmv = BDY(mij); len = LEN(mij); + for ( a = 0; a < len; a++, NMV_ADV(nmv) ) { + u = ndv_mul_nmv_trunc(mod,nmv,mj[k],DL(BDY(d))); + add_pbucket(mod,bucket,u); + } + } + u = nd_quo(mod,bucket,d); + mi[k] = ndtondv(mod,u); + } + if ( DP_Print ) fprintf(stderr,"\n",k); + } + d = mjj; + } + if ( sgn < 0 ) + if ( mod ) + ndv_mul_c(mod,d,mod-1); + else + ndv_mul_c_q(d,mone); + *rp = ndvtop(mod,CO,fv,d); +} + +ND ndv_mul_nmv_trunc(int mod,NMV m0,NDV p,UINT *d) +{ + NM mr,mr0; + NM tnm; + NMV m; + UINT *d0,*dt,*dm; + int c,n,td,i,c1,c2,len; + Q q; + ND r; + + if ( !p ) return 0; + else { + n = NV(p); m = BDY(p); len = LEN(p); + d0 = DL(m0); + td = TD(d); + mr0 = 0; + NEWNM(tnm); + if ( mod ) { + c = CM(m0); + for ( i = 0; i < len; i++, NMV_ADV(m) ) { + ndl_add(DL(m),d0,DL(tnm)); + if ( ndl_reducible(DL(tnm),d) ) { + NEXTNM(mr0,mr); + c1 = CM(m); DMAR(c1,c,0,mod,c2); CM(mr) = c2; + ndl_copy(DL(tnm),DL(mr)); + } + } + } else { + q = CQ(m0); + for ( i = 0; i < len; i++, NMV_ADV(m) ) { + ndl_add(DL(m),d0,DL(tnm)); + if ( ndl_reducible(DL(tnm),d) ) { + NEXTNM(mr0,mr); + mulq(CQ(m),q,&CQ(mr)); + ndl_copy(DL(tnm),DL(mr)); + } + } + } + if ( !mr0 ) + return 0; + else { + NEXT(mr) = 0; + for ( len = 0, mr = mr0; mr; mr = NEXT(mr), len++ ); + MKND(NV(p),mr0,len,r); + SG(r) = SG(p) + TD(d0); + return r; + } + } }