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

Diff for /OpenXM_contrib2/asir2000/builtin/gr.c between version 1.22 and 1.60

version 1.22, 2001/09/05 01:57:32 version 1.60, 2005/11/16 23:42:53
Line 45 
Line 45 
  * DEVELOPER SHALL HAVE NO LIABILITY IN CONNECTION WITH THE USE,   * DEVELOPER SHALL HAVE NO LIABILITY IN CONNECTION WITH THE USE,
  * PERFORMANCE OR NON-PERFORMANCE OF THE SOFTWARE.   * PERFORMANCE OR NON-PERFORMANCE OF THE SOFTWARE.
  *   *
  * $OpenXM: OpenXM_contrib2/asir2000/builtin/gr.c,v 1.21 2001/09/04 08:48:19 noro Exp $   * $OpenXM: OpenXM_contrib2/asir2000/builtin/gr.c,v 1.59 2005/02/17 06:27:35 noro Exp $
 */  */
 #include "ca.h"  #include "ca.h"
 #include "parse.h"  #include "parse.h"
 #include "base.h"  #include "base.h"
 #include "ox.h"  #include "ox.h"
   
 #define ITOS(p) (((unsigned int)(p))&0x7fffffff)  #if defined(__GNUC__)
 #define STOI(i) ((P)((unsigned int)(i)|0x80000000))  #define INLINE inline
   #elif defined(VISUAL)
   #define INLINE __inline
   #else
   #define INLINE
   #endif
   
 #define NEXTVL(r,c) \  
 if(!(r)){NEWVL(r);(c)=(r);}else{NEWVL(NEXT(c));(c)=NEXT(c);}  
   
 #define HMAG(p) (p_mag(BDY(p)->c))  #define HMAG(p) (p_mag(BDY(p)->c))
   
 struct dp_pairs {  #define NEWDP_pairs ((DP_pairs)MALLOC(sizeof(struct dp_pairs)))
         int dp1, dp2;  
         DL lcm;  
         int sugar;  
         struct dp_pairs *next;  
 };  
   
 typedef struct dp_pairs *DP_pairs;  static DP_pairs collect_pairs_of_hdlcm( DP_pairs d1, DP_pairs *prest );
   double get_rtime();
   
 #define NEWDPP(a) ((a)=(DP_pairs)MALLOC(sizeof(struct dp_pairs)))  
   
 #define NEXTDPP(r,c) \  
 if(!(r)){NEWDPP(r);(c)=(r);}else{NEWDPP(NEXT(c));(c)=NEXT(c);}  
   
 struct oEGT eg_nf,eg_nfm;  struct oEGT eg_nf,eg_nfm;
 struct oEGT eg_znfm,eg_pz,eg_np,eg_ra,eg_mc,eg_gc;  struct oEGT eg_znfm,eg_pz,eg_np,eg_ra,eg_mc,eg_gc;
 int TP,NBP,NMP,NFP,NDP,ZR,NZR;  int TP,N_BP,NMP,NFP,NDP,ZR,NZR;
   
 #define NEWDP_pairs ((DP_pairs)MALLOC(sizeof(struct dp_pairs)))  
   
 extern int (*cmpdl)();  extern int (*cmpdl)();
 extern int do_weyl;  extern int do_weyl;
   
 extern DP_Print;  extern DP_Print;
   
 void dp_imul_d(DP,Q,DP *);  
 void print_stat(void);  
 void init_stat(void);  
 int dp_load_t(int,DP *);  
 void dp_load(int,DP *);  
 void dp_save(int,Obj,char *);  
 void dp_make_flaglist(LIST *);  
 void dp_set_flag(Obj,Obj);  
 int membercheck(NODE,NODE);  
 int gbcheck(NODE);  
 int dl_redble(DL,DL);  
 NODE remove_reducibles(NODE,int);  
 NODE updbase(NODE,int);  
 DP_pairs criterion_F(DP_pairs);  
 int criterion_2(int,int);  
 static DP_pairs collect_pairs_of_hdlcm(DP_pairs,DP_pairs *);  
 DP_pairs criterion_M(DP_pairs);  
 DP_pairs criterion_B(DP_pairs,int);  
 DP_pairs newpairs(NODE,int);  
 DP_pairs updpairs(DP_pairs,NODE,int);  
 void _dp_nf(NODE,DP,DP *,int,DP *);  
 void _dp_nf_z(NODE,DP,DP *,int,int,DP *);  
 NODE gb_mod(NODE,int);  
 NODE gbd(NODE,int,NODE,NODE);  
 NODE gb(NODE,int,NODE);  
 NODE gb_f4(NODE);  
 NODE gb_f4_mod(NODE,int);  
 DP_pairs minp(DP_pairs, DP_pairs *);  
 void minsugar(DP_pairs,DP_pairs *,DP_pairs *);  
 NODE append_one(NODE,int);  
 void reducebase_dehomo(NODE,NODE *);  
 int newps_mod(DP,int);  
 int newps_nosave(DP,int,NODE);  
 int newps(DP,int,NODE);  
 void reduceall_mod(NODE,int,NODE *);  
 void reduceall(NODE,NODE *);  
 NODE NODE_sortbi(NODE,int);  
 NODE NODE_sortbi_insert(int, NODE,int);  
 NODE NODE_sortb(NODE,int);  
 NODE NODE_sortb_insert(DP,NODE,int);  
 void prim_part(DP,int,DP *);  
 void setup_arrays(NODE,int,NODE *);  
 int validhc(P,int,NODE);  
 void vlminus(VL,VL,VL *);  
 void printsubst(NODE);  
 void makesubst(VL,NODE *);  
 void pltovl(LIST,VL *);  
 void printdl(DL);  
 int DPPlength(DP_pairs);  
 void dp_gr_mod_main(LIST,LIST,Num,int,struct order_spec *,LIST *);  
 void dp_gr_main(LIST,LIST,Num,int,int,struct order_spec *,LIST *);  
 void dp_f4_main(LIST,LIST,struct order_spec *,LIST *);  
 void dp_f4_mod_main(LIST,LIST,int,struct order_spec *,LIST *);  
 double get_rtime();  
 void _dpmod_to_vect(DP,DL *,int *);  
 void dp_to_vect(DP,DL *,Q *);  
 NODE dp_dllist(DP f);  
 NODE symb_merge(NODE,NODE,int),_symb_merge(NODE,NODE,int);  
 extern int dp_nelim;  extern int dp_nelim;
 extern int dp_fcoeffs;  extern int dp_fcoeffs;
 static DP *ps,*psm;  static DP *ps,*psm;
Line 156  static VL VC;
Line 89  static VL VC;
   
 int PCoeffs;  int PCoeffs;
 int DP_Print = 0;  int DP_Print = 0;
   int DP_PrintShort = 0;
 int DP_Multiple = 0;  int DP_Multiple = 0;
 int DP_NFStat = 0;  int DP_NFStat = 0;
 LIST Dist = 0;  LIST Dist = 0;
Line 163  int NoGCD = 0;
Line 97  int NoGCD = 0;
 int GenTrace = 0;  int GenTrace = 0;
 int OXCheck = -1;  int OXCheck = -1;
   
 static int NoSugar = 0;  int NoSugar = 0;
 static int NoCriB = 0;  static int NoCriB = 0;
 static int NoGC = 0;  static int NoGC = 0;
 static int NoMC = 0;  static int NoMC = 0;
 static int NoRA = 0;  static int NoRA = 0;
 static int DP_PrintShort = 0;  
 static int ShowMag = 0;  static int ShowMag = 0;
 static int Stat = 0;  static int Stat = 0;
 static int Denominator = 1;  static int Denominator = 1;
 static int Top = 0;  int Top = 0;
 static int Reverse = 0;  int Reverse = 0;
 static int Max_mag = 0;  static int Max_mag = 0;
 static char *Demand = 0;  static int Max_coef = 0;
   char *Demand = 0;
 static int PtozpRA = 0;  static int PtozpRA = 0;
   
 int doing_f4;  int doing_f4;
 NODE TraceList;  NODE TraceList;
   NODE AllTraceList;
   
 int eqdl(nv,dl1,dl2)  void Pox_cmo_rpc(NODE,Obj *);
 int nv;  void Pox_rpc(NODE,Obj *);
 DL dl1,dl2;  void Pox_pop_local(NODE,Obj *);
   
   INLINE int eqdl(int nv,DL dl1,DL dl2)
 {  {
         int i;          int i;
         int *b1,*b2;          int *p1,*p2;
   
         if ( dl1->td != dl2->td )          if ( dl1->td != dl2->td )
                 return 0;                  return 0;
         for ( i = 0, b1 = dl1->d, b2 = dl2->d; i < nv; i++ )          i = nv-1;
                 if ( b1[i] != b2[i] )          p1 = dl1->d;
                         break;          p2 = dl2->d;
         if ( i == nv )          while ( i >= 7 ) {
                 return 1;                  if ( *p1++ != *p2++ ) return 0;
         else                  if ( *p1++ != *p2++ ) return 0;
                 return 0;                  if ( *p1++ != *p2++ ) return 0;
                   if ( *p1++ != *p2++ ) return 0;
                   if ( *p1++ != *p2++ ) return 0;
                   if ( *p1++ != *p2++ ) return 0;
                   if ( *p1++ != *p2++ ) return 0;
                   if ( *p1++ != *p2++ ) return 0;
                   i -= 8;
           }
           switch ( i ) {
                   case 6:
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           return 1;
                   case 5:
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           return 1;
                   case 4:
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           return 1;
                   case 3:
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           return 1;
                   case 2:
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           return 1;
                   case 1:
                           if ( *p1++ != *p2++ ) return 0;
                           if ( *p1++ != *p2++ ) return 0;
                           return 1;
                   case 0:
                           if ( *p1++ != *p2++ ) return 0;
                           return 1;
                   default:
                           return 1;
           }
 }  }
   
 /* b[] should be cleared */  /* b[] should be cleared */
   
 void _dpmod_to_vect(f,at,b)  void _dpmod_to_vect(DP f,DL *at,int *b)
 DP f;  
 DL *at;  
 int *b;  
 {  {
         int i,nv;          int i,nv;
         MP m;          MP m;
Line 216  int *b;
Line 203  int *b;
         }          }
 }  }
   
 void dp_to_vect(f,at,b)  /* [t,findex] -> tf -> compressed vector */
 DP f;  
 DL *at;  void _tf_to_vect_compress(NODE tf,DL *at,CDP *b)
 Q *b;  
 {  {
           int i,j,k,nv,len;
           DL t,s,d1;
           DP f;
           MP m;
           CDP r;
   
           t = (DL)BDY(tf);
           f = ps[(int)BDY(NEXT(tf))];
   
           nv = f->nv;
           for ( m = BDY(f), len = 0; m; m = NEXT(m), len++ );
           r = (CDP)MALLOC(sizeof(struct oCDP));
           r->len = len;
           r->psindex = (int)BDY(NEXT(tf));
           r->body = (unsigned int *)MALLOC_ATOMIC(sizeof(unsigned int)*len);
   
           NEWDL_NOINIT(s,nv);
           for ( m = BDY(f), i = j = 0; m; m = NEXT(m), j++ ) {
                   d1 = m->dl;
                   s->td = t->td+d1->td;
                   for ( k = 0; k < nv; k++ )
                           s->d[k] = t->d[k]+d1->d[k];
                   for ( ; !eqdl(nv,s,at[i]); i++ );
                   r->body[j] = i;
           }
           *b = r;
   }
   
   void dp_to_vect(DP f,DL *at,Q *b)
   {
         int i,nv;          int i,nv;
         MP m;          MP m;
   
Line 231  Q *b;
Line 247  Q *b;
         }          }
 }  }
   
 NODE dp_dllist(f)  NODE dp_dllist(DP f)
 DP f;  
 {  {
         MP m;          MP m;
         NODE mp,mp0;          NODE mp,mp0;
Line 247  DP f;
Line 262  DP f;
         return mp0;          return mp0;
 }  }
   
 void pdl(f)  NODE mul_dllist(DL d,DP f)
 NODE f;  
 {  {
           MP m;
           NODE mp,mp0;
           DL t,d1;
           int i,nv;
   
           if ( !f )
                   return 0;
           nv = NV(f);
           mp0 = 0;
           for ( m = BDY(f); m; m = NEXT(m) ) {
                   NEXTNODE(mp0,mp);
                   NEWDL_NOINIT(t,nv);
                   d1 = m->dl;
                   t->td = d->td+d1->td;
                   for ( i = 0; i < nv; i++ )
                           t->d[i] = d->d[i]+d1->d[i];
                   BDY(mp) = (pointer)t;
           }
           NEXT(mp) = 0;
           return mp0;
   }
   
   void pdl(NODE f)
   {
         while ( f ) {          while ( f ) {
                 printdl(BDY(f)); f = NEXT(f);                  printdl(BDY(f)); f = NEXT(f);
         }          }
Line 257  NODE f;
Line 295  NODE f;
         printf("\n");          printf("\n");
 }  }
   
 void dp_gr_main(f,v,homo,modular,field,ord,rp)  void dp_gr_main(LIST f,LIST v,Num homo,int modular,int field,struct order_spec *ord,LIST *rp)
 LIST f,v;  
 Num homo;  
 int modular,field;  
 struct order_spec *ord;  
 LIST *rp;  
 {  {
         int i,mindex,m,nochk;          int i,mindex,m,nochk;
         struct order_spec ord1;          struct order_spec *ord1;
           Q q;
         VL fv,vv,vc;          VL fv,vv,vc;
         NODE fd,fd0,fi,fi0,r,r0,t,subst,x,s,xx;          NODE fd,fd0,fi,fi0,r,r0,t,subst,x,s,xx;
           NODE ind,ind0;
           LIST trace,gbindex;
           int input_is_dp = 0;
   
         mindex = 0; nochk = 0; dp_fcoeffs = field;          mindex = 0; nochk = 0; dp_fcoeffs = field;
         get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&vc);          get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&vc);
Line 280  LIST *rp;
Line 317  LIST *rp;
                 homogenize_order(ord,NVars,&ord1);                  homogenize_order(ord,NVars,&ord1);
                 for ( fd0 = fi0 = 0, t = BDY(f); t; t = NEXT(t) ) {                  for ( fd0 = fi0 = 0, t = BDY(f); t; t = NEXT(t) ) {
                         NEXTNODE(fd0,fd); NEXTNODE(fi0,fi);                          NEXTNODE(fd0,fd); NEXTNODE(fi0,fi);
                         ptod(CO,vv,(P)BDY(t),(DP *)&BDY(fi)); dp_homo((DP)BDY(fi),(DP *)&BDY(fd));                          if ( BDY(t) && OID(BDY(t)) == O_DP ) {
                                   dp_sort((DP)BDY(t),(DP *)&BDY(fi)); input_is_dp = 1;
                           } else
                                   ptod(CO,vv,(P)BDY(t),(DP *)&BDY(fi));
                           dp_homo((DP)BDY(fi),(DP *)&BDY(fd));
                 }                  }
                 if ( fd0 ) NEXT(fd) = 0;                  if ( fd0 ) NEXT(fd) = 0;
                 if ( fi0 ) NEXT(fi) = 0;                  if ( fi0 ) NEXT(fi) = 0;
                 initd(&ord1);                  initd(ord1);
         } else {          } else {
                 for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) {                  for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) {
                         NEXTNODE(fd0,fd); ptod(CO,vv,(P)BDY(t),(DP *)&BDY(fd));                          NEXTNODE(fd0,fd);
                           if ( BDY(t) && OID(BDY(t)) == O_DP ) {
                                   dp_sort((DP)BDY(t),(DP *)&BDY(fd)); input_is_dp = 1;
                           } else
                                   ptod(CO,vv,(P)BDY(t),(DP *)&BDY(fd));
                 }                  }
                 if ( fd0 ) NEXT(fd) = 0;                  if ( fd0 ) NEXT(fd) = 0;
                 fi0 = fd0;                  fi0 = fd0;
Line 304  LIST *rp;
Line 349  LIST *rp;
         init_stat();          init_stat();
         while ( 1 ) {          while ( 1 ) {
                 if ( homo ) {                  if ( homo ) {
                         initd(&ord1); CNVars = NVars+1;                          initd(ord1); CNVars = NVars+1;
                 }                  }
                 if ( DP_Print && modular ) {                  if ( DP_Print && modular ) {
                         fprintf(asir_out,"mod= %d, eval = ",m); printsubst(subst);                          fprintf(asir_out,"mod= %d, eval = ",m); printsubst(subst);
Line 333  LIST *rp;
Line 378  LIST *rp;
                         pss[i] = 0; psh[i] = 0; psc[i] = 0; ps[i] = 0;                          pss[i] = 0; psh[i] = 0; psc[i] = 0; ps[i] = 0;
                 }                  }
         }          }
         for ( r0 = 0; x; x = NEXT(x) ) {          for ( r0 = 0, ind0 = 0; x; x = NEXT(x) ) {
                 NEXTNODE(r0,r); dp_load((int)BDY(x),&ps[(int)BDY(x)]);                  NEXTNODE(r0,r); dp_load((int)BDY(x),&ps[(int)BDY(x)]);
                 dtop(CO,vv,ps[(int)BDY(x)],(P *)&BDY(r));                  if ( input_is_dp )
                           BDY(r) = (pointer)ps[(int)BDY(x)];
                   else
                           dtop(CO,vv,ps[(int)BDY(x)],(P *)&BDY(r));
                   NEXTNODE(ind0,ind);
                   STOQ((int)BDY(x),q); BDY(ind) = q;
         }          }
         if ( r0 ) NEXT(r) = 0;          if ( r0 ) NEXT(r) = 0;
           if ( ind0 ) NEXT(ind) = 0;
         MKLIST(*rp,r0);          MKLIST(*rp,r0);
           MKLIST(gbindex,ind0);
   
           if ( GenTrace && OXCheck < 0 ) {
   
                   x = AllTraceList;
                   for ( r = 0; x; x = NEXT(x) ) {
                           MKNODE(r0,BDY(x),r); r = r0;
                   }
                   MKLIST(trace,r);
                   r0 = mknode(3,*rp,gbindex,trace);
                   MKLIST(*rp,r0);
           }
         print_stat();          print_stat();
         if ( ShowMag )          if ( ShowMag )
                 fprintf(asir_out,"\nMax_mag=%d\n",Max_mag);                  fprintf(asir_out,"\nMax_mag=%d, Max_coef=%d\n",Max_mag, Max_coef);
 }  }
   
 void dp_gr_mod_main(f,v,homo,m,ord,rp)  void dp_gr_mod_main(LIST f,LIST v,Num homo,int m,struct order_spec *ord,LIST *rp)
 LIST f,v;  
 Num homo;  
 int m;  
 struct order_spec *ord;  
 LIST *rp;  
 {  {
         struct order_spec ord1;          struct order_spec *ord1;
         VL fv,vv,vc;          VL fv,vv,vc;
         NODE fd,fd0,r,r0,t,x,s,xx;          NODE fd,fd0,r,r0,t,x,s,xx;
         DP a,b,c;          DP a,b,c;
 extern struct oEGT eg_red_mod;          extern struct oEGT eg_red_mod;
           int input_is_dp = 0;
   
         get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&vc);          get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&vc);
         NVars = length((NODE)vv); PCoeffs = vc ? 1 : 0; VC = vc;          NVars = length((NODE)vv); PCoeffs = vc ? 1 : 0; VC = vc;
Line 365  extern struct oEGT eg_red_mod;
Line 424  extern struct oEGT eg_red_mod;
         initd(ord);          initd(ord);
         if ( homo ) {          if ( homo ) {
                 for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) {                  for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) {
                         ptod(CO,vv,(P)BDY(t),&a); dp_homo(a,&b);                          if ( BDY(t) && OID(BDY(t)) == O_DP ) {
                                   dp_sort((DP)BDY(t),&a); input_is_dp = 1;
                           } else
                                   ptod(CO,vv,(P)BDY(t),&a);
                           dp_homo(a,&b);
                         if ( PCoeffs )                          if ( PCoeffs )
                                 dp_mod(b,m,0,&c);                                  dp_mod(b,m,0,&c);
                         else                          else
Line 374  extern struct oEGT eg_red_mod;
Line 437  extern struct oEGT eg_red_mod;
                                 NEXTNODE(fd0,fd); BDY(fd) = (pointer)c;                                  NEXTNODE(fd0,fd); BDY(fd) = (pointer)c;
                         }                          }
                 }                  }
                 homogenize_order(ord,NVars,&ord1); initd(&ord1);                  homogenize_order(ord,NVars,&ord1); initd(ord1);
         } else {          } else {
                 for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) {                  for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) {
                         ptod(CO,vv,(P)BDY(t),&b);                          if ( BDY(t) && OID(BDY(t)) == O_DP ) {
                                   dp_sort((DP)BDY(t),&b); input_is_dp = 1;
                           } else
                                   ptod(CO,vv,(P)BDY(t),&b);
                         if ( PCoeffs )                          if ( PCoeffs )
                                 dp_mod(b,m,0,&c);                                  dp_mod(b,m,0,&c);
                         else                          else
Line 391  extern struct oEGT eg_red_mod;
Line 457  extern struct oEGT eg_red_mod;
         setup_arrays(fd0,m,&s);          setup_arrays(fd0,m,&s);
         init_stat();          init_stat();
         if ( homo ) {          if ( homo ) {
                 initd(&ord1); CNVars = NVars+1;                  initd(ord1); CNVars = NVars+1;
         }          }
 /* init_eg(&eg_red_mod); */  /* init_eg(&eg_red_mod); */
         x = gb_mod(s,m);          x = gb_mod(s,m);
Line 403  extern struct oEGT eg_red_mod;
Line 469  extern struct oEGT eg_red_mod;
         reduceall_mod(x,m,&xx); x = xx;          reduceall_mod(x,m,&xx); x = xx;
         if ( PCoeffs )          if ( PCoeffs )
                 for ( r0 = 0; x; x = NEXT(x) ) {                  for ( r0 = 0; x; x = NEXT(x) ) {
                         NEXTNODE(r0,r); mdtop(CO,m,vv,ps[(int)BDY(x)],(P *)&BDY(r));                          NEXTNODE(r0,r);
                           if ( input_is_dp )
                                   mdtodp(ps[(int)BDY(x)],(DP *)&BDY(r));
                           else
                                   mdtop(CO,m,vv,ps[(int)BDY(x)],(P *)&BDY(r));
                 }                  }
         else          else
                 for ( r0 = 0; x; x = NEXT(x) ) {                  for ( r0 = 0; x; x = NEXT(x) ) {
                         NEXTNODE(r0,r); _dtop_mod(CO,vv,ps[(int)BDY(x)],(P *)&BDY(r));                          NEXTNODE(r0,r);
                           if ( input_is_dp )
                                   _mdtodp(ps[(int)BDY(x)],(DP *)&BDY(r));
                           else
                                   _dtop_mod(CO,vv,ps[(int)BDY(x)],(P *)&BDY(r));
                 }                  }
         print_stat();          print_stat();
         if ( r0 ) NEXT(r) = 0;          if ( r0 ) NEXT(r) = 0;
         MKLIST(*rp,r0);          MKLIST(*rp,r0);
 }  }
   
 void dp_f4_main(f,v,ord,rp)  void dp_f4_main(LIST f,LIST v,struct order_spec *ord,LIST *rp)
 LIST f,v;  
 struct order_spec *ord;  
 LIST *rp;  
 {  {
         int i,mindex,m,nochk;          int homogen;
         struct order_spec ord1;  
         VL fv,vv,vc;          VL fv,vv,vc;
         NODE fd,fd0,fi,fi0,r,r0,t,subst,x,s,xx;          NODE fd,fd0,r,r0,t,x,s,xx;
           int input_is_dp = 0;
   
         dp_fcoeffs = 0;          dp_fcoeffs = 0;
         get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&vc);          get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&vc);
Line 431  LIST *rp;
Line 502  LIST *rp;
         if ( ord->id && NVars != ord->nv )          if ( ord->id && NVars != ord->nv )
                 error("dp_f4_main : invalid order specification");                  error("dp_f4_main : invalid order specification");
         initd(ord);          initd(ord);
         for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) {          for ( fd0 = 0, t = BDY(f), homogen = 1; t; t = NEXT(t) ) {
                 NEXTNODE(fd0,fd); ptod(CO,vv,(P)BDY(t),(DP *)&BDY(fd));                  NEXTNODE(fd0,fd);
                   if ( BDY(t) && OID(BDY(t)) == O_DP ) {
                           dp_sort((DP)BDY(t),(DP *)&BDY(fd)); input_is_dp = 1;
                   } else
                           ptod(CO,vv,(P)BDY(t),(DP *)&BDY(fd));
                   if ( homogen )
                           homogen = dp_homogeneous(BDY(fd));
         }          }
         if ( fd0 ) NEXT(fd) = 0;          if ( fd0 ) NEXT(fd) = 0;
         setup_arrays(fd0,0,&s);          setup_arrays(fd0,0,&s);
         x = gb_f4(s);          x = gb_f4(s);
         reduceall(x,&xx); x = xx;          if ( !homogen ) {
                   reduceall(x,&xx); x = xx;
           }
         for ( r0 = 0; x; x = NEXT(x) ) {          for ( r0 = 0; x; x = NEXT(x) ) {
                 NEXTNODE(r0,r); dp_load((int)BDY(x),&ps[(int)BDY(x)]);                  NEXTNODE(r0,r); dp_load((int)BDY(x),&ps[(int)BDY(x)]);
                 dtop(CO,vv,ps[(int)BDY(x)],(P *)&BDY(r));                  if ( input_is_dp )
                           BDY(r) = (pointer)ps[(int)BDY(x)];
                   else
                           dtop(CO,vv,ps[(int)BDY(x)],(P *)&BDY(r));
         }          }
         if ( r0 ) NEXT(r) = 0;          if ( r0 ) NEXT(r) = 0;
         MKLIST(*rp,r0);          MKLIST(*rp,r0);
 }  }
   
 void dp_f4_mod_main(f,v,m,ord,rp)  void dp_f4_mod_main(LIST f,LIST v,int m,struct order_spec *ord,LIST *rp)
 LIST f,v;  
 int m;  
 struct order_spec *ord;  
 LIST *rp;  
 {  {
         int i;          int homogen;
         struct order_spec ord1;  
         VL fv,vv,vc;          VL fv,vv,vc;
         DP b,c,c1;          DP b,c,c1;
         NODE fd,fd0,fi,fi0,r,r0,t,subst,x,s,xx;          NODE fd,fd0,r,r0,t,x,s,xx;
           int input_is_dp = 0;
   
         dp_fcoeffs = 0;          dp_fcoeffs = 0;
         get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&vc);          get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&vc);
Line 465  LIST *rp;
Line 543  LIST *rp;
         if ( ord->id && NVars != ord->nv )          if ( ord->id && NVars != ord->nv )
                 error("dp_f4_mod_main : invalid order specification");                  error("dp_f4_mod_main : invalid order specification");
         initd(ord);          initd(ord);
         for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) {          for ( fd0 = 0, t = BDY(f), homogen = 1; t; t = NEXT(t) ) {
                 ptod(CO,vv,(P)BDY(t),&b);                  if ( BDY(t) && OID(BDY(t)) == O_DP ) {
                           dp_sort((DP)BDY(t),&b); input_is_dp = 1;
                   } else
                           ptod(CO,vv,(P)BDY(t),&b);
                   if ( homogen )
                           homogen = dp_homogeneous(b);
                 _dp_mod(b,m,0,&c);                  _dp_mod(b,m,0,&c);
                 _dp_monic(c,m,&c1);                  _dp_monic(c,m,&c1);
                 if ( c ) {                  if ( c ) {
Line 475  LIST *rp;
Line 558  LIST *rp;
         }          }
         if ( fd0 ) NEXT(fd) = 0;          if ( fd0 ) NEXT(fd) = 0;
         setup_arrays(fd0,m,&s);          setup_arrays(fd0,m,&s);
         x = gb_f4_mod(s,m);          init_stat();
         reduceall_mod(x,m,&xx); x = xx;          if ( do_weyl )
                   x = gb_f4_mod_old(s,m);
           else
                   x = gb_f4_mod(s,m);
           if ( !homogen ) {
                   reduceall_mod(x,m,&xx); x = xx;
           }
         for ( r0 = 0; x; x = NEXT(x) ) {          for ( r0 = 0; x; x = NEXT(x) ) {
                 NEXTNODE(r0,r); _dtop_mod(CO,vv,ps[(int)BDY(x)],(P *)&BDY(r));                  NEXTNODE(r0,r);
                   if ( input_is_dp )
                           _mdtodp(ps[(int)BDY(x)],(DP *)&BDY(r));
                   else
                           _dtop_mod(CO,vv,ps[(int)BDY(x)],(P *)&BDY(r));
         }          }
         if ( r0 ) NEXT(r) = 0;          if ( r0 ) NEXT(r) = 0;
         MKLIST(*rp,r0);          MKLIST(*rp,r0);
           print_stat();
 }  }
   
 NODE gb_f4(f)  NODE gb_f4(NODE f)
 NODE f;  
 {  {
         int i,j,k,nh,row,col,nv;          int i,k,nh,row,col,nv;
         NODE r,g,gall;          NODE r,g,gall;
         NODE s,s0;          NODE s,s0;
         DP_pairs d,dm,dr,t;          DP_pairs d,dm,dr,t;
         DP h,nf,nf1,f1,f2,f21,f21r,sp,sp1,sd,sdm,tdp;          DP nf,nf1,f2,sp,sd,tdp;
         MP mp,mp0;          MP mp,mp0;
         NODE blist,bt,nt;          NODE blist,bt;
         DL *ht,*at;          DL *ht,*at;
         MAT mat,nm;          MAT mat,nm;
         int *colstat;  
         int *rind,*cind;          int *rind,*cind;
         int rank,nred;          int rank,nred;
         Q dn;          Q dn;
         struct oEGT tmp0,tmp1,tmp2,eg_split_symb,eg_split_elim;          struct oEGT tmp0,tmp1,eg_split_symb;
         extern struct oEGT eg_mod,eg_elim,eg_chrem,eg_gschk,eg_intrat,eg_symb;          extern struct oEGT eg_mod,eg_elim,eg_chrem,eg_gschk,eg_intrat,eg_symb;
   
         init_eg(&eg_mod); init_eg(&eg_elim); init_eg(&eg_chrem);          init_eg(&eg_mod); init_eg(&eg_elim); init_eg(&eg_chrem);
Line 605  NODE f;
Line 697  NODE f;
   
 /* initial bases are monic */  /* initial bases are monic */
   
 NODE gb_f4_mod(f,m)  unsigned int **psca;
 NODE f;  GeoBucket create_bucket();
 int m;  DL remove_head_bucket(GeoBucket,int);
   
   NODE gb_f4_mod(NODE f,int m)
 {  {
         int i,j,k,nh,row,col,nv;          int i,j,k,nh,row,col,nv;
         NODE r,g,gall;          NODE r,g,gall;
         NODE s,s0;          NODE s,s0;
         DP_pairs d,dm,dr,t;          DP_pairs d,dm,dr,t;
         DP h,nf,f1,f2,f21,f21r,sp,sp1,sd,sdm,tdp;          DP nf,sp,sd,tdp;
         MP mp,mp0;          MP mp,mp0;
         NODE blist,bt,nt;          NODE blist,bt,bt1,dt;
           DL *at,*st;
           int **spmat;
           CDP *redmat;
           int *colstat,*w,*w1;
           int rank,nred,nsp,nsp0,nonzero,spcol;
           int *indred,*isred;
           CDP ri;
           int pscalen;
           GeoBucket bucket;
           DL head;
           struct oEGT tmp0,tmp1,eg_split_symb,eg_split_conv,eg_split_elim1,eg_split_elim2;
           extern struct oEGT eg_symb,eg_conv,eg_elim1,eg_elim2;
   
           /* initialize coeffcient array list of ps[] */
           pscalen = pslen;
           psca = (unsigned int **)MALLOC(pscalen*sizeof(unsigned int *));
   
           init_eg(&eg_symb); init_eg(&eg_conv); init_eg(&eg_elim1); init_eg(&eg_elim2);
           for ( gall = g = 0, d = 0, r = f; r; r = NEXT(r) ) {
                   i = (int)BDY(r);
                   d = updpairs(d,g,i);
                   g = updbase(g,i);
                   gall = append_one(gall,i);
                   dptoca(ps[i],&psca[i]);
           }
           if ( gall )
                   nv = ((DP)ps[(int)BDY(gall)])->nv;
           while ( d ) {
                   get_eg(&tmp0);
                   minsugar(d,&dm,&dr); d = dr;
                   if ( DP_Print )
                           fprintf(asir_out,"sugar=%d\n",dm->sugar);
                   blist = 0;
                   bucket = create_bucket();
                   /* asph : sum of all head terms of spoly */
                   for ( t = dm; t; t = NEXT(t) ) {
                           _dp_sp_mod(ps[t->dp1],ps[t->dp2],m,&sp);
   /*                      fprintf(stderr,"splen=%d-",dp_nt(sp)); */
                           if ( sp ) {
                                   MKNODE(bt,sp,blist); blist = bt;
                                   add_bucket(bucket,dp_dllist(sp),nv);
   /*                              fprintf(stderr,"%d-",length(s0)); */
                           }
                   }
   #if 0
                   if ( DP_Print )
                           fprintf(asir_out,"initial spmat : %d x %d ",length(blist),length(s0));
   #endif
                   /* s0 : all the terms appeared in symbolic reduction */
                   nred = 0;
                   s0 = 0;
                   while ( 1 ) {
                           head = remove_head_bucket(bucket,nv);
                           if ( !head ) break;
                           else {
                                   NEXTNODE(s0,s);
                                   BDY(s) = (pointer)head;
                           }
                           for ( r = gall; r; r = NEXT(r) )
                                   if ( _dl_redble(BDY(ps[(int)BDY(r)])->dl,head,nv) )
                                           break;
                           if ( r ) {
                                   dltod(head,nv,&tdp);
                                   dp_subd(tdp,ps[(int)BDY(r)],&sd);
                                   dt = mul_dllist(BDY(sd)->dl,ps[(int)BDY(r)]);
                                   add_bucket(bucket,NEXT(dt),nv);
   /*                              fprintf(stderr,"[%d]",length(dt)); */
                                   /* list of [t,f] */
                                   bt1 = mknode(2,BDY(sd)->dl,BDY(r));
                                   MKNODE(bt,bt1,blist); blist = bt;
   /*                              fprintf(stderr,"%d-",length(s0));  */
                                   nred++;
                           }
                   }
                   if ( s0 ) NEXT(s) = 0;
   /*              fprintf(stderr,"\n"); */
                   get_eg(&tmp1); add_eg(&eg_symb,&tmp0,&tmp1);
                   init_eg(&eg_split_symb); add_eg(&eg_split_symb,&tmp0,&tmp1);
   
                   if ( DP_Print )
                           fprintf(asir_out,"number of reducers : %d\n",nred);
   
                   get_eg(&tmp0);
                   /* the first nred polys in blist are reducers */
                   /* row = the number of all the polys */
                   for ( r = blist, row = 0; r; r = NEXT(r), row++ );
   
                   /* col = number of all terms */
                   for ( s = s0, col = 0; s; s = NEXT(s), col++ );
   
                   /* head terms of all terms */
                   at = (DL *)MALLOC(col*sizeof(DL));
                   for ( s = s0, i = 0; i < col; s = NEXT(s), i++ )
                           at[i] = (DL)BDY(s);
   
                   /* store coefficients separately in spmat and redmat */
                   nsp = row-nred;
   
                   /* reducer matrix */
                   /* indred : register the position of the head term */
                   redmat = (CDP *)MALLOC(nred*sizeof(CDP));
                   for ( i = 0, r = blist; i < nred; r = NEXT(r), i++ )
                           _tf_to_vect_compress(BDY(r),at,&redmat[i]);
   
                   /* register the position of the head term */
                   indred = (int *)MALLOC_ATOMIC(nred*sizeof(int));
                   bzero(indred,nred*sizeof(int));
                   isred = (int *)MALLOC_ATOMIC(col*sizeof(int));
                   bzero(isred,col*sizeof(int));
                   for ( i = 0; i < nred; i++ ) {
                           ri = redmat[i];
                           indred[i] = ri->body[0];
                           isred[indred[i]] = 1;
                   }
   
                   spcol = col-nred;
                   /* head terms not in ht */
                   st = (DL *)MALLOC(spcol*sizeof(DL));
                   for ( j = 0, k = 0; j < col; j++ )
                           if ( !isred[j] )
                                   st[k++] = at[j];
                   get_eg(&tmp1); add_eg(&eg_conv,&tmp0,&tmp1);
                   init_eg(&eg_split_conv); add_eg(&eg_split_conv,&tmp0,&tmp1);
   
                   get_eg(&tmp1);
                   /* spoly matrix; stored in reduced form; terms in ht[] are omitted */
                   spmat = (int **)MALLOC(nsp*sizeof(int *));
                   w = (int *)MALLOC_ATOMIC(col*sizeof(int));
   
                   /* skip reducers in blist */
                   for ( i = 0, r = blist; i < nred; r = NEXT(r), i++ );
                   for ( i = 0; r; r = NEXT(r) ) {
                           bzero(w,col*sizeof(int));
                           _dpmod_to_vect(BDY(r),at,w);
                           reduce_sp_by_red_mod_compress(w,redmat,indred,nred,col,m);
                           for ( j = 0; j < col; j++ )
                                   if ( w[j] )
                                           break;
                           if ( j < col ) {
                                   w1 = (int *)MALLOC_ATOMIC(spcol*sizeof(int));
                                   for ( j = 0, k = 0; j < col; j++ )
                                           if ( !isred[j] )
                                                   w1[k++] = w[j];
                                   spmat[i] = w1;
                                   i++;
                           }
                   }
                   /* update nsp */
                   nsp0 = nsp;
                   nsp = i;
   
                   /* XXX free redmat explicitly */
                   for ( k = 0; k < nred; k++ ) {
                           GC_free(BDY(redmat[k]));
                           GC_free(redmat[k]);
                   }
   
                   get_eg(&tmp0); add_eg(&eg_elim1,&tmp1,&tmp0);
                   init_eg(&eg_split_elim1); add_eg(&eg_split_elim1,&tmp1,&tmp0);
   
                   colstat = (int *)MALLOC_ATOMIC(spcol*sizeof(int));
                   bzero(colstat,spcol*sizeof(int));
                   for ( i = 0, nonzero=0; i < nsp; i++ )
                           for ( j = 0; j < spcol; j++ )
                                   if ( spmat[i][j] )
                                           nonzero++;
                   if ( DP_Print && nsp )
                           fprintf(asir_out,"spmat : %d x %d (nonzero=%f%%)...",
                                   nsp,spcol,((double)nonzero*100)/(nsp*spcol));
                   if ( nsp )
                           rank = generic_gauss_elim_mod(spmat,nsp,spcol,m,colstat);
                   else
                           rank = 0;
                   get_eg(&tmp1); add_eg(&eg_elim2,&tmp0,&tmp1);
                   init_eg(&eg_split_elim2); add_eg(&eg_split_elim2,&tmp0,&tmp1);
   
                   if ( DP_Print ) {
                           fprintf(asir_out,"done rank = %d\n",rank,row,col);
                           print_eg("Symb",&eg_split_symb);
                           print_eg("Conv",&eg_split_conv);
                           print_eg("Elim1",&eg_split_elim1);
                           print_eg("Elim2",&eg_split_elim2);
                           fprintf(asir_out,"\n");
                   }
   
                   NZR += rank;
                   ZR += nsp0-rank;
   
                   if ( !rank )
                           continue;
   
                   for ( j = 0, i = 0; j < spcol; j++ )
                           if ( colstat[j] ) {
                                   mp0 = 0;
                                   NEXTMP(mp0,mp); mp->dl = st[j]; mp->c = STOI(1);
                                   for ( k = j+1; k < spcol; k++ )
                                           if ( !colstat[k] && spmat[i][k] ) {
                                                   NEXTMP(mp0,mp); mp->dl = st[k];
                                                   mp->c = STOI(spmat[i][k]);
                                   }
                                   NEXT(mp) = 0;
                                   MKDP(nv,mp0,nf); nf->sugar = dm->sugar;
                                   nh = newps_mod(nf,m);
                                   if ( nh == pscalen ) {
                                           psca = (unsigned int **)
                                                   REALLOC(psca,2*pscalen*sizeof(unsigned int *));
                                           pscalen *= 2;
                                   }
                                   dptoca(ps[nh],&psca[nh]);
                                   d = updpairs(d,g,nh);
                                   g = updbase(g,nh);
                                   gall = append_one(gall,nh);
                                   i++;
                           }
   
                   /* XXX free spmat[] explicitly */
                   for ( j = 0; j < nsp; j++ ) {
                           GC_free(spmat[j]);
                   }
           }
           if ( DP_Print ) {
                   print_eg("Symb",&eg_symb);
                   print_eg("Conv",&eg_conv);
                   print_eg("Elim1",&eg_elim1);
                   print_eg("Elim2",&eg_elim2);
                   fflush(asir_out);
           }
           return g;
   }
   
   NODE gb_f4_mod_old(NODE f,int m)
   {
           int i,j,k,nh,row,col,nv;
           NODE r,g,gall;
           NODE s,s0;
           DP_pairs d,dm,dr,t;
           DP nf,f2,sp,sd,sdm,tdp;
           MP mp,mp0;
           NODE blist,bt;
         DL *ht,*at,*st;          DL *ht,*at,*st;
         int **spmat,**redmat;          int **spmat,**redmat;
         int *colstat,*w;          int *colstat,*w;
         int rank,nred,nsp,nonzero,spcol;          int rank,nred,nsp,nonzero,spcol;
         int *indred,*isred,*ri;          int *indred,*isred,*ri;
         struct oEGT tmp0,tmp1,tmp2,eg_split_symb,eg_split_elim1,eg_split_elim2;          struct oEGT tmp0,tmp1,eg_split_symb,eg_split_elim1,eg_split_elim2;
         extern struct oEGT eg_symb,eg_elim1,eg_elim2;          extern struct oEGT eg_symb,eg_elim1,eg_elim2;
   
         init_eg(&eg_symb); init_eg(&eg_elim1); init_eg(&eg_elim2);          init_eg(&eg_symb); init_eg(&eg_elim1); init_eg(&eg_elim2);
Line 775  int m;
Line 1108  int m;
         return g;          return g;
 }  }
   
 int DPPlength(n)  int DPPlength(DP_pairs n)
 DP_pairs n;  
 {  {
         int i;          int i;
   
Line 784  DP_pairs n;
Line 1116  DP_pairs n;
         return i;          return i;
 }  }
   
 void printdl(dl)  void printdl(DL dl)
 DL dl;  
 {  {
         int i;          int i;
   
Line 795  DL dl;
Line 1126  DL dl;
         fprintf(asir_out,"%d>>",dl->d[i]);          fprintf(asir_out,"%d>>",dl->d[i]);
 }  }
   
 void pltovl(l,vl)  void pltovl(LIST l,VL *vl)
 LIST l;  
 VL *vl;  
 {  {
         NODE n;          NODE n;
         VL r,r0;          VL r,r0;
Line 810  VL *vl;
Line 1139  VL *vl;
         *vl = r0;          *vl = r0;
 }  }
   
 void makesubst(v,s)  void vltopl(VL vl,LIST *l)
 VL v;  
 NODE *s;  
 {  {
           VL n;
         NODE r,r0;          NODE r,r0;
           P p;
   
           n = vl;
           for ( r0 = 0; n; n = NEXT(n) ) {
                   NEXTNODE(r0,r); MKV(n->v,p); BDY(r) = (pointer)p;
           }
           if ( r0 ) NEXT(r) = 0;
           MKLIST(*l,r0);
   }
   
   void makesubst(VL v,NODE *s)
   {
           NODE r,r0;
         Q q;          Q q;
         unsigned int n;          unsigned int n;
   
Line 831  NODE *s;
Line 1172  NODE *s;
         *s = r0;          *s = r0;
 }  }
   
 void printsubst(s)  void printsubst(NODE s)
 NODE s;  
 {  {
         fputc('[',asir_out);          fputc('[',asir_out);
         while ( s ) {          while ( s ) {
Line 846  NODE s;
Line 1186  NODE s;
         fprintf(asir_out,"]\n"); return;          fprintf(asir_out,"]\n"); return;
 }  }
   
 void vlminus(v,w,d)  void vlminus(VL v,VL w,VL *d)
 VL v,w,*d;  
 {  {
         int i,j,n,m;          int i,j,n,m;
         V *va,*wa;          V *va,*wa;
Line 877  VL v,w,*d;
Line 1216  VL v,w,*d;
         *d = r0;          *d = r0;
 }  }
   
 int validhc(a,m,s)  int validhc(P a,int m,NODE s)
 P a;  
 int m;  
 NODE s;  
 {  {
         P c,c1;          P c,c1;
         V v;          V v;
Line 895  NODE s;
Line 1231  NODE s;
         return c1 ? 1 : 0;          return c1 ? 1 : 0;
 }  }
   
 void setup_arrays(f,m,r)  void setup_arrays(NODE f,int m,NODE *r)
 NODE f,*r;  
 int m;  
 {  {
         int i;          int i;
         NODE s,s0,f0;          NODE s,s0,f0;
Line 920  int m;
Line 1254  int m;
                 pss[i] = ps[i]->sugar;                  pss[i] = ps[i]->sugar;
                 psc[i] = BDY(ps[i])->c;                  psc[i] = BDY(ps[i])->c;
         }          }
         if ( GenTrace && (OXCheck >= 0) ) {          if ( GenTrace ) {
                 Q q;                  Q q;
                 STRING fname;                  STRING fname;
                 LIST input;                  LIST input;
                 NODE arg;                  NODE arg,t,t1;
                 Obj dmy;                  Obj obj;
   
                   t = 0;
                   for ( i = psn-1; i >= 0; i-- ) {
                           MKNODE(t1,ps[i],t);
                           t = t1;
                   }
                   MKLIST(input,t);
   
                 STOQ(OXCheck,q);                  if ( OXCheck >= 0 ) {
                 MKSTR(fname,"register_input");                          STOQ(OXCheck,q);
                 MKLIST(input,f0);                          MKSTR(fname,"register_input");
                 arg = mknode(3,q,fname,input);                          arg = mknode(3,q,fname,input);
                 Pox_cmo_rpc(arg,&dmy);                          Pox_cmo_rpc(arg,&obj);
                   } else if ( OXCheck < 0 ) {
                           MKNODE(AllTraceList,input,0);
                   }
         }          }
         for ( s0 = 0, i = 0; i < psn; i++ ) {          for ( s0 = 0, i = 0; i < psn; i++ ) {
                 NEXTNODE(s0,s); BDY(s) = (pointer)i;                  NEXTNODE(s0,s); BDY(s) = (pointer)i;
Line 940  int m;
Line 1284  int m;
         *r = s0;          *r = s0;
 }  }
   
 void prim_part(f,m,r)  void prim_part(DP f,int m,DP *r)
 DP f,*r;  
 int m;  
 {  {
         P d,t;          P d,t;
   
Line 950  int m;
Line 1292  int m;
                 if ( PCoeffs )                  if ( PCoeffs )
                         dp_prim_mod(f,m,r);                          dp_prim_mod(f,m,r);
                 else                  else
                         *r = f;                          _dp_monic(f,m,r);
         } else {          } else {
                 if ( dp_fcoeffs )                  if ( dp_fcoeffs || PCoeffs )
                         *r = f;  
                 else if ( PCoeffs )  
                         dp_prim(f,r);                          dp_prim(f,r);
                 else                  else
                         dp_ptozp(f,r);                          dp_ptozp(f,r);
                 if ( GenTrace && TraceList ) {                  if ( GenTrace && TraceList ) {
                           /* adust the denominator according to the final
                              content reduction */
                         divsp(CO,BDY(f)->c,BDY(*r)->c,&d);                          divsp(CO,BDY(f)->c,BDY(*r)->c,&d);
                         mulp(CO,(P)ARG3(BDY((LIST)BDY(TraceList))),d,&t);                          mulp(CO,(P)ARG3(BDY((LIST)BDY(TraceList))),d,&t);
                         ARG3(BDY((LIST)BDY(TraceList))) = t;                          ARG3(BDY((LIST)BDY(TraceList))) = t;
Line 966  int m;
Line 1308  int m;
         }          }
 }  }
   
 NODE /* of DP */ NODE_sortb_insert( newdp, nd, dec )  NODE /* of DP */ NODE_sortb_insert( DP newdp, NODE /* of DP */ nd, int dec )
 DP newdp;  
 NODE /* of DP */ nd;  
 int dec;  
 {  {
         register NODE last, p;          register NODE last, p;
         register DL newdl = BDY(newdp)->dl;          register DL newdl = BDY(newdp)->dl;
Line 988  int dec;
Line 1327  int dec;
         return nd;          return nd;
 }  }
   
 NODE NODE_sortb( node, dec )  NODE NODE_sortb( NODE node, int dec )
 NODE node;  
 int dec;  
 {  {
         register NODE nd, ans;          register NODE nd, ans;
   
Line 999  int dec;
Line 1336  int dec;
         return ans;          return ans;
 }  }
   
 NODE /* of index */ NODE_sortbi_insert( newdpi, nd, dec )  NODE /* of index */ NODE_sortbi_insert( int newdpi, NODE /* of index */ nd, int dec )
 int newdpi;  
 NODE /* of index */ nd;  
 int dec;  
 {  {
         register NODE last, p;          register NODE last, p;
         register DL newdl = psh[newdpi];          register DL newdl = psh[newdpi];
Line 1021  int dec;
Line 1355  int dec;
         return nd;          return nd;
 }  }
   
 NODE NODE_sortbi( node, dec )  NODE NODE_sortbi( NODE node, int dec )
 NODE node;  
 int dec;  
 {  {
         register NODE nd, ans;          register NODE nd, ans;
   
Line 1032  int dec;
Line 1364  int dec;
         return ans;          return ans;
 }  }
   
 void reduceall(in,h)  void reduceall(NODE in,NODE *h)
 NODE in;  
 NODE *h;  
 {  {
         NODE r,t,top;          NODE r,t,top;
         int n,i,j;          int n,i,j;
Line 1053  NODE *h;
Line 1383  NODE *h;
         w = (int *)ALLOCA(n*sizeof(int));          w = (int *)ALLOCA(n*sizeof(int));
         for ( i = 0, t = r; i < n; i++, t = NEXT(t) )          for ( i = 0, t = r; i < n; i++, t = NEXT(t) )
                 w[i] = (int)BDY(t);                  w[i] = (int)BDY(t);
           /* w[i] < 0 : reduced to 0 */
         for ( i = 0; i < n; i++ ) {          for ( i = 0; i < n; i++ ) {
                 for ( top = 0, j = n-1; j >= 0; j-- )                  for ( top = 0, j = n-1; j >= 0; j-- )
                         if ( j != i ) {                          if ( w[j] >= 0 && j != i ) {
                                 MKNODE(t,(pointer)w[j],top); top = t;                                  MKNODE(t,(pointer)w[j],top); top = t;
                         }                          }
                 get_eg(&tmp0);                  get_eg(&tmp0);
Line 1077  NODE *h;
Line 1408  NODE *h;
                 if ( DP_Print || DP_PrintShort ) {                  if ( DP_Print || DP_PrintShort ) {
                         fprintf(asir_out,"."); fflush(asir_out);                          fprintf(asir_out,"."); fflush(asir_out);
                 }                  }
                 w[i] = newps(g1,0,(NODE)0);                  if ( g1 ) {
                           w[i] = newps(g1,0,(NODE)0);
                   } else {
                           w[i] = -1;
                   }
         }          }
         for ( top = 0, j = n-1; j >= 0; j-- ) {          for ( top = 0, j = n-1; j >= 0; j-- ) {
                 MKNODE(t,(pointer)w[j],top); top = t;                  if ( w[j] >= 0 ) {
                           MKNODE(t,(pointer)w[j],top); top = t;
                   }
         }          }
         *h = top;          *h = top;
         if ( DP_Print || DP_PrintShort )          if ( DP_Print || DP_PrintShort )
                 fprintf(asir_out,"\n");                  fprintf(asir_out,"\n");
 }  }
   
 void reduceall_mod(in,m,h)  void reduceall_mod(NODE in,int m,NODE *h)
 NODE in;  
 int m;  
 NODE *h;  
 {  {
         NODE r,t,top;          NODE r,t,top;
         int n,i,j;          int n,i,j;
Line 1109  NODE *h;
Line 1443  NODE *h;
         w = (int *)ALLOCA(n*sizeof(int));          w = (int *)ALLOCA(n*sizeof(int));
         for ( i = 0, t = r; i < n; i++, t = NEXT(t) )          for ( i = 0, t = r; i < n; i++, t = NEXT(t) )
                 w[i] = (int)BDY(t);                  w[i] = (int)BDY(t);
           /* w[i] < 0 : reduced to 0 */
         for ( i = 0; i < n; i++ ) {          for ( i = 0; i < n; i++ ) {
                 for ( top = 0, j = n-1; j >= 0; j-- )                  for ( top = 0, j = n-1; j >= 0; j-- )
                         if ( j != i ) {                          if ( w[j] >= 0 && j != i ) {
                                 MKNODE(t,(pointer)w[j],top); top = t;                                  MKNODE(t,(pointer)w[j],top); top = t;
                         }                          }
                 get_eg(&tmp0);                  get_eg(&tmp0);
Line 1125  NODE *h;
Line 1460  NODE *h;
                 if ( DP_Print || DP_PrintShort ) {                  if ( DP_Print || DP_PrintShort ) {
                         fprintf(asir_out,"."); fflush(asir_out);                          fprintf(asir_out,"."); fflush(asir_out);
                 }                  }
                 w[i] = newps_mod(g,m);                  if ( g ) {
                           w[i] = newps_mod(g,m);
                   } else {
                           w[i] = -1;
                   }
         }          }
         for ( top = 0, j = n-1; j >= 0; j-- ) {          for ( top = 0, j = n-1; j >= 0; j-- ) {
                 MKNODE(t,(pointer)w[j],top); top = t;                  if ( w[j] >= 0 ) {
                           MKNODE(t,(pointer)w[j],top); top = t;
                   }
         }          }
         *h = top;          *h = top;
         if ( DP_Print || DP_PrintShort )          if ( DP_Print || DP_PrintShort )
                 fprintf(asir_out,"\n");                  fprintf(asir_out,"\n");
 }  }
   
 int newps(a,m,subst)  int newps(DP a,int m,NODE subst)
 DP a;  
 int m;  
 NODE subst;  
 {  {
         if ( m && !validhc(!a?0:BDY(a)->c,m,subst) )          if ( m && !validhc(!a?0:BDY(a)->c,m,subst) )
                 return -1;                  return -1;
Line 1166  NODE subst;
Line 1504  NODE subst;
                 _dp_mod(a,m,subst,&psm[psn]);                  _dp_mod(a,m,subst,&psm[psn]);
         if ( GenTrace ) {          if ( GenTrace ) {
                 NODE tn,tr,tr1;                  NODE tn,tr,tr1;
                 LIST trace;                  LIST trace,trace1;
                   NODE arg;
                   Q q1,q2;
                   STRING fname;
                   Obj obj;
   
                 /* reverse the TraceList */                  /* reverse the TraceList */
                 tn = TraceList;                  tn = TraceList;
Line 1175  NODE subst;
Line 1517  NODE subst;
                 }                  }
                 MKLIST(trace,tr);                  MKLIST(trace,tr);
                 if ( OXCheck >= 0 ) {                  if ( OXCheck >= 0 ) {
                         NODE arg;  
                         Q q1,q2;  
                         STRING fname;  
                         Obj dmy;  
   
                         STOQ(OXCheck,q1);                          STOQ(OXCheck,q1);
                         MKSTR(fname,"check_trace");                          MKSTR(fname,"check_trace");
                         STOQ(psn,q2);                          STOQ(psn,q2);
                         arg = mknode(5,q1,fname,a,q2,trace);                          arg = mknode(5,q1,fname,a,q2,trace);
                         Pox_cmo_rpc(arg,&dmy);                          Pox_cmo_rpc(arg,&obj);
                   } else if ( OXCheck < 0 ) {
                           STOQ(psn,q1);
                           tn = mknode(2,q1,trace);
                           MKLIST(trace1,tn);
                           MKNODE(tr,trace1,AllTraceList);
                           AllTraceList = tr;
                 } else                  } else
                         dp_save(psn,(Obj)trace,"t");                          dp_save(psn,(Obj)trace,"t");
                 TraceList = 0;                  TraceList = 0;
Line 1192  NODE subst;
Line 1535  NODE subst;
         return psn++;          return psn++;
 }  }
   
 int newps_nosave(a,m,subst)  int newps_nosave(DP a,int m,NODE subst)
 DP a;  
 int m;  
 NODE subst;  
 {  {
         if ( m && !validhc(!a?0:BDY(a)->c,m,subst) )          if ( m && !validhc(!a?0:BDY(a)->c,m,subst) )
                 return -1;                  return -1;
Line 1217  NODE subst;
Line 1557  NODE subst;
         return psn++;          return psn++;
 }  }
   
 int newps_mod(a,m)  int newps_mod(DP a,int m)
 DP a;  
 int m;  
 {  {
         if ( psn == pslen ) {          if ( psn == pslen ) {
                 pslen *= 2;                  pslen *= 2;
Line 1234  int m;
Line 1572  int m;
         return psn++;          return psn++;
 }  }
   
 void reducebase_dehomo(f,g)  void reducebase_dehomo(NODE f,NODE *g)
 NODE f,*g;  
 {  {
         int n,i,j,k;          int n,i,j,k;
         int *r;          int *r;
Line 1281  NODE f,*g;
Line 1618  NODE f,*g;
         *g = top;          *g = top;
 }  }
   
 NODE append_one(f,n)  NODE append_one(NODE f,int n)
 NODE f;  
 int n;  
 {  {
         NODE t;          NODE t;
   
Line 1296  int n;
Line 1631  int n;
         }          }
 }  }
   
 DP_pairs minp( d, prest )  DP_pairs minp( DP_pairs d, DP_pairs *prest )
 DP_pairs d, *prest;  
 {  {
         register DP_pairs m, ml, p, l;          register DP_pairs m, ml, p, l;
         register DL lcm;          register DL lcm;
Line 1322  DP_pairs d, *prest;
Line 1656  DP_pairs d, *prest;
         return m;          return m;
 }  }
   
 void minsugar(d,dm,dr)  void minsugar(DP_pairs d,DP_pairs *dm,DP_pairs *dr)
 DP_pairs d;  
 DP_pairs *dm,*dr;  
 {  {
         int msugar;          int msugar;
         DP_pairs t,dm0,dr0,dmt,drt;          DP_pairs t,dm0,dr0,dmt,drt;
Line 1349  DP_pairs *dm,*dr;
Line 1681  DP_pairs *dm,*dr;
         *dm = dm0; *dr = dr0;          *dm = dm0; *dr = dr0;
 }  }
   
 NODE gb(f,m,subst)  NODE gb(NODE f,int m,NODE subst)
 NODE f;  
 int m;  
 NODE subst;  
 {  {
         int i,nh,prev,mag;          int i,nh,prev,mag,mag0,magt;
         NODE r,g,gall;          NODE r,g,gall;
         DP_pairs d,d1;          DP_pairs d;
         DP_pairs l;          DP_pairs l;
         DP h,nf,nfm,dp1,dp2;          DP h,nf,nfm,dp1,dp2;
         MP mp;          MP mp;
         struct oEGT tnf0,tnf1,tnfm0,tnfm1,tpz0,tpz1,tsp0,tsp1,tspm0,tspm1,tnp0,tnp1,tmp0,tmp1;          struct oEGT tnf0,tnf1,tnfm0,tnfm1,tpz0,tpz1,tnp0,tnp1;
         int skip_nf_flag;          int skip_nf_flag;
         double t_0;          double t_0;
         Q q;          Q q;
Line 1368  NODE subst;
Line 1697  NODE subst;
         static prev_sugar = -1;          static prev_sugar = -1;
   
         Max_mag = 0;          Max_mag = 0;
           Max_coef = 0;
         prev = 1;          prev = 1;
         doing_f4 = 0;          doing_f4 = 0;
         if ( m ) {          if ( m ) {
Line 1399  NODE subst;
Line 1729  NODE subst;
                         if ( Demand ) {                          if ( Demand ) {
                                 if ( dp_load_t(psn,&nf) ) {                                  if ( dp_load_t(psn,&nf) ) {
                                         skip_nf_flag = 1;                                          skip_nf_flag = 1;
                                         tnf1=tsp1;  
                                         goto skip_nf;                                          goto skip_nf;
                                 } else {                                  } else {
                                         skip_nf_flag = 0;                                          skip_nf_flag = 0;
Line 1420  NODE subst;
Line 1749  NODE subst;
                                 _dp_nf(gall,h,ps,!Top,&nf);                                  _dp_nf(gall,h,ps,!Top,&nf);
                         else                          else
                                 _dp_nf_z(gall,h,ps,!Top,DP_Multiple,&nf);                                  _dp_nf_z(gall,h,ps,!Top,DP_Multiple,&nf);
                         if ( DP_Print )                          if ( DP_Print && nf )
                                 fprintf(asir_out,"(%.3g)",get_rtime()-t_0);                                  fprintf(asir_out,"(%.3g)",get_rtime()-t_0);
                         get_eg(&tnf1); add_eg(&eg_nf,&tnf0,&tnf1);                          get_eg(&tnf1); add_eg(&eg_nf,&tnf0,&tnf1);
                 } else                  } else
Line 1443  skip_nf:
Line 1772  skip_nf:
                         g = updbase(g,nh);                          g = updbase(g,nh);
                         gall = append_one(gall,nh);                          gall = append_one(gall,nh);
                         if ( !dp_fcoeffs && ShowMag ) {                          if ( !dp_fcoeffs && ShowMag ) {
                                 for ( mag = 0, mp = BDY(h); mp; mp = NEXT(mp) )                                  for ( mag = 0, mag0 = 0, mp = BDY(h); mp; mp = NEXT(mp) ) {
                                         mag += p_mag((P)mp->c);                                          magt = p_mag((P)mp->c);
                                           mag0 = MAX(mag0,magt);
                                           mag += magt;
                                   }
                                   Max_coef = MAX(Max_coef,mag0);
                                 Max_mag = MAX(Max_mag,mag);                                  Max_mag = MAX(Max_mag,mag);
                         }                          }
                         if ( DP_Print ) {                          if ( DP_Print ) {
Line 1456  skip_nf:
Line 1789  skip_nf:
                                         l->dp1,l->dp2,length(g),length(gall),DPPlength(d),                                          l->dp1,l->dp2,length(g),length(gall),DPPlength(d),
                                         pss[nh]);                                          pss[nh]);
                                 if ( ShowMag )                                  if ( ShowMag )
                                         fprintf(asir_out,",mag=%d",mag);                                          fprintf(asir_out,",mag=(%d,%d)",mag,mag0);
                                 fprintf(asir_out,"\n"); fflush(asir_out);                                  fprintf(asir_out,"\n"); fflush(asir_out);
                         } else if ( DP_PrintShort ) {                          } else if ( DP_PrintShort ) {
                                 fprintf(asir_out,"+"); fflush(asir_out);                                  fprintf(asir_out,"+"); fflush(asir_out);
Line 1480  skip_nf:
Line 1813  skip_nf:
         return g;          return g;
 }  }
   
 NODE gb_mod(f,m)  NODE gb_mod(NODE f,int m)
 NODE f;  
 int m;  
 {  {
         int i,nh,prev;          int i,nh,prev;
         NODE r,g,gall;          NODE r,g,gall;
         DP_pairs d,d1;          DP_pairs d;
         DP_pairs l;          DP_pairs l;
         DP h,nf;          DP h,nf;
         struct oEGT tnfm0,tnfm1,tspm0,tspm1,tmp0,tmp1,tpz0,tpz1;          struct oEGT tnfm0,tnfm1,tpz0,tpz1;
   
         prev = 1;          prev = 1;
         for ( gall = g = 0, d = 0, r = f; r; r = NEXT(r) ) {          for ( gall = g = 0, d = 0, r = f; r; r = NEXT(r) ) {
Line 1544  int m;
Line 1875  int m;
         return g;          return g;
 }  }
   
 DP_pairs updpairs( d, g, t)  DP_pairs updpairs( DP_pairs d, NODE /* of index */ g, int t)
 DP_pairs d;  
 NODE /* of index */ g;  
 int t;  
 {  {
         register DP_pairs d1, dd, nd;          register DP_pairs d1, dd, nd;
         struct oEGT tup0,tup1;  
         int dl,dl1;          int dl,dl1;
   
         if ( !g ) return d;          if ( !g ) return d;
         if ( !NoCriB && d ) {          if ( !NoCriB && d ) {
                 dl = DPPlength(d);                  dl = DPPlength(d);
                 d = criterion_B( d, t );                  d = criterion_B( d, t );
                 dl -= DPPlength(d); NBP += dl;                  dl -= DPPlength(d); N_BP += dl;
         }          }
         d1 = newpairs( g, t );          d1 = newpairs( g, t );
         if ( NEXT(d1) ) {          if ( NEXT(d1) ) {
Line 1585  int t;
Line 1912  int t;
         return d;          return d;
 }  }
   
 DP_pairs newpairs( g, t )  DP_pairs newpairs( NODE /* of index */ g, int t )
 NODE /* of index */ g;  
 register int t;  
 {  {
         register NODE r;          register NODE r;
         register DL tdl = psh[t];          register DL tdl = psh[t];
Line 1605  register int t;
Line 1930  register int t;
                 p->lcm = lcm_of_DL(CNVars, dl = psh[dp], tdl, (DL)0 );                  p->lcm = lcm_of_DL(CNVars, dl = psh[dp], tdl, (DL)0 );
 #if 0  #if 0
                 if ( do_weyl )                  if ( do_weyl )
                         p->sugar = dl_weight(p->lcm);                          p->sugar = dl_weyl_weight(p->lcm);
                 else                  else
 #endif  #endif
                         p->sugar = (ts > (s = pss[dp] - dl->td) ? ts : s) + p->lcm->td;                          p->sugar = (ts > (s = pss[dp] - dl->td) ? ts : s) + p->lcm->td;
Line 1613  register int t;
Line 1938  register int t;
         return last;          return last;
 }  }
   
 DP_pairs criterion_B( d, s )  DP_pairs criterion_B( DP_pairs d, int s )
 register DP_pairs d;  
 int s;  
 {  {
         register DP_pairs dd, p;          register DP_pairs dd, p;
         register DL tij, t = psh[s], dltmp;          register DL tij, t = psh[s], dltmp;
Line 1638  int s;
Line 1961  int s;
         return dd;          return dd;
 }  }
   
 DP_pairs criterion_M( d1 )  DP_pairs criterion_M( DP_pairs d1 )
 DP_pairs d1;  
 {  {
         register DP_pairs dd, e, d3, d2, p;          register DP_pairs dd, e, d3, d2, p;
         register DL itdl, jtdl;          register DL itdl, jtdl;
Line 1681  DP_pairs d1;
Line 2003  DP_pairs d1;
         return dd;          return dd;
 }  }
   
 static DP_pairs collect_pairs_of_hdlcm( d1, prest )  static DP_pairs collect_pairs_of_hdlcm( DP_pairs d1, DP_pairs *prest )
 DP_pairs d1, *prest;  
 {  {
         register DP_pairs w, p, r, s;          register DP_pairs w, p, r, s;
         register DL ti;          register DL ti;
Line 1706  DP_pairs d1, *prest;
Line 2027  DP_pairs d1, *prest;
         return w;          return w;
 }  }
   
 int criterion_2( dp1, dp2 )  int criterion_2( int dp1, int dp2 )
 int dp1, dp2;  
 {  {
         register int i, *d1, *d2;          register int i, *d1, *d2;
   
Line 1717  int dp1, dp2;
Line 2037  int dp1, dp2;
         return 1;          return 1;
 }  }
   
 DP_pairs criterion_F( d1 )  DP_pairs criterion_F( DP_pairs d1 )
 DP_pairs d1;  
 {  {
         DP_pairs rest, head;          DP_pairs rest, head;
         register DP_pairs last, p, r, w;          register DP_pairs last, p, r, w;
Line 1727  DP_pairs d1;
Line 2046  DP_pairs d1;
         for ( head = last = 0, p = d1; NEXT(p); ) {          for ( head = last = 0, p = d1; NEXT(p); ) {
                 s = (r = w = collect_pairs_of_hdlcm( p, &rest ))->sugar;                  s = (r = w = collect_pairs_of_hdlcm( p, &rest ))->sugar;
                 while ( w = NEXT(w) )                  while ( w = NEXT(w) )
                         if ( criterion_2( w->dp1, w->dp2 ) ) {                          if ( !do_weyl && criterion_2( w->dp1, w->dp2 ) ) {
                                 r = w;                                  r = w;
                                 break;                                  break;
                         } else if ( w->sugar < s ) s = (r = w)->sugar;                          } else if ( w->sugar < s ) s = (r = w)->sugar;
Line 1741  DP_pairs d1;
Line 2060  DP_pairs d1;
         return head;          return head;
 }  }
   
 NODE updbase(g,t)  NODE updbase(NODE g,int t)
 NODE g;  
 int t;  
 {  {
         g = remove_reducibles(g,t);          g = remove_reducibles(g,t);
         g = append_one(g,t);          g = append_one(g,t);
         return g;          return g;
 }  }
   
 NODE /* of index */ remove_reducibles( nd, newdp )  NODE /* of index */ remove_reducibles(NODE /* of index */ nd, int newdp )
 NODE /* of index */ nd;  
 int newdp;  
 {  {
         register DL dl, dln;          register DL dl, dln;
         register NODE last, p, head;          register NODE last, p, head;
Line 1773  int newdp;
Line 2088  int newdp;
         return head;          return head;
 }  }
   
 int dl_redble( dl1, dl2 )  int dl_redble(DL dl1,DL dl2)
 DL dl1, dl2;  
 {  {
         register int n, *d1, *d2;          register int n, *d1, *d2;
   
Line 1783  DL dl1, dl2;
Line 2097  DL dl1, dl2;
         return 1;          return 1;
 }  }
   
 int dl_weight(dl)  #if 0
 DL dl;  int dl_weyl_weight(DL dl)
 {  {
         int n,w,i;          int n,w,i;
   
Line 1793  DL dl;
Line 2107  DL dl;
                 w += (-dl->d[i]+dl->d[n+i]);                  w += (-dl->d[i]+dl->d[n+i]);
         return w;          return w;
 }  }
   #endif
   
 int gbcheck(f)  int gbcheck(NODE f)
 NODE f;  
 {  {
         int i;          int i;
         NODE r,g,gall;          NODE r,g,gall;
Line 1833  NODE f;
Line 2147  NODE f;
         return 1;          return 1;
 }  }
   
 int membercheck(f,x)  void gbcheck_list(NODE f,int n,VECT *gp,LIST *pp)
 NODE f,x;  
 {  {
           int i;
           NODE r,g,gall,u,u0,t;
           VECT vect;
           LIST pair;
           DP_pairs d,l;
           Q q1,q2;
   
           /* we need the following settings */
           NVars = CNVars = n;
           setup_arrays(f,0,&r);
           for ( gall = g = 0, d = 0; r; r = NEXT(r) ) {
                   i = (int)BDY(r);
                   d = updpairs(d,g,i);
                   g = updbase(g,i);
                   gall = append_one(gall,i);
           }
           NEWVECT(vect); vect->len = psn; vect->body = (pointer)ps;
           *gp = vect;
   
           for ( u0 = 0, l = d; l; l = NEXT(l) ) {
                   NEXTNODE(u0,u);
                   STOQ(l->dp1,q1);
                   STOQ(l->dp2,q2);
                   t = mknode(2,q1,q2);
                   MKLIST(pair,t);
                   BDY(u) = (pointer)pair;
           }
           if ( u0 )
                   NEXT(u) = 0;
           MKLIST(*pp,u0);
   }
   
   int membercheck(NODE f,NODE x)
   {
         DP g;          DP g;
         struct oEGT tmp0,tmp1;          struct oEGT tmp0,tmp1;
   
Line 1861  NODE f,x;
Line 2208  NODE f,x;
         return 1;          return 1;
 }  }
   
 void dp_set_flag(name,value)  void dp_set_flag(Obj name,Obj value)
 Obj name,value;  
 {  {
         char *n;          char *n;
         int v;          int v;
           Q ratio;
   
         if ( OID(name) != O_STR )          if ( OID(name) != O_STR )
                 return;                  return;
Line 1876  Obj name,value;
Line 2223  Obj name,value;
         if ( !strcmp(n,"Dist") ) {          if ( !strcmp(n,"Dist") ) {
                 Dist = (LIST)value; return;                  Dist = (LIST)value; return;
         }          }
           if ( !strcmp(n,"Content") ) {
                   ratio = (Q)value;
                   if ( ratio ) {
                           DP_Multiple = BD(NM(ratio))[0];
                           Denominator = INT(ratio) ? 1 : BD(DN(ratio))[0];
                   } else {
                           DP_Multiple = 0;
                           Denominator = 1;
                   }
           }
         if ( value && OID(value) != O_N )          if ( value && OID(value) != O_N )
                 return;                  return;
         v = QTOS((Q)value);          v = QTOS((Q)value);
Line 1917  Obj name,value;
Line 2274  Obj name,value;
                 OXCheck = v;                  OXCheck = v;
 }  }
   
 void dp_make_flaglist(list)  void dp_make_flaglist(LIST *list)
 LIST *list;  
 {  {
         Q v;          Q v,nm,dn;
         STRING name,path;          STRING name,path;
         NODE n,n1;          NODE n,n1;
   
   #if 0
         STOQ(DP_Multiple,v); MKNODE(n,v,0); MKSTR(name,"DP_Multiple"); MKNODE(n1,name,n); n = n1;          STOQ(DP_Multiple,v); MKNODE(n,v,0); MKSTR(name,"DP_Multiple"); MKNODE(n1,name,n); n = n1;
         STOQ(Denominator,v); MKNODE(n1,v,n); n = n1; MKSTR(name,"Denominator"); MKNODE(n1,name,n); n = n1;          STOQ(Denominator,v); MKNODE(n1,v,n); n = n1; MKSTR(name,"Denominator"); MKNODE(n1,name,n); n = n1;
   #else
           if ( DP_Multiple ) {
                   STOQ(DP_Multiple,nm); STOQ(Denominator,dn); divq(nm,dn,&v);
           } else
                   v = 0;
           MKNODE(n,v,0); MKSTR(name,"Content"); MKNODE(n1,name,n); n = n1;
   #endif
         MKNODE(n1,Dist,n); n = n1; MKSTR(name,"Dist"); MKNODE(n1,name,n); n = n1;          MKNODE(n1,Dist,n); n = n1; MKSTR(name,"Dist"); MKNODE(n1,name,n); n = n1;
         STOQ(Reverse,v); MKNODE(n1,v,n); n = n1; MKSTR(name,"Reverse"); MKNODE(n1,name,n); n = n1;          STOQ(Reverse,v); MKNODE(n1,v,n); n = n1; MKSTR(name,"Reverse"); MKNODE(n1,name,n); n = n1;
         STOQ(Stat,v); MKNODE(n1,v,n); n = n1; MKSTR(name,"Stat"); MKNODE(n1,name,n); n = n1;          STOQ(Stat,v); MKNODE(n1,v,n); n = n1; MKSTR(name,"Stat"); MKNODE(n1,name,n); n = n1;
Line 1953  LIST *list;
Line 2317  LIST *list;
   
 #define DELIM '/'  #define DELIM '/'
   
 void dp_save(index,p,prefix)  void dp_save(int index,Obj p,char *prefix)
 int index;  
 Obj p;  
 char *prefix;  
 {  {
         FILE *fp;          FILE *fp;
         char path[BUFSIZ];          char path[BUFSIZ];
Line 1970  char *prefix;
Line 2331  char *prefix;
         savevl(fp,VC); saveobj(fp,p); fclose(fp);          savevl(fp,VC); saveobj(fp,p); fclose(fp);
 }  }
   
 void dp_load(index,p)  void dp_load(int index,DP *p)
 int index;  
 DP *p;  
 {  {
         FILE *fp;          FILE *fp;
         char path[BUFSIZ];          char path[BUFSIZ];
Line 1983  DP *p;
Line 2342  DP *p;
                 sprintf(path,"%s%c%d",Demand,DELIM,index);                  sprintf(path,"%s%c%d",Demand,DELIM,index);
                 if ( !(fp = fopen(path,"rb") ) )                  if ( !(fp = fopen(path,"rb") ) )
                         error("dp_load : cannot open a file");                          error("dp_load : cannot open a file");
                 skipvl(fp); loadobj(fp,(Obj *)p); fclose(fp);                  if ( PCoeffs )
                           loadvl(fp);
                   else
                           skipvl(fp);
                   loadobj(fp,(Obj *)p); fclose(fp);
         }          }
 }  }
   
 int dp_load_t(index,p)  int dp_load_t(int index,DP *p)
 int index;  
 DP *p;  
 {  {
         FILE *fp;          FILE *fp;
         char path[BUFSIZ];          char path[BUFSIZ];
Line 1998  DP *p;
Line 2359  DP *p;
         if ( !(fp = fopen(path,"rb") ) )          if ( !(fp = fopen(path,"rb") ) )
                 return 0;                  return 0;
         else {          else {
                 skipvl(fp); loadobj(fp,(Obj *)p); fclose(fp); return 1;                  if ( PCoeffs )
                           loadvl(fp);
                   else
                           skipvl(fp);
                   loadobj(fp,(Obj *)p); fclose(fp); return 1;
         }          }
 }  }
   
Line 2006  void init_stat() {
Line 2371  void init_stat() {
         init_eg(&eg_nf); init_eg(&eg_nfm); init_eg(&eg_znfm);          init_eg(&eg_nf); init_eg(&eg_nfm); init_eg(&eg_znfm);
         init_eg(&eg_pz); init_eg(&eg_np);          init_eg(&eg_pz); init_eg(&eg_np);
         init_eg(&eg_ra); init_eg(&eg_mc); init_eg(&eg_gc);          init_eg(&eg_ra); init_eg(&eg_mc); init_eg(&eg_gc);
         ZR = NZR = TP = NBP = NFP = NDP = 0;          ZR = NZR = TP = NMP = N_BP = NFP = NDP = 0;
 }  }
   
 void print_stat() {  void print_stat() {
Line 2015  void print_stat() {
Line 2380  void print_stat() {
         print_eg("NF",&eg_nf); print_eg("NFM",&eg_nfm); print_eg("ZNFM",&eg_znfm);          print_eg("NF",&eg_nf); print_eg("NFM",&eg_nfm); print_eg("ZNFM",&eg_znfm);
         print_eg("PZ",&eg_pz); print_eg("NP",&eg_np);          print_eg("PZ",&eg_pz); print_eg("NP",&eg_np);
         print_eg("RA",&eg_ra); print_eg("MC",&eg_mc); print_eg("GC",&eg_gc);          print_eg("RA",&eg_ra); print_eg("MC",&eg_mc); print_eg("GC",&eg_gc);
         fprintf(asir_out,"T=%d,B=%d M=%d F=%d D=%d ZR=%d NZR=%d\n",TP,NBP,NMP,NFP,NDP,ZR,NZR);          fprintf(asir_out,"T=%d,B=%d M=%d F=%d D=%d ZR=%d NZR=%d\n",TP,N_BP,NMP,NFP,NDP,ZR,NZR);
 }  }
   
 /*  /*
Line 2029  extern int GenTrace;
Line 2394  extern int GenTrace;
 extern NODE TraceList;  extern NODE TraceList;
 extern int mpi_mag;  extern int mpi_mag;
   
 void dp_mulc_d(p,c,r)  void dp_mulc_d(DP p,P c,DP *r)
 DP p;  
 P c;  
 DP *r;  
 {  {
         if ( Dist && BDY(Dist)          if ( Dist && BDY(Dist)
                 && HMAG(p) > mpi_mag                  && HMAG(p) > mpi_mag
Line 2045  DP *r;
Line 2407  DP *r;
         }          }
 }  }
   
 void _dp_nf(b,g,ps,full,rp)  void _dp_nf(NODE b,DP g,DP *ps,int full,DP *rp)
 NODE b;  
 DP g;  
 DP *ps;  
 int full;  
 DP *rp;  
 {  {
         DP u,p,d,s,t,mult;          DP u,p,d,s,t,mult;
         P coef;          P coef;
Line 2108  DP *rp;
Line 2465  DP *rp;
         *rp = d;          *rp = d;
 }  }
   
 void _dp_nf_z(b,g,ps,full,multiple,r)  void _dp_nf_z(NODE b,DP g,DP *ps,int full,int multiple,DP *r)
 NODE b;  
 DP g;  
 DP *ps;  
 int full,multiple;  
 DP *r;  
 {  {
         DP u,dp,rp,t,t1,t2,red,shift;          DP u,dp,rp,t,t1,red,shift;
         Q dc,rc,dcq,rcq,cont,hr,hred,cr,cred,mcred,c,gcd,cq;          Q dc,rc,dcq,rcq,cont,hr,hred,cr,cred,mcred,c,gcd,cq;
         N gn,tn,cn;  
         NODE l;          NODE l;
         MP m,mr;  
         int hmag,denom;          int hmag,denom;
         int sugar,psugar;          int sugar,psugar;
         NODE dist;  
         STRING imul;          STRING imul;
         int kara_bit;          double t_0,tt,t_p,t_m,t_g,t_a;
         double get_rtime();  
         double t_0,t_00,tt,ttt,t_p,t_m,t_g,t_a;  
         LIST hist;          LIST hist;
         NODE node;          NODE node;
         Q rcred,mrcred;          Q rcred,mrcred;
Line 2155  DP *r;
Line 2502  DP *r;
                                 tt = get_rtime(); t_p += tt-t_0;                                  tt = get_rtime(); t_p += tt-t_0;
   
                                 dp_subd(rp,red,&shift);                                  dp_subd(rp,red,&shift);
                                 dp_mulc_d(rp,cr,&t);                                  dp_mulc_d(rp,(P)cr,&t);
                                 chsgnp((P)cred,(P *)&mcred);                                  chsgnp((P)cred,(P *)&mcred);
                                 dp_mulc_d(red,mcred,&t1);                                  dp_mulc_d(red,(P)mcred,&t1);
                                 muld(CO,shift,t1,&t1);                                  muld(CO,shift,t1,&t1);
                                 addd(CO,t,t1,&u);                                  addd(CO,t,t1,&u);
                                 t_m += get_rtime()-tt;                                  t_m += get_rtime()-tt;
Line 2252  final:
Line 2599  final:
   
 void imulv();  void imulv();
   
 void dp_imul_d(p,q,rp)  void dp_imul_d(DP p,Q q,DP *rp)
 DP p;  
 Q q;  
 DP *rp;  
 {  {
         int nsep,ndist,i,j,k,l,n;          int nsep,ndist,i,j,k,l,n;
         double t0,t1,t2;          double t0,t1,t2;
Line 2264  DP *rp;
Line 2608  DP *rp;
         VECT c,cs,ri;          VECT c,cs,ri;
         VECT *r;          VECT *r;
         MP m;          MP m;
         NODE tn,dist,n0,n1,n2;          NODE tn,dist,n0;
         Obj dmy;          Obj obj;
         STRING imul;          STRING imul;
         extern LIST Dist;          extern LIST Dist;
   
Line 2286  DP *rp;
Line 2630  DP *rp;
         r = (VECT *)CALLOC(nsep,sizeof(VECT *));          r = (VECT *)CALLOC(nsep,sizeof(VECT *));
         for ( i = 0, tn = dist, b = BDY(cs); i < ndist; i++, tn = NEXT(tn) ) {          for ( i = 0, tn = dist, b = BDY(cs); i < ndist; i++, tn = NEXT(tn) ) {
                 n0 = mknode(4,BDY(tn),imul,b[i],q);                  n0 = mknode(4,BDY(tn),imul,b[i],q);
                 Pox_rpc(n0,&dmy);                  Pox_rpc(n0,&obj);
         }          }
         t1 = get_rtime();          t1 = get_rtime();
         im_t_s += t1 - t0;          im_t_s += t1 - t0;
Line 2294  DP *rp;
Line 2638  DP *rp;
         t1 = get_rtime();          t1 = get_rtime();
         for ( i = 0, tn = dist; i < ndist; i++, tn = NEXT(tn) ) {          for ( i = 0, tn = dist; i < ndist; i++, tn = NEXT(tn) ) {
                 MKNODE(n0,BDY(tn),0);                  MKNODE(n0,BDY(tn),0);
                 Pox_pop_local(n0,&r[i]);                  Pox_pop_local(n0,&obj); r[i] = (VECT)obj;
                 if ( OID(r[i]) == O_ERR ) {                  if ( OID(r[i]) == O_ERR ) {
                         printexpr(CO,(Obj)r[i]);                          printexpr(CO,(Obj)r[i]);
                         error("dp_imul_d : aborted");                          error("dp_imul_d : aborted");
Line 2311  DP *rp;
Line 2655  DP *rp;
         dp_vtod(s,p,rp);          dp_vtod(s,p,rp);
 }  }
   
 void imulv(w,c,rp)  void imulv(VECT w,Q c,VECT *rp)
 VECT w;  
 Q c;  
 VECT *rp;  
 {  {
         int n,i;          int n,i;
         VECT r;          VECT r;
Line 2323  VECT *rp;
Line 2664  VECT *rp;
         MKVECT(r,n); *rp = r;          MKVECT(r,n); *rp = r;
         for ( i = 0; i < n; i++ )          for ( i = 0; i < n; i++ )
                 mulq((Q)BDY(w)[i],(Q)c,(Q *)&BDY(r)[i]);                  mulq((Q)BDY(w)[i],(Q)c,(Q *)&BDY(r)[i]);
   }
   
   void dptoca(DP p,unsigned int **rp)
   {
           int i;
           MP m;
           unsigned int *r;
   
           if ( !p )
                   *rp = 0;
           else {
                   for ( m = BDY(p), i = 0; m; m = NEXT(m), i++ );
                   *rp = r = (unsigned int *)MALLOC_ATOMIC(i*sizeof(unsigned int));
                   for ( m = BDY(p), i = 0; m; m = NEXT(m), i++ )
                           r[i] = ITOS(C(m));
           }
 }  }
   

Legend:
Removed from v.1.22  
changed lines
  Added in v.1.60

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