[BACK]Return to nd.c CVS log [TXT][DIR] Up to [local] / OpenXM_contrib2 / asir2000 / engine

Diff for /OpenXM_contrib2/asir2000/engine/nd.c between version 1.86 and 1.94

version 1.86, 2003/10/28 08:47:01 version 1.94, 2004/03/15 07:30:44
Line 1 
Line 1 
 /* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.85 2003/10/28 03:23:40 noro Exp $ */  /* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.93 2004/03/13 07:48:30 noro Exp $ */
   
 #include "ca.h"  #include "nd.h"
 #include "parse.h"  
 #include "ox.h"  
 #include "inline.h"  
 #include <time.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 (*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;  static int ndv_alloc;
   #if 1
 static int nd_f4_nsp=0x7fffffff;  static int nd_f4_nsp=0x7fffffff;
   #else
   static int nd_f4_nsp=50;
   #endif
 static double nd_scale=2;  static double nd_scale=2;
 static UINT **nd_bound;  static UINT **nd_bound;
 static struct order_spec *nd_ord;  static struct order_spec *nd_ord;
Line 129  static int nd_epw,nd_bpe,nd_wpd,nd_exporigin;
Line 25  static int nd_epw,nd_bpe,nd_wpd,nd_exporigin;
 static UINT nd_mask[32];  static UINT nd_mask[32];
 static UINT nd_mask0,nd_mask1;  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;
 static NDV *nd_ps_trace;  static NDV *nd_ps_trace;
 static RHist *nd_psh;  static RHist *nd_psh;
Line 141  static int nd_psn,nd_pslen;
Line 33  static int nd_psn,nd_pslen;
 static RHist *nd_red;  static RHist *nd_red;
   
 static int nd_found,nd_create,nd_notfirst;  static int nd_found,nd_create,nd_notfirst;
 static int nm_adv;  
 static int nmv_adv;  static int nmv_adv;
 static int nd_dcomp;  
 static int nd_demand;  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)<<nd_epos[a].s))  
 #define XOR_EXP(r,a,e) ((r)[nd_epos[a].i] ^= ((e)<<nd_epos[a].s))  
   
 #define GET_EXP_OLD(d,a) (((d)[oepos[a].i]>>oepos[a].s)&omask0)  
 #define PUT_EXP_OLD(r,a,e) ((r)[oepos[a].i] |= ((e)<<oepos[a].s))  
   
 /* macros for term comparison */  
 #define TD_DL_COMPARE(d1,d2)\  
 (TD(d1)>TD(d2)?1:(TD(d1)<TD(d2)?-1:ndl_lex_compare(d1,d2)))  
 #if 0  
 #define DL_COMPARE(d1,d2)\  
 (nd_dcomp>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()  void nd_free_private_storage()
 {  {
         _nm_free_list = 0;          _nm_free_list = 0;
Line 1213  ND nd_add(int mod,ND p1,ND p2)
Line 873  ND nd_add(int mod,ND p1,ND p2)
         }          }
 }  }
   
 ND nd_add_q(ND p1,ND p2)  
 {  
         int n,c,can;  
         ND r;  
         NM m1,m2,mr0,mr,s;  
         Q t;  
   
         if ( !p1 ) return p2;  
         else if ( !p2 ) return p1;  
         else {  
                 can = 0;  
                 for ( n = NV(p1), m1 = BDY(p1), m2 = BDY(p2), mr0 = 0; m1 && m2; ) {  
                         c = DL_COMPARE(DL(m1),DL(m2));  
                         switch ( c ) {  
                                 case 0:  
                                         addq(CQ(m1),CQ(m2),&t);  
                                         s = m1; m1 = NEXT(m1);  
                                         if ( t ) {  
                                                 can++; NEXTNM2(mr0,mr,s); CQ(mr) = (t);  
                                         } else {  
                                                 can += 2; FREENM(s);  
                                         }  
                                         s = m2; m2 = NEXT(m2); FREENM(s);  
                                         break;  
                                 case 1:  
                                         s = m1; m1 = NEXT(m1); NEXTNM2(mr0,mr,s);  
                                         break;  
                                 case -1:  
                                         s = m2; m2 = NEXT(m2); NEXTNM2(mr0,mr,s);  
                                         break;  
                         }  
                 }  
                 if ( !mr0 )  
                         if ( m1 ) mr0 = m1;  
                         else if ( m2 ) mr0 = m2;  
                         else return 0;  
                 else if ( m1 ) NEXT(mr) = m1;  
                 else if ( m2 ) NEXT(mr) = m2;  
                 else NEXT(mr) = 0;  
                 BDY(p1) = mr0;  
                 SG(p1) = MAX(SG(p1),SG(p2));  
                 LEN(p1) = LEN(p1)+LEN(p2)-can;  
                 FREEND(p2);  
                 return p1;  
         }  
 }  
   
 ND nd_add_sf(ND p1,ND p2)  ND nd_add_sf(ND p1,ND p2)
 {  {
         int n,c,can;          int n,c,can;
Line 1758  ND normalize_pbucket(int mod,PGeoBucket g)
Line 1371  ND normalize_pbucket(int mod,PGeoBucket g)
         return r;          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 */  /* return value = 0 => input is not a GB */
   
 NODE nd_gb(int m,int ishomo,int checkonly)  NODE nd_gb(int m,int ishomo,int checkonly)
Line 1781  NODE nd_gb(int m,int ishomo,int checkonly)
Line 1433  NODE nd_gb(int m,int ishomo,int checkonly)
 again:  again:
                 l = nd_minp(d,&d);                  l = nd_minp(d,&d);
                 if ( SG(l) != sugar ) {                  if ( SG(l) != sugar ) {
                         if ( ishomo ) {                          if ( ishomo ) do_diagonalize(sugar,m);
                                 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;  
                                 }  
                         }  
                         sugar = SG(l);                          sugar = SG(l);
                         if ( DP_Print ) fprintf(asir_out,"%d",sugar);                          if ( DP_Print ) fprintf(asir_out,"%d",sugar);
                 }                  }
Line 1852  again:
Line 1476  again:
         return g;          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)  NODE nd_gb_trace(int m,int ishomo)
 {  {
         int i,nh,sugar,stat;          int i,nh,sugar,stat;
Line 1873  NODE nd_gb_trace(int m,int ishomo)
Line 1544  NODE nd_gb_trace(int m,int ishomo)
 again:  again:
                 l = nd_minp(d,&d);                  l = nd_minp(d,&d);
                 if ( SG(l) != sugar ) {                  if ( SG(l) != sugar ) {
                         if ( ishomo ) {                          if ( ishomo ) do_diagonalize_trace(sugar,m);
                                 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;  
                                 }  
                         }  
                         sugar = SG(l);                          sugar = SG(l);
                         if ( DP_Print ) fprintf(asir_out,"%d",sugar);                          if ( DP_Print ) fprintf(asir_out,"%d",sugar);
                 }                  }
Line 2401  void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe
Line 2035  void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe
         ndv_alloc = 0;          ndv_alloc = 0;
         get_vars((Obj)f,&fv); pltovl(v,&vv);          get_vars((Obj)f,&fv); pltovl(v,&vv);
         for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ );          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);          nd_init_ord(ord);
         for ( t = BDY(f), max = 0; t; t = NEXT(t) )          for ( t = BDY(f), max = 0; t; t = NEXT(t) )
                 for ( tv = vv; tv; tv = NEXT(tv) ) {                  for ( tv = vv; tv; tv = NEXT(tv) ) {
Line 2433  void nd_gr(LIST f,LIST v,int m,int f4,struct order_spe
Line 2075  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)  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;          VL tv,fv,vv,vc;
         NODE fd,fd0,in0,in,r,r0,t,s,cand;          NODE fd,fd0,in0,in,r,r0,t,s,cand;
         int m,nocheck,nvar,mindex,e,max;          int m,nocheck,nvar,mindex,e,max;
Line 2445  void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru
Line 2087  void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru
   
         get_vars((Obj)f,&fv); pltovl(v,&vv);          get_vars((Obj)f,&fv); pltovl(v,&vv);
         for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ );          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;          nocheck = 0;
         mindex = 0;          mindex = 0;
   
Line 2484  void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru
Line 2134  void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru
                                 wmax = MAX(TD(DL(a)),wmax);                                  wmax = MAX(TD(DL(a)),wmax);
                 }                  }
                 homogenize_order(ord,nvar,&ord1);                  homogenize_order(ord,nvar,&ord1);
                 nd_init_ord(&ord1);                  nd_init_ord(ord1);
                 nd_setup_parameters(nvar+1,wmax);                  nd_setup_parameters(nvar+1,wmax);
                 for ( t = fd0; t; t = NEXT(t) )                  for ( t = fd0; t; t = NEXT(t) )
                         ndv_homogenize((NDV)BDY(t),obpe,oadv,oepos);                          ndv_homogenize((NDV)BDY(t),obpe,oadv,oepos);
Line 2523  void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru
Line 2173  void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru
                         m = get_lprime(++mindex);                          m = get_lprime(++mindex);
                         /* reset the parameters */                          /* reset the parameters */
                         if ( !ishomo && homo ) {                          if ( !ishomo && homo ) {
                                 nd_init_ord(&ord1);                                  nd_init_ord(ord1);
                                 nd_setup_parameters(nvar+1,wmax);                                  nd_setup_parameters(nvar+1,wmax);
                         } else {                          } else {
                                 nd_init_ord(ord);                                  nd_init_ord(ord);
Line 2754  void ndv_dehomogenize(NDV p,struct order_spec *ord)
Line 2404  void ndv_dehomogenize(NDV p,struct order_spec *ord)
         for ( m = BDY(p), i = 0; i < len; NMV_ADV(m), i++ )          for ( m = BDY(p), i = 0; i < len; NMV_ADV(m), i++ )
                 ndl_dehomogenize(DL(m));                  ndl_dehomogenize(DL(m));
         if ( newwpd != nd_wpd ) {          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++ ) {                  for ( m = r = BDY(p), i = 0; i < len; NMV_ADV(m), NDV_NADV(r), i++ ) {
                         CQ(r) = CQ(m);                          CQ(r) = CQ(m);
                         for ( j = 0; j < newexporigin; j++ ) DL(r)[j] = DL(m)[j];                          for ( j = 0; j < newexporigin; j++ ) DL(r)[j] = DL(m)[j];
Line 2950  void nd_setup_parameters(int nvar,int max) {
Line 2600  void nd_setup_parameters(int nvar,int max) {
                 nd_mask[nd_epw-i-1] = (nd_mask0<<(i*nd_bpe));                  nd_mask[nd_epw-i-1] = (nd_mask0<<(i*nd_bpe));
                 nd_mask1 |= (1<<(nd_bpe-1))<<(i*nd_bpe);                  nd_mask1 |= (1<<(nd_bpe-1))<<(i*nd_bpe);
         }          }
         nm_adv = sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT);          nmv_adv = ROUND_FOR_ALIGN(sizeof(struct oNMV)+(nd_wpd-1)*sizeof(UINT));
         nmv_adv = sizeof(struct oNMV)+(nd_wpd-1)*sizeof(UINT);  
         nd_epos = nd_create_epos(nd_ord);          nd_epos = nd_create_epos(nd_ord);
         nd_blockmask = nd_create_blockmask(nd_ord);          nd_blockmask = nd_create_blockmask(nd_ord);
 }  }
Line 4412  NODE nd_f4_red_dist(int m,ND_pairs sp0,UINT *s0vect,in
Line 4061  NODE nd_f4_red_dist(int m,ND_pairs sp0,UINT *s0vect,in
         nd_send_int(nd_wpd);          nd_send_int(nd_wpd);
         nd_send_int(nmv_adv);          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);          nd_send_int(nd_psn);
         for ( i = 0; i < nd_psn; i++ ) nd_send_ndv(nd_ps[i]);          for ( i = 0; i < nd_psn; i++ ) nd_send_ndv(nd_ps[i]);
Line 4458  void nd_exec_f4_red_dist()
Line 4107  void nd_exec_f4_red_dist()
         ND_pairs *sp0;          ND_pairs *sp0;
         int *colstat;          int *colstat;
         int a,sprow,rank;          int a,sprow,rank;
         struct order_spec ord;          struct order_spec *ord;
         Obj ordspec;          Obj ordspec;
         ND spol;          ND spol;
         int maxrs;          int maxrs;
Line 4473  void nd_exec_f4_red_dist()
Line 4122  void nd_exec_f4_red_dist()
         nmv_adv = nd_recv_int();          nmv_adv = nd_recv_int();
   
         loadobj(nd_read,&ordspec);          loadobj(nd_read,&ordspec);
         create_order_spec(ordspec,&ord);          create_order_spec(0,ordspec,&ord);
         nd_init_ord(&ord);          nd_init_ord(ord);
         nd_setup_parameters(nd_nvar,0);          nd_setup_parameters(nd_nvar,0);
   
         nd_psn = nd_recv_int();          nd_psn = nd_recv_int();

Legend:
Removed from v.1.86  
changed lines
  Added in v.1.94

FreeBSD-CVSweb <freebsd-cvsweb@FreeBSD.org>