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

Diff for /OpenXM_contrib2/asir2018/engine/nd.c between version 1.64 and 1.65

version 1.64, 2022/03/09 07:50:51 version 1.65, 2022/04/03 00:39:12
Line 1 
Line 1 
 /* $OpenXM: OpenXM_contrib2/asir2018/engine/nd.c,v 1.63 2022/01/13 08:15:02 noro Exp $ */  /* $OpenXM: OpenXM_contrib2/asir2018/engine/nd.c,v 1.64 2022/03/09 07:50:51 noro Exp $ */
   
 #include "nd.h"  #include "nd.h"
   
Line 178  void _NM_alloc()
Line 178  void _NM_alloc()
 matrix alloc_matrix(int row,int col)  matrix alloc_matrix(int row,int col)
 {  {
   unsigned long **a;    unsigned long **a;
   int i,len,blen;  
   matrix mat;    matrix mat;
   
   mat = (matrix)MALLOC(sizeof(struct matrix));    mat = (matrix)MALLOC(sizeof(struct matrix));
Line 383  void ndl_dehomogenize(UINT *d)
Line 382  void ndl_dehomogenize(UINT *d)
 void ndl_lcm(UINT *d1,unsigned *d2,UINT *d)  void ndl_lcm(UINT *d1,unsigned *d2,UINT *d)
 {  {
     UINT t1,t2,u,u1,u2;      UINT t1,t2,u,u1,u2;
     int i,j,l;      int i,j;
   
     if ( nd_module && (MPOS(d1) != MPOS(d2)) )      if ( nd_module && (MPOS(d1) != MPOS(d2)) )
         error("ndl_lcm : inconsistent monomials");          error("ndl_lcm : inconsistent monomials");
Line 481  void ndl_lcm(UINT *d1,unsigned *d2,UINT *d)
Line 480  void ndl_lcm(UINT *d1,unsigned *d2,UINT *d)
 void ndl_max(UINT *d1,unsigned *d2,UINT *d)  void ndl_max(UINT *d1,unsigned *d2,UINT *d)
 {  {
     UINT t1,t2,u,u1,u2;      UINT t1,t2,u,u1,u2;
     int i,j,l;      int i,j;
   
     for ( i = nd_exporigin; i < nd_wpd; i++ ) {      for ( i = nd_exporigin; i < nd_wpd; i++ ) {
         u1 = d1[i]; u2 = d2[i];          u1 = d1[i]; u2 = d2[i];
Line 521  int ndl_weight(UINT *d)
Line 520  int ndl_weight(UINT *d)
 int ndl_weight2(UINT *d)  int ndl_weight2(UINT *d)
 {  {
     int t,u;      int t,u;
     int i,j;      int i;
   
     for ( i = 0, t = 0; i < nd_nvar; i++ ) {      for ( i = 0, t = 0; i < nd_nvar; i++ ) {
         u = GET_EXP(d,i);          u = GET_EXP(d,i);
Line 579  int ndl_lex_compare(UINT *d1,UINT *d2)
Line 578  int ndl_lex_compare(UINT *d1,UINT *d2)
   
 int ndl_block_compare(UINT *d1,UINT *d2)  int ndl_block_compare(UINT *d1,UINT *d2)
 {  {
     int i,l,j,ord_o,ord_l;      int i,l,j,ord_o;
     struct order_pair *op;      struct order_pair *op;
     UINT t1,t2,m;      UINT t1,t2,m;
     UINT *mask;      UINT *mask;
Line 748  int ndl_module_glex_compare(UINT *d1,UINT *d2)
Line 747  int ndl_module_glex_compare(UINT *d1,UINT *d2)
       break;        break;
   
     case 1:      case 1:
       if ( nd_pot_nelim && MPOS(d1)>=nd_pot_nelim+1 && MPOS(d2) >= nd_pot_nelim+1 ) {        if ( nd_pot_nelim && MPOS(d1)>=(UINT)(nd_pot_nelim+1) && MPOS(d2) >= (UINT)(nd_pot_nelim+1) ) {
          if ( TD(d1) > TD(d2) ) return 1;           if ( TD(d1) > TD(d2) ) return 1;
          else if ( TD(d1) < TD(d2) ) return -1;           else if ( TD(d1) < TD(d2) ) return -1;
          if ( (c = ndl_lex_compare(d1,d2)) != 0 ) return c;           if ( (c = ndl_lex_compare(d1,d2)) != 0 ) return c;
Line 851  int ndl_module_schreyer_compare(UINT *m1,UINT *m2)
Line 850  int ndl_module_schreyer_compare(UINT *m1,UINT *m2)
     if ( pos1 == pos2 ) return (*dl_base_compare_function)(nd_nvar,d1,d2);      if ( pos1 == pos2 ) return (*dl_base_compare_function)(nd_nvar,d1,d2);
   }    }
   // comparison by the bottom order    // comparison by the bottom order
 LAST:  
   switch ( nd_base_ordtype ) {    switch ( nd_base_ordtype ) {
     case 0:      case 0:
       t = (*dl_base_compare_function)(nd_nvar,d1,d2);        t = (*dl_base_compare_function)(nd_nvar,d1,d2);
Line 995  INLINE void ndl_sub(UINT *d1,UINT *d2,UINT *d)
Line 993  INLINE void ndl_sub(UINT *d1,UINT *d2,UINT *d)
   
 int ndl_disjoint(UINT *d1,UINT *d2)  int ndl_disjoint(UINT *d1,UINT *d2)
 {  {
     UINT t1,t2,u,u1,u2;      UINT t1,t2,u1,u2;
     int i,j;      int i,j;
   
     if ( nd_module && (MPOS(d1) == MPOS(d2)) ) return 0;      if ( nd_module && (MPOS(d1) == MPOS(d2)) ) return 0;
Line 1316  INLINE int ndl_find_reducer_s(UINT *dg,SIG sig)
Line 1314  INLINE int ndl_find_reducer_s(UINT *dg,SIG sig)
   
 ND nd_merge(ND p1,ND p2)  ND nd_merge(ND p1,ND p2)
 {  {
     int n,c;      int c;
     int t,can,td1,td2;      int can;
     ND r;  
     NM m1,m2,mr0,mr,s;      NM m1,m2,mr0,mr,s;
   
     if ( !p1 ) return p2;      if ( !p1 ) return p2;
     else if ( !p2 ) return p1;      else if ( !p2 ) return p1;
     else {      else {
         can = 0;          can = 0;
         for ( n = NV(p1), m1 = BDY(p1), m2 = BDY(p2), mr0 = 0; m1 && m2; ) {          for (  m1 = BDY(p1), m2 = BDY(p2), mr0 = 0; m1 && m2; ) {
             c = DL_COMPARE(DL(m1),DL(m2));              c = DL_COMPARE(DL(m1),DL(m2));
             switch ( c ) {              switch ( c ) {
                 case 0:                  case 0:
Line 1358  ND nd_merge(ND p1,ND p2)
Line 1355  ND nd_merge(ND p1,ND p2)
   
 ND nd_add(int mod,ND p1,ND p2)  ND nd_add(int mod,ND p1,ND p2)
 {  {
     int n,c;      int c;
     int t,can,td1,td2;      int t,can;
     ND r;  
     NM m1,m2,mr0,mr,s;      NM m1,m2,mr0,mr,s;
   
     Nnd_add++;      Nnd_add++;
Line 1371  ND nd_add(int mod,ND p1,ND p2)
Line 1367  ND nd_add(int mod,ND p1,ND p2)
     else if ( !mod ) return nd_add_q(p1,p2);      else if ( !mod ) return nd_add_q(p1,p2);
     else {      else {
         can = 0;          can = 0;
         for ( n = NV(p1), m1 = BDY(p1), m2 = BDY(p2), mr0 = 0; m1 && m2; ) {          for ( m1 = BDY(p1), m2 = BDY(p2), mr0 = 0; m1 && m2; ) {
             c = DL_COMPARE(DL(m1),DL(m2));              c = DL_COMPARE(DL(m1),DL(m2));
             switch ( c ) {              switch ( c ) {
                 case 0:                  case 0:
Line 1432  int nm_destructive_add_q(NM *m1,NM *m2,NM *mr0,NM *mr)
Line 1428  int nm_destructive_add_q(NM *m1,NM *m2,NM *mr0,NM *mr)
   
 ND nd_add_q(ND p1,ND p2)  ND nd_add_q(ND p1,ND p2)
 {  {
     int n,c,can;      int c,can;
     ND r;  
     NM m1,m2,mr0,mr,s;      NM m1,m2,mr0,mr,s;
     P t;  
   
     if ( !p1 ) return p2;      if ( !p1 ) return p2;
     else if ( !p2 ) return p1;      else if ( !p2 ) return p1;
     else {      else {
         can = 0;          can = 0;
         for ( n = NV(p1), m1 = BDY(p1), m2 = BDY(p2), mr0 = 0; m1 && m2; ) {          for ( m1 = BDY(p1), m2 = BDY(p2), mr0 = 0; m1 && m2; ) {
             c = DL_COMPARE(DL(m1),DL(m2));              c = DL_COMPARE(DL(m1),DL(m2));
             switch ( c ) {              switch ( c ) {
                 case 0:                  case 0:
Line 1483  ND nd_add_q(ND p1,ND p2)
Line 1477  ND nd_add_q(ND p1,ND p2)
   
 ND nd_add_sf(ND p1,ND p2)  ND nd_add_sf(ND p1,ND p2)
 {  {
     int n,c,can;      int c,can;
     ND r;  
     NM m1,m2,mr0,mr,s;      NM m1,m2,mr0,mr,s;
     int t;      int t;
   
Line 1492  ND nd_add_sf(ND p1,ND p2)
Line 1485  ND nd_add_sf(ND p1,ND p2)
     else if ( !p2 ) return p1;      else if ( !p2 ) return p1;
     else {      else {
         can = 0;          can = 0;
         for ( n = NV(p1), m1 = BDY(p1), m2 = BDY(p2), mr0 = 0; m1 && m2; ) {          for ( m1 = BDY(p1), m2 = BDY(p2), mr0 = 0; m1 && m2; ) {
             c = DL_COMPARE(DL(m1),DL(m2));              c = DL_COMPARE(DL(m1),DL(m2));
             switch ( c ) {              switch ( c ) {
                 case 0:                  case 0:
Line 1574  ND nd_reduce2(int mod,ND d,ND g,NDV p,NM mul,NDC dn,Ob
Line 1567  ND nd_reduce2(int mod,ND d,ND g,NDV p,NM mul,NDC dn,Ob
 /* ret=1 : success, ret=0 : overflow */  /* ret=1 : success, ret=0 : overflow */
 int nd_nf(int mod,ND d,ND g,NDV *ps,int full,ND *rp)  int nd_nf(int mod,ND d,ND g,NDV *ps,int full,ND *rp)
 {  {
     NM m,mrd,tail;      NM m,tail;
     NM mul;      NM mul;
     int n,sugar,psugar,sugar0,stat,index;      int n,sugar,index;
     int c,c1,c2,dummy;  
     RHist h;      RHist h;
     NDV p,red;      NDV p;
     Q cg,cred,gcd,tq,qq;  
     Z iq;      Z iq;
     DP dmul;      DP dmul;
     NODE node;      NODE node;
     LIST hist;      LIST hist;
     double hmag;      double hmag;
     P tp,tp1;      Obj div;
     Obj tr,tr1,div;  
     union oNDC hg;      union oNDC hg;
     P cont;      P cont;
   
Line 1597  int nd_nf(int mod,ND d,ND g,NDV *ps,int full,ND *rp)
Line 1587  int nd_nf(int mod,ND d,ND g,NDV *ps,int full,ND *rp)
     }      }
     if ( !mod ) hmag = ((double)p_mag(HCP(g)))*nd_scale;      if ( !mod ) hmag = ((double)p_mag(HCP(g)))*nd_scale;
   
     sugar0 = sugar = SG(g);      sugar = SG(g);
     n = NV(g);      n = NV(g);
     mul = (NM)MALLOC(sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT));      mul = (NM)MALLOC(sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT));
     if ( d )      if ( d )
Line 1620  int nd_nf(int mod,ND d,ND g,NDV *ps,int full,ND *rp)
Line 1610  int nd_nf(int mod,ND d,ND g,NDV *ps,int full,ND *rp)
                 nmtodp(mod,mul,&dmul);                  nmtodp(mod,mul,&dmul);
                 node = mknode(4,div,iq,dmul,ONE);                  node = mknode(4,div,iq,dmul,ONE);
             }              }
             sugar = MAX(sugar,SG(p)+TD(DL(mul)));              sugar = MAX(sugar,(int)(SG(p)+TD(DL(mul))));
             if ( !mod && g && !nd_vc && ((double)(p_mag(HCP(g))) > hmag) ) {              if ( !mod && g && !nd_vc && ((double)(p_mag(HCP(g))) > hmag) ) {
                 hg = HCU(g);                  hg = HCU(g);
                 nd_removecont2(d,g);                  nd_removecont2(d,g);
Line 1662  int nd_nf(int mod,ND d,ND g,NDV *ps,int full,ND *rp)
Line 1652  int nd_nf(int mod,ND d,ND g,NDV *ps,int full,ND *rp)
   
 int nd_nf_s(int mod,ND d,ND g,NDV *ps,int full,ND *rp)  int nd_nf_s(int mod,ND d,ND g,NDV *ps,int full,ND *rp)
 {  {
     NM m,mrd,tail;      NM m,tail;
     NM mul;      NM mul;
     int n,sugar,psugar,sugar0,stat,index;      int n,sugar,index;
     int c,c1,c2,dummy;  
     RHist h;      RHist h;
     NDV p,red;      NDV p;
     Q cg,cred,gcd,tq,qq;  
     Z iq;      Z iq;
     DP dmul;      DP dmul;
     NODE node;      NODE node;
     LIST hist;      LIST hist;
     double hmag;      double hmag;
     P tp,tp1;      Obj div;
     Obj tr,tr1,div;  //    union oNDC hg;
     union oNDC hg;  
     P cont;  
     SIG sig;      SIG sig;
   
     if ( !g ) {      if ( !g ) {
Line 1686  int nd_nf_s(int mod,ND d,ND g,NDV *ps,int full,ND *rp)
Line 1672  int nd_nf_s(int mod,ND d,ND g,NDV *ps,int full,ND *rp)
     }      }
     if ( !mod ) hmag = ((double)p_mag(HCP(g)))*nd_scale;      if ( !mod ) hmag = ((double)p_mag(HCP(g)))*nd_scale;
   
     sugar0 = sugar = SG(g);      sugar = SG(g);
     n = NV(g);      n = NV(g);
     mul = (NM)MALLOC(sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT));      mul = (NM)MALLOC(sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT));
     if ( d )      if ( d )
Line 1705  int nd_nf_s(int mod,ND d,ND g,NDV *ps,int full,ND *rp)
Line 1691  int nd_nf_s(int mod,ND d,ND g,NDV *ps,int full,ND *rp)
             p = ps[index];              p = ps[index];
             /* d+g -> div*(d+g)+mul*p */              /* d+g -> div*(d+g)+mul*p */
             g = nd_reduce2(mod,d,g,p,mul,0,&div);              g = nd_reduce2(mod,d,g,p,mul,0,&div);
             sugar = MAX(sugar,SG(p)+TD(DL(mul)));              sugar = MAX(sugar,(int)(SG(p)+TD(DL(mul))));
             if ( !mod && g && ((double)(p_mag(HCP(g))) > hmag) ) {              if ( !mod && g && ((double)(p_mag(HCP(g))) > hmag) ) {
                 hg = HCU(g);  //                hg = HCU(g);
                 nd_removecont2(d,g);                  nd_removecont2(d,g);
                 hmag = ((double)p_mag(HCP(g)))*nd_scale;                  hmag = ((double)p_mag(HCP(g)))*nd_scale;
             }              }
Line 1752  int nd_nf_pbucket(int mod,ND g,NDV *ps,int full,ND *rp
Line 1738  int nd_nf_pbucket(int mod,ND g,NDV *ps,int full,ND *rp
 {  {
     int hindex,index;      int hindex,index;
     NDV p;      NDV p;
     ND u,d,red;      ND d,red;
     NODE l;      NM mul,m,tail;
     NM mul,m,mrd,tail;      int sugar,psugar,n;
     int sugar,psugar,n,h_reducible;  
     PGeoBucket bucket;      PGeoBucket bucket;
     int c,c1,c2;      int c,c1,c2;
     Z cg,cred,gcd,zzz;      Z cg,cred,gcd;
     RHist h;      RHist h;
     double hmag,gmag;      double hmag,gmag;
     int count = 0;      int count = 0;
Line 1864  int nd_nf_pbucket_s(int mod,ND g,NDV *ps,int full,ND *
Line 1849  int nd_nf_pbucket_s(int mod,ND g,NDV *ps,int full,ND *
 {  {
   int hindex,index;    int hindex,index;
   NDV p;    NDV p;
   ND u,d,red;    ND d,red;
   NODE l;    NM mul,m,tail;
   NM mul,m,mrd,tail;    int sugar,psugar,n;
   int sugar,psugar,n,h_reducible;  
   PGeoBucket bucket;    PGeoBucket bucket;
   int c,c1,c2;    int c,c1,c2;
   Z cg,cred,gcd,zzz;    Z cg,cred,gcd;
   RHist h;    RHist h;
   double hmag,gmag;    double hmag,gmag;
   int count = 0;    int count = 0;
Line 1990  int nd_nf_pbucket_s(int mod,ND g,NDV *ps,int full,ND *
Line 1974  int nd_nf_pbucket_s(int mod,ND g,NDV *ps,int full,ND *
   
 int ndv_check_membership(int m,NODE input,int obpe,int oadv,EPOS oepos,NODE cand)  int ndv_check_membership(int m,NODE input,int obpe,int oadv,EPOS oepos,NODE cand)
 {  {
     int n,i,stat;      int i,stat;
     ND nf,d;      ND nf,d;
     NDV r;      NDV r;
     NODE t,s;      NODE t,s;
     union oNDC dn;  
     Z q;      Z q;
     LIST list;      LIST list;
   
     ndv_setup(m,0,cand,nd_gentrace?1:0,1,0);      ndv_setup(m,0,cand,nd_gentrace?1:0,1,0);
     n = length(cand);  //    n = length(cand);
   
   if ( nd_gentrace ) { nd_alltracelist = 0; nd_tracelist = 0; }    if ( nd_gentrace ) { nd_alltracelist = 0; nd_tracelist = 0; }
     /* membercheck : list is a subset of Id(cand) ? */      /* membercheck : list is a subset of Id(cand) ? */
Line 2106  void add_pbucket_symbolic(PGeoBucket g,ND d)
Line 2089  void add_pbucket_symbolic(PGeoBucket g,ND d)
 #else  #else
 void add_pbucket_symbolic(PGeoBucket g,ND d)  void add_pbucket_symbolic(PGeoBucket g,ND d)
 {  {
   int l,i,k,m,m0;    int l,k,m,m0;
   
   if ( !d )    if ( !d )
     return;      return;
Line 2149  void add_pbucket(int mod,PGeoBucket g,ND d)
Line 2132  void add_pbucket(int mod,PGeoBucket g,ND d)
 #else  #else
 void add_pbucket(int mod,PGeoBucket g,ND d)  void add_pbucket(int mod,PGeoBucket g,ND d)
 {  {
   int l,i,k,m,m0;    int l,k,m,m0;
   
   m0 = g->m;    m0 = g->m;
   while ( d != 0 ) {    while ( d != 0 ) {
Line 2211  NM remove_head_pbucket_symbolic(PGeoBucket g)
Line 2194  NM remove_head_pbucket_symbolic(PGeoBucket g)
   
 int head_pbucket(int mod,PGeoBucket g)  int head_pbucket(int mod,PGeoBucket g)
 {  {
     int j,i,c,k,nv,sum;      int j,i,c,k,sum;
     UINT *di,*dj;      UINT *dj;
     ND gi,gj;      ND gi,gj;
   
     k = g->m;      k = g->m;
Line 2257  int head_pbucket(int mod,PGeoBucket g)
Line 2240  int head_pbucket(int mod,PGeoBucket g)
   
 int head_pbucket_q(PGeoBucket g)  int head_pbucket_q(PGeoBucket g)
 {  {
     int j,i,c,k,nv;      int j,i,c,k;
     Z sum,t;      Z sum,t;
     ND gi,gj;      ND gi,gj;
   
Line 2271  int head_pbucket_q(PGeoBucket g)
Line 2254  int head_pbucket_q(PGeoBucket g)
                 gj = g->body[j];                  gj = g->body[j];
                 sum = HCZ(gj);                  sum = HCZ(gj);
             } else {              } else {
                 nv = NV(gi);  //               nv = NV(gi);
                 c = DL_COMPARE(HDL(gi),HDL(gj));                  c = DL_COMPARE(HDL(gi),HDL(gj));
                 if ( c > 0 ) {                  if ( c > 0 ) {
                     if ( sum ) HCZ(gj) = sum;                      if ( sum ) HCZ(gj) = sum;
Line 2297  int head_pbucket_q(PGeoBucket g)
Line 2280  int head_pbucket_q(PGeoBucket g)
   
 int head_pbucket_lf(PGeoBucket g)  int head_pbucket_lf(PGeoBucket g)
 {  {
     int j,i,c,k,nv;      int j,i,c,k;
     Z sum,t;      Z sum,t;
     ND gi,gj;      ND gi,gj;
   
Line 2311  int head_pbucket_lf(PGeoBucket g)
Line 2294  int head_pbucket_lf(PGeoBucket g)
                 gj = g->body[j];                  gj = g->body[j];
                 sum = HCZ(gj);                  sum = HCZ(gj);
             } else {              } else {
                 nv = NV(gi);  //              nv = NV(gi);
                 c = DL_COMPARE(HDL(gi),HDL(gj));                  c = DL_COMPARE(HDL(gi),HDL(gj));
                 if ( c > 0 ) {                  if ( c > 0 ) {
                     if ( sum ) HCZ(gj) = sum;                      if ( sum ) HCZ(gj) = sum;
Line 2338  int head_pbucket_lf(PGeoBucket g)
Line 2321  int head_pbucket_lf(PGeoBucket g)
 ND normalize_pbucket(int mod,PGeoBucket g)  ND normalize_pbucket(int mod,PGeoBucket g)
 {  {
     int i;      int i;
     ND r,t;      ND r;
   
     r = 0;      r = 0;
     for ( i = 0; i <= g->m; i++ ) {      for ( i = 0; i <= g->m; i++ ) {
Line 2379  void register_hcf(NDV p)
Line 2362  void register_hcf(NDV p)
 #else  #else
 void register_hcf(NDV p)  void register_hcf(NDV p)
 {  {
     DCP dc,t;  
     P hc,h,q;      P hc,h,q;
     Q dmy;      Q dmy;
     int c;      int c;
Line 2413  void register_hcf(NDV p)
Line 2395  void register_hcf(NDV p)
   
 int do_diagonalize(int sugar,int m)  int do_diagonalize(int sugar,int m)
 {  {
   int i,nh,stat;    int i,stat;
   NODE r,g,t;    ND nf,s,head;
   ND h,nf,s,head;  
   NDV nfv;    NDV nfv;
   Q q;    P cont;
   P nm,nmp,dn,mnp,dnp,cont,cont1;  
   union oNDC hc;    union oNDC hc;
   NODE node;    NODE node;
   LIST l;    LIST l;
Line 2496  LIST dp_monomial_hilbert_poincare_weight(VECT b,VECT x
Line 2476  LIST dp_monomial_hilbert_poincare_weight(VECT b,VECT x
   
 void setup_hpdata(HPDATA final,HPDATA current)  void setup_hpdata(HPDATA final,HPDATA current)
 {  {
   int n,i,wlen;    int n,i;
   DL *p;    DL *p;
   VECT b,x;    VECT b,x;
   DL dl;    DL dl;
   LIST weight;  
   LIST ret;    LIST ret;
   int *w;    int *w;
   NODE nd;  
   
   final->n = n = nd_nvar;    final->n = n = nd_nvar;
   final->hn = (P)BDY(nd_hpdata);    final->hn = (P)BDY(nd_hpdata);
Line 2557  int comp_hn(P a, P b)
Line 2535  int comp_hn(P a, P b)
   
 void update_hpdata(HPDATA current,int nh)  void update_hpdata(HPDATA current,int nh)
 {  {
   NODE data1,nd,t;    NODE data1;
   DL new,dl;    DL new;
   int len,i,n;    int i,n;
   Z dz;    Z dz;
   DL *p;    DL *p;
   VECT b,head;    VECT b;
   P tv,td,s,hn,hpoly;    P tv,td,s,hn;
   LIST list1;    LIST list1;
   
   n = nd_nvar;    n = nd_nvar;
Line 2612  ND_pairs nd_remove_same_sugar( ND_pairs d, int sugar)
Line 2590  ND_pairs nd_remove_same_sugar( ND_pairs d, int sugar)
 NODE nd_gb(int m,int ishomo,int checkonly,int gensyz,int **indp)  NODE nd_gb(int m,int ishomo,int checkonly,int gensyz,int **indp)
 {  {
   int i,nh,sugar,stat;    int i,nh,sugar,stat;
   NODE r,g,t;    NODE g,t;
   ND_pairs d;    ND_pairs d;
   ND_pairs l;    ND_pairs l;
   ND h,nf,s,head,nf1;    ND h,nf;
   NDV nfv;    NDV nfv;
   Z q;    Z q;
   union oNDC dn,hc;    union oNDC hc;
   int diag_count = 0;    int diag_count = 0;
   int Nnfnz = 0,Nnfz = 0;    int Nnfnz = 0,Nnfz = 0;
   P cont;    P cont;
   LIST list;    LIST list;
   struct oHPDATA current_hpdata,final_hpdata;    struct oHPDATA current_hpdata,final_hpdata;
   int final_hpvalue;  
   
 struct oEGT eg1,eg2,eg_update;  struct oEGT eg1,eg2,eg_update;
   
Line 3038  int dlength(ND_pairs d)
Line 3015  int dlength(ND_pairs d)
 NODE nd_sba_buch(int m,int ishomo,int **indp,NODE *syzp)  NODE nd_sba_buch(int m,int ishomo,int **indp,NODE *syzp)
 {  {
   int i,j,nh,sugar,stat,pos;    int i,j,nh,sugar,stat,pos;
   NODE r,t,g;    NODE g;
   ND_pairs *d;    ND_pairs *d;
   ND_pairs l,l1;    ND_pairs l,l1;
   ND h,nf,s,head,nf1;    ND h,nf;
   NDV nfv;    NDV nfv;
   Z q;  //  union oNDC hc;
   union oNDC dn,hc;  
   P cont;  
   LIST list;  
   SIG sig;    SIG sig;
   NODE *syzlist;    NODE *syzlist;
   int ngen,ind;    int ngen,ind;
   int Nnominimal,Nredundant;    int Nnominimal,Nredundant;
   DL lcm,quo,mul;    DL lcm,quo,mul;
   struct oHPDATA final_hpdata,current_hpdata;    struct oHPDATA final_hpdata,current_hpdata;
   struct oEGT eg1,eg2,eg3,eg4,eg_update,eg_remove,eg_large,eg_nf,eg_nfzero;    struct oEGT eg1,eg2,eg3,eg4,eg_remove,eg_large,eg_nf,eg_nfzero;
   struct oEGT eg_minsig,eg_smallest,eg_removecont,eg_hpdata,eg_updatepairs,eg_sbabuch,eg_sp;    struct oEGT eg_minsig,eg_smallest,eg_removecont,eg_hpdata,eg_updatepairs,eg_sbabuch,eg_sp;
   int Nnfs=0,Nnfz=0,Nnfnz=0,dlen,nsyz;    int Nnfs=0,Nnfz=0,Nnfnz=0,dlen,nsyz;
   
Line 3161  get_eg(&eg2); 
Line 3135  get_eg(&eg2); 
         fflush(stdout);          fflush(stdout);
       }        }
       add_eg(&eg_nf,&eg1,&eg2);        add_eg(&eg_nf,&eg1,&eg2);
       hc = HCU(nf);  //      hc = HCU(nf);
        get_eg(&eg1);        get_eg(&eg1);
        nd_removecont(m,nf);        nd_removecont(m,nf);
        get_eg(&eg2); add_eg(&eg_removecont,&eg1,&eg2);        get_eg(&eg2); add_eg(&eg_removecont,&eg1,&eg2);
        nfv = ndtondv(m,nf); nd_free(nf);        nfv = ndtondv(m,nf); nd_free(nf);
        nh = ndv_newps(m,nfv,0);        nh = ndv_newps(m,nfv,0);
   
        get_eg(&eg1);        get_eg(&eg1);
        dlen += update_pairs_array_s(d,nh,syzlist);        dlen += update_pairs_array_s(d,nh,syzlist);
        get_eg(&eg2); add_eg(&eg_updatepairs,&eg1,&eg2);        get_eg(&eg2); add_eg(&eg_updatepairs,&eg1,&eg2);
        nd_sba_pos[sig->pos] = append_one(nd_sba_pos[sig->pos],nh);        nd_sba_pos[sig->pos] = append_one(nd_sba_pos[sig->pos],nh);
        if ( nd_hpdata ) {        if ( nd_hpdata ) {
          int dg,sugar0;          int dg,sugar0;
   
          get_eg(&eg1);          get_eg(&eg1);
          update_hpdata(&current_hpdata,nh);          update_hpdata(&current_hpdata,nh);
          get_eg(&eg2); add_eg(&eg_hpdata,&eg1,&eg2);          get_eg(&eg2); add_eg(&eg_hpdata,&eg1,&eg2);
          dg = comp_hn(final_hpdata.hn,current_hpdata.hn);          dg = comp_hn(final_hpdata.hn,current_hpdata.hn);
 //         if ( !compp(CO,final_hpdata.hn,current_hpdata.hn) )  //        if ( !compp(CO,final_hpdata.hn,current_hpdata.hn) )
          if ( dg < 0 ) {          if ( dg < 0 ) {
            if ( DP_Print ) { printf("\nWe found a gb.\n"); }            if ( DP_Print ) { printf("\nWe found a gb.\n"); }
              break;              break;
          } else if ( nd_sba_heu == 1 ) {          } else if ( nd_sba_heu == 1 ) {
            for ( i = 0; i < ngen; i++ ) {            for ( i = 0; i < ngen; i++ ) {
              sugar0 = sugar;              sugar0 = sugar;
              while ( d[i] && dg > sugar0 ) {              while ( d[i] && dg > sugar0 ) {
                d[i] = nd_remove_same_sugar(d[i],sugar0);                d[i] = nd_remove_same_sugar(d[i],sugar0);
                sugar0++;                sugar0++;
              }              }
           }            }
         }          }
       }        }
    } else {      } else {
       d[ind] = d[ind]->next; dlen--;        d[ind] = d[ind]->next; dlen--;
       Nnfz++;        Nnfz++;
       add_eg(&eg_nfzero,&eg1,&eg2);        add_eg(&eg_nfzero,&eg1,&eg2);
      // syzygy      // syzygy
 get_eg(&eg1);  get_eg(&eg1);
      nsyz = Nsyz;        nsyz = Nsyz;
      d[sig->pos] = remove_spair_s(d[sig->pos],sig);        d[sig->pos] = remove_spair_s(d[sig->pos],sig);
      dlen -= Nsyz-nsyz;        dlen -= Nsyz-nsyz;
 get_eg(&eg2); add_eg(&eg_remove,&eg1,&eg2);  get_eg(&eg2); add_eg(&eg_remove,&eg1,&eg2);
      syzlist[sig->pos] = insert_sig(syzlist[sig->pos],sig);        syzlist[sig->pos] = insert_sig(syzlist[sig->pos],sig);
      if ( DP_Print ) { printf("."); fflush(stdout); }        if ( DP_Print ) { printf("."); fflush(stdout); }
    }      }
  }    }
  get_eg(&eg4); add_eg(&eg_sbabuch,&eg3,&eg4);    get_eg(&eg4); add_eg(&eg_sbabuch,&eg3,&eg4);
  g = conv_ilist_s(nd_demand,0,indp);    g = conv_ilist_s(nd_demand,0,indp);
  if ( DP_Print ) {    if ( DP_Print ) {
    printf("\ndlen=%d,nd_sba done. nd_add=%d,Nsyz=%d,Nsamesig=%d,Nnominimal=%d\n",dlen,Nnd_add,Nsyz,Nsamesig,Nnominimal);      printf("\ndlen=%d,nd_sba done. nd_add=%d,Nsyz=%d,Nsamesig=%d,Nnominimal=%d\n",dlen,Nnd_add,Nsyz,Nsamesig,Nnominimal);
    printf("Nbase=%d,Nnfnz=%d,Nnfz=%d,Nnfsingular=%d\n",nd_psn,Nnfnz,Nnfz,Nnfs);      printf("Nbase=%d,Nnfnz=%d,Nnfz=%d,Nnfsingular=%d\n",nd_psn,Nnfnz,Nnfz,Nnfs);
    fflush(stdout);      fflush(stdout);
    if ( nd_sba_redundant_check )      if ( nd_sba_redundant_check )
    printf("Nredundant=%d\n",Nredundant);        printf("Nredundant=%d\n",Nredundant);
    fflush(stdout);      fflush(stdout);
    print_eg("sp",&eg_sp);       print_eg("sp",&eg_sp);
    print_eg("create",&eg_create);       print_eg("create",&eg_create);
    print_eg("merge",&eg_merge);       print_eg("merge",&eg_merge);
    print_eg("minsig",&eg_minsig);       print_eg("minsig",&eg_minsig);
    print_eg("smallest",&eg_smallest);       print_eg("smallest",&eg_smallest);
    print_eg("remove",&eg_remove);       print_eg("remove",&eg_remove);
    printf("\n");       printf("\n");
    print_eg("nf",&eg_nf);       print_eg("nf",&eg_nf);
    print_eg("nfzero",&eg_nfzero);       print_eg("nfzero",&eg_nfzero);
    print_eg("removecont",&eg_removecont);       print_eg("removecont",&eg_removecont);
    print_eg("updatepairs",&eg_updatepairs);       print_eg("updatepairs",&eg_updatepairs);
    print_eg("hpdata",&eg_hpdata);       print_eg("hpdata",&eg_hpdata);
    print_eg("total",&eg_sbabuch);       print_eg("total",&eg_sbabuch);
    printf("\n");       printf("\n");
  }    }
  if ( nd_sba_syz ) {    if ( nd_sba_syz ) {
    print_eg("remove",&eg_remove);      print_eg("remove",&eg_remove);
    print_eg("nf",&eg_nf);      print_eg("nf",&eg_nf);
    print_eg("nfzero",&eg_nfzero);      print_eg("nfzero",&eg_nfzero);
    printf("\n");      printf("\n");
  }    }
  if ( nd_sba_syz ) {    if ( nd_sba_syz ) {
    NODE hsyz,tsyz,prev;      NODE hsyz,tsyz,prev;
   
    hsyz = 0;      hsyz = 0;
    for ( i = 0; i < ngen; i++ ) {      for ( i = 0; i < ngen; i++ ) {
      tsyz = syzlist[i];        tsyz = syzlist[i];
      for ( prev = 0; tsyz != 0; prev = tsyz, tsyz = NEXT(tsyz))        for ( prev = 0; tsyz != 0; prev = tsyz, tsyz = NEXT(tsyz))
        BDY(tsyz) = (pointer)sigtodpm((SIG)BDY(tsyz));          BDY(tsyz) = (pointer)sigtodpm((SIG)BDY(tsyz));
      if ( prev != 0 ) {        if ( prev != 0 ) {
        prev->next = hsyz; hsyz = syzlist[i];          prev->next = hsyz; hsyz = syzlist[i];
      }        }
    }      }
    *syzp = hsyz;      *syzp = hsyz;
  } else *syzp = 0;    } else *syzp = 0;
  return g;    return g;
 }  }
   
 /* splist = [[i1,i2],...] */  /* splist = [[i1,i2],...] */
Line 3266  int check_splist(int m,NODE splist)
Line 3240  int check_splist(int m,NODE splist)
   for ( d = 0, t = splist; t; t = NEXT(t) ) {    for ( d = 0, t = splist; t; t = NEXT(t) ) {
     p = BDY((LIST)BDY(t));      p = BDY((LIST)BDY(t));
     NEXTND_pairs(d,r);      NEXTND_pairs(d,r);
     r->i1 = ZTOS((Q)ARG0(p)); r->i2 = ZTOS((Q)ARG1(p));      r->i1 = (int)ZTOS((Q)ARG0(p)); r->i2 = (int)ZTOS((Q)ARG1(p));
     ndl_lcm(DL(nd_psh[r->i1]),DL(nd_psh[r->i2]),r->lcm);      ndl_lcm(DL(nd_psh[r->i1]),DL(nd_psh[r->i2]),r->lcm);
     SG(r) = TD(LCM(r)); /* XXX */      SG(r) = TD(LCM(r)); /* XXX */
   }    }
Line 3304  int check_splist_f4(int m,NODE splist)
Line 3278  int check_splist_f4(int m,NODE splist)
   for ( d = 0, t = splist; t; t = NEXT(t) ) {    for ( d = 0, t = splist; t; t = NEXT(t) ) {
     p = BDY((LIST)BDY(t));      p = BDY((LIST)BDY(t));
     NEXTND_pairs(d,r);      NEXTND_pairs(d,r);
     r->i1 = ZTOS((Q)ARG0(p)); r->i2 = ZTOS((Q)ARG1(p));      r->i1 = (int)ZTOS((Q)ARG0(p)); r->i2 = (int)ZTOS((Q)ARG1(p));
     ndl_lcm(DL(nd_psh[r->i1]),DL(nd_psh[r->i2]),r->lcm);      ndl_lcm(DL(nd_psh[r->i1]),DL(nd_psh[r->i2]),r->lcm);
     SG(r) = TD(LCM(r)); /* XXX */      SG(r) = TD(LCM(r)); /* XXX */
   }    }
Line 3335  int check_splist_f4(int m,NODE splist)
Line 3309  int check_splist_f4(int m,NODE splist)
   
 int do_diagonalize_trace(int sugar,int m)  int do_diagonalize_trace(int sugar,int m)
 {  {
   int i,nh,stat;    int i,stat;
   NODE r,g,t;    ND nf,s,head;
   ND h,nf,nfq,s,head;    NDV nfv;
   NDV nfv,nfqv;  
   Q q,den,num;  
   union oNDC hc;    union oNDC hc;
   NODE node;    NODE node;
   LIST l;    LIST l;
   Z iq;    Z iq;
   P cont,cont1;    P cont;
   
   if ( diag_period == 0 ) return 1;    if ( diag_period == 0 ) return 1;
   for ( i = nd_psn-1; i >= 0 && SG(nd_psh[i]) == sugar; i-- ) {    for ( i = nd_psn-1; i >= 0 && SG(nd_psh[i]) == sugar; i-- ) {
Line 3407  void nd_subst_vector(VL vl,P p,NODE subst,P *r)
Line 3379  void nd_subst_vector(VL vl,P p,NODE subst,P *r)
 NODE nd_gb_trace(int m,int ishomo,int **indp)  NODE nd_gb_trace(int m,int ishomo,int **indp)
 {  {
   int i,nh,sugar,stat;    int i,nh,sugar,stat;
   NODE r,g,t;    NODE g,t;
   ND_pairs d;    ND_pairs d;
   ND_pairs l;    ND_pairs l;
   ND h,nf,nfq,s,head;    ND h,nf,nfq;
   NDV nfv,nfqv;    NDV nfv,nfqv;
   Z q,den,num;    Z q;
   P hc;    P hc;
   union oNDC dn,hnfq;    union oNDC hnfq;
   struct oEGT eg_monic,egm0,egm1;    struct oEGT eg_monic,egm0,egm1;
   int diag_count = 0;    int diag_count = 0;
   P cont;    P cont;
   LIST list;    LIST list;
   struct oHPDATA current_hpdata,final_hpdata;    struct oHPDATA current_hpdata,final_hpdata;
   int final_hpvalue;  
   
   init_eg(&eg_monic);    init_eg(&eg_monic);
   init_eg(&eg_invdalg);    init_eg(&eg_invdalg);
Line 3590  NODE ndv_reduceall(int m,NODE f)
Line 3561  NODE ndv_reduceall(int m,NODE f)
   int i,j,n,stat;    int i,j,n,stat;
   ND nf,g,head;    ND nf,g,head;
   NODE t,a0,a;    NODE t,a0,a;
   union oNDC dn;  
   Q q,num,den;  
   NODE node;    NODE node;
   LIST l;    LIST l;
   Z iq,jq;    Z iq,jq;
   int *perm;    int *perm;
   union oNDC hc;    union oNDC hc;
   P cont,cont1;    P cont;
   
   if ( nd_nora ) return f;    if ( nd_nora ) return f;
   n = length(f);    n = length(f);
Line 3605  NODE ndv_reduceall(int m,NODE f)
Line 3574  NODE ndv_reduceall(int m,NODE f)
   perm = (int *)MALLOC(n*sizeof(int));    perm = (int *)MALLOC(n*sizeof(int));
   if ( nd_gentrace ) {    if ( nd_gentrace ) {
     for ( t = nd_tracelist, i = 0; i < n; i++, t = NEXT(t) )      for ( t = nd_tracelist, i = 0; i < n; i++, t = NEXT(t) )
       perm[i] = ZTOS((Q)ARG1(BDY((LIST)BDY(t))));        perm[i] = (int)ZTOS((Q)ARG1(BDY((LIST)BDY(t))));
   }    }
   for ( i = 0; i < n; ) {    for ( i = 0; i < n; ) {
     if ( nd_gentrace ) {      if ( nd_gentrace ) {
Line 3624  NODE ndv_reduceall(int m,NODE f)
Line 3593  NODE ndv_reduceall(int m,NODE f)
       hc = HCU(nf); nd_removecont(m,nf);        hc = HCU(nf); nd_removecont(m,nf);
       if ( nd_gentrace ) {        if ( nd_gentrace ) {
         for ( t = nd_tracelist; t; t = NEXT(t) ) {          for ( t = nd_tracelist; t; t = NEXT(t) ) {
           jq = ARG1(BDY((LIST)BDY(t))); j = ZTOS(jq);            jq = ARG1(BDY((LIST)BDY(t))); j = (int)ZTOS(jq);
           STOZ(perm[j],jq); ARG1(BDY((LIST)BDY(t))) = jq;            STOZ(perm[j],jq); ARG1(BDY((LIST)BDY(t))) = jq;
         }          }
         /* exact division */          /* exact division */
Line 3747  ND_pairs nd_newpairs( NODE g, int t )
Line 3716  ND_pairs nd_newpairs( NODE g, int t )
   
   dl = DL(nd_psh[t]);    dl = DL(nd_psh[t]);
   ts = SG(nd_psh[t]) - TD(dl);    ts = SG(nd_psh[t]) - TD(dl);
   if ( nd_module && nd_intersect && (MPOS(dl) > nd_intersect) ) return 0;    if ( nd_module && nd_intersect && (MPOS(dl) > (UINT)nd_intersect) ) return 0;
   for ( r0 = 0, h = g; h; h = NEXT(h) ) {    for ( r0 = 0, h = g; h; h = NEXT(h) ) {
     if ( nd_module && (MPOS(DL(nd_psh[(long)BDY(h)])) != MPOS(dl)) )      if ( nd_module && (MPOS(DL(nd_psh[(long)BDY(h)])) != MPOS(dl)) )
       continue;        continue;
Line 3779  int sig_cmpdl_op(int n,DL d1,DL d2)
Line 3748  int sig_cmpdl_op(int n,DL d1,DL d2)
 {  {
   int e1,e2,i,j,l;    int e1,e2,i,j,l;
   int *t1,*t2;    int *t1,*t2;
   int len,head;    int len;
   struct order_pair *pair;    struct order_pair *pair;
   
   len = nd_sba_modord->block_length;    len = nd_sba_modord->block_length;
   pair = nd_sba_modord->order_pair;    pair = nd_sba_modord->order_pair;
   
   head = 0;  
   for ( i = 0, t1 = d1->d, t2 = d2->d; i < len; i++ ) {    for ( i = 0, t1 = d1->d, t2 = d2->d; i < len; i++ ) {
     l = pair[i].length;      l = pair[i].length;
     switch ( pair[i].order ) {      switch ( pair[i].order ) {
Line 3827  int sig_cmpdl_op(int n,DL d1,DL d2)
Line 3795  int sig_cmpdl_op(int n,DL d1,DL d2)
       default:        default:
         error("sig_cmpdl_op : invalid order"); break;          error("sig_cmpdl_op : invalid order"); break;
     }      }
     t1 += l; t2 += l; head += l;      t1 += l; t2 += l; // head += l;
   }    }
   return 0;    return 0;
 }  }
Line 3901  struct comp_sig_spec *create_comp_sig_spec(VL current_
Line 3869  struct comp_sig_spec *create_comp_sig_spec(VL current_
     for ( n = 0, t = node; t; t = NEXT(t), n++ );      for ( n = 0, t = node; t; t = NEXT(t), n++ );
     l = (struct order_pair *)MALLOC_ATOMIC(n*sizeof(struct order_pair));      l = (struct order_pair *)MALLOC_ATOMIC(n*sizeof(struct order_pair));
     for ( i = 0, t = node, s = 0; i < n; t = NEXT(t), i++ ) {      for ( i = 0, t = node, s = 0; i < n; t = NEXT(t), i++ ) {
       tn = BDY((LIST)BDY(t)); l[i].order = ZTOS((Q)BDY(tn));        tn = BDY((LIST)BDY(t)); l[i].order = (int)ZTOS((Q)BDY(tn));
       tn = NEXT(tn); l[i].length = ZTOS((Q)BDY(tn));        tn = NEXT(tn); l[i].length = (int)ZTOS((Q)BDY(tn));
       s += l[i].length;        s += l[i].length;
     }      }
     if ( s != nvar )      if ( s != nvar )
Line 3917  struct comp_sig_spec *create_comp_sig_spec(VL current_
Line 3885  struct comp_sig_spec *create_comp_sig_spec(VL current_
     w = almat(m->row,m->col);      w = almat(m->row,m->col);
     for ( i = 0; i < m->row; i++ )      for ( i = 0; i < m->row; i++ )
       for ( j = 0; j < m->col; j++ )        for ( j = 0; j < m->col; j++ )
         w[i][j] = ZTOS((Q)b[i][j]);          w[i][j] = (int)ZTOS((Q)b[i][j]);
     spec->row = m->row;      spec->row = m->row;
     spec->matrix = w;      spec->matrix = w;
     spec->cmpdl = sig_cmpdl_mat;      spec->cmpdl = sig_cmpdl_mat;
Line 3927  struct comp_sig_spec *create_comp_sig_spec(VL current_
Line 3895  struct comp_sig_spec *create_comp_sig_spec(VL current_
     node = BDY((LIST)weight);      node = BDY((LIST)weight);
     a = (int *)MALLOC(nvar*sizeof(int));      a = (int *)MALLOC(nvar*sizeof(int));
     for ( i = 0; i < nvar; i++, node = NEXT(node) )      for ( i = 0; i < nvar; i++, node = NEXT(node) )
       a[i] = ZTOS((Z)BDY(node));        a[i] = (int)ZTOS((Z)BDY(node));
     spec->weight = a;      spec->weight = a;
   }    }
   return spec;    return spec;
Line 4074  void dup_ND_pairs(ND_pairs to,ND_pairs from)
Line 4042  void dup_ND_pairs(ND_pairs to,ND_pairs from)
 ND_pairs merge_pairs_s(ND_pairs p1,ND_pairs p2)  ND_pairs merge_pairs_s(ND_pairs p1,ND_pairs p2)
 {  {
   struct oND_pairs root;    struct oND_pairs root;
   ND_pairs q1,q2,r0,r;    ND_pairs q1,q2,r;
   int ret;    int ret;
   
   r = &root;    r = &root;
Line 4157  INLINE int __dl_redble(DL d1,DL d2,int nvar)
Line 4125  INLINE int __dl_redble(DL d1,DL d2,int nvar)
   
 ND_pairs nd_newpairs_s(int t, NODE *syz)  ND_pairs nd_newpairs_s(int t, NODE *syz)
 {  {
   NODE h,s;    NODE s;
   UINT *dl;    int ret,i;
   int ts,ret,i;    ND_pairs r0,_sp,sp;
   ND_pairs r,r0,_sp,sp;  
   SIG spsig,tsig;    SIG spsig,tsig;
   static int nvar = 0;    static int nvar = 0;
   static SIG _sig1,_sig2;    static SIG _sig1,_sig2;
   struct oEGT eg1,eg2,eg3,eg4;  
   
   NEWND_pairs(_sp);    NEWND_pairs(_sp);
   if ( !_sig1 || nvar != nd_nvar ) {    if ( !_sig1 || nvar != nd_nvar ) {
Line 4193  ND_pairs nd_newpairs_s(int t, NODE *syz)
Line 4159  ND_pairs nd_newpairs_s(int t, NODE *syz)
   
 ND_pairs *nd_newpairs_array_s(int t, NODE *syz)  ND_pairs *nd_newpairs_array_s(int t, NODE *syz)
 {  {
   NODE h,s;    NODE s;
   UINT *dl;    int ret,i;
   int ts,ret,i;    ND_pairs _sp,sp;
   ND_pairs r,r0,_sp,sp;  
   ND_pairs *d;    ND_pairs *d;
   SIG spsig,tsig;    SIG spsig,tsig;
   static int nvar = 0;    static int nvar = 0;
   static SIG _sig1,_sig2;    static SIG _sig1,_sig2;
   struct oEGT eg1,eg2,eg3,eg4;  
   
   NEWND_pairs(_sp);    NEWND_pairs(_sp);
   if ( !_sig1 || nvar != nd_nvar ) {    if ( !_sig1 || nvar != nd_nvar ) {
Line 4239  ND_pairs nd_ipairtospair(NODE ipair)
Line 4203  ND_pairs nd_ipairtospair(NODE ipair)
   for ( r0 = 0, t = ipair; t; t = NEXT(t) ) {    for ( r0 = 0, t = ipair; t; t = NEXT(t) ) {
     NEXTND_pairs(r0,r);      NEXTND_pairs(r0,r);
     tn = BDY((LIST)BDY(t));      tn = BDY((LIST)BDY(t));
     r->i1 = ZTOS((Q)ARG0(tn));      r->i1 = (int)ZTOS((Q)ARG0(tn));
     r->i2 = ZTOS((Q)ARG1(tn));      r->i2 = (int)ZTOS((Q)ARG1(tn));
     ndl_lcm(DL(nd_psh[r->i1]),DL(nd_psh[r->i2]),r->lcm);      ndl_lcm(DL(nd_psh[r->i1]),DL(nd_psh[r->i2]),r->lcm);
     s1 = SG(nd_psh[r->i1])-TD(DL(nd_psh[r->i1]));      s1 = SG(nd_psh[r->i1])-TD(DL(nd_psh[r->i1]));
     s2 = SG(nd_psh[r->i2])-TD(DL(nd_psh[r->i2]));      s2 = SG(nd_psh[r->i2])-TD(DL(nd_psh[r->i2]));
Line 4259  ND_pairs crit_B( ND_pairs d, int s )
Line 4223  ND_pairs crit_B( ND_pairs d, int s )
 {  {
   ND_pairs cur,head,prev,remove;    ND_pairs cur,head,prev,remove;
   UINT *t,*tl,*lcm;    UINT *t,*tl,*lcm;
   int td,tdl;  
   
   if ( !d ) return 0;    if ( !d ) return 0;
   t = DL(nd_psh[s]);    t = DL(nd_psh[s]);
Line 4425  NODE update_base(NODE nd,int ndp)
Line 4388  NODE update_base(NODE nd,int ndp)
 ND_pairs nd_minp( ND_pairs d, ND_pairs *prest )  ND_pairs nd_minp( ND_pairs d, ND_pairs *prest )
 {  {
     ND_pairs m,ml,p,l;      ND_pairs m,ml,p,l;
     UINT *lcm;      int s;
     int s,td,len,tlen,c,c1;  
   
     if ( !(p = NEXT(m = d)) ) {      if ( !(p = NEXT(m = d)) ) {
         *prest = p;          *prest = p;
Line 4526  int nd_tdeg(NDV c)
Line 4488  int nd_tdeg(NDV c)
   
   len = LEN(c);    len = LEN(c);
   for ( a = BDY(c), i = 0; i < len; i++, NMV_ADV(a) )    for ( a = BDY(c), i = 0; i < len; i++, NMV_ADV(a) )
     wmax = MAX(TD(DL(a)),wmax);      wmax = MAX((int)TD(DL(a)),wmax);
   return wmax;    return wmax;
 }  }
   
 int ndv_newps(int m,NDV a,NDV aq)  int ndv_newps(int m,NDV a,NDV aq)
 {  {
     int len;  
     RHist r;      RHist r;
     NDV b;  
     NODE tn;      NODE tn;
     LIST l;      LIST l;
     Z iq;      Z iq;
Line 4622  void ndv_lm_modord(NDV p,DL d)
Line 4582  void ndv_lm_modord(NDV p,DL d)
   
 int ndv_setup(int mod,int trace,NODE f,int dont_sort,int dont_removecont,int sba)  int ndv_setup(int mod,int trace,NODE f,int dont_sort,int dont_removecont,int sba)
 {  {
   int i,j,td,len,max;    int i,j;
   NODE s,s0,f0,tn;    NODE s,tn;
   UINT *d;  
   RHist r;    RHist r;
   NDVI w;    NDVI w;
   NDV a,am;    NDV a,am;
   union oNDC hc;    union oNDC hc;
   NODE node;    NODE node;
   P hcp;  
   Z iq,jq;    Z iq,jq;
   LIST l;    LIST l;
   
Line 4679  int ndv_setup(int mod,int trace,NODE f,int dont_sort,i
Line 4637  int ndv_setup(int mod,int trace,NODE f,int dont_sort,i
         if ( !dont_removecont) ndv_removecont(-2,a);          if ( !dont_removecont) ndv_removecont(-2,a);
         am = nd_ps[i] = ndv_dup(trace,w[i].p);          am = nd_ps[i] = ndv_dup(trace,w[i].p);
         ndv_mod(trace,am);          ndv_mod(trace,am);
       if ( DL_COMPARE(HDL(am),HDL(a)) )          if ( DL_COMPARE(HDL(am),HDL(a)) ) return 0;
         return 0;  
         ndv_removecont(trace,am);          ndv_removecont(trace,am);
       } else {        } else {
         a = nd_ps_trace[i] = ndv_dup(0,w[i].p);          a = nd_ps_trace[i] = ndv_dup(0,w[i].p);
Line 4688  int ndv_setup(int mod,int trace,NODE f,int dont_sort,i
Line 4645  int ndv_setup(int mod,int trace,NODE f,int dont_sort,i
         register_hcf(a);          register_hcf(a);
         am = nd_ps[i] = ndv_dup(mod,a);          am = nd_ps[i] = ndv_dup(mod,a);
         ndv_mod(mod,am);          ndv_mod(mod,am);
       if ( DL_COMPARE(HDL(am),HDL(a)) )          if ( DL_COMPARE(HDL(am),HDL(a)) ) return 0;
         return 0;  
         ndv_removecont(mod,am);          ndv_removecont(mod,am);
       }        }
     } else {      } else {
Line 4760  static VECT prev_weight_vector_obj;
Line 4716  static VECT prev_weight_vector_obj;
 void preprocess_algcoef(VL vv,VL av,struct order_spec *ord,LIST f,  void preprocess_algcoef(VL vv,VL av,struct order_spec *ord,LIST f,
     struct order_spec **ord1p,LIST *f1p,NODE *alistp)      struct order_spec **ord1p,LIST *f1p,NODE *alistp)
 {  {
     NODE alist,t,s,r0,r,arg;      NODE alist,t,s,arg;
     VL tv;      VL tv;
     P poly;      P poly;
     DP d;      DP d;
Line 4769  void preprocess_algcoef(VL vv,VL av,struct order_spec 
Line 4725  void preprocess_algcoef(VL vv,VL av,struct order_spec 
     MP m;      MP m;
     int i,nvar,nalg,n;      int i,nvar,nalg,n;
     NumberField nf;      NumberField nf;
     LIST f1,f2;      LIST f1;
     struct order_spec *current_spec;  
     VECT obj,obj0;      VECT obj,obj0;
     VECT tmp;      VECT tmp;
   
Line 4859  NODE postprocess_algcoef(VL av,NODE alist,NODE r)
Line 4814  NODE postprocess_algcoef(VL av,NODE alist,NODE r)
   
 void nd_gr(LIST f,LIST v,int m,int homo,int retdp,int f4,struct order_spec *ord,LIST *rp)  void nd_gr(LIST f,LIST v,int m,int homo,int retdp,int f4,struct order_spec *ord,LIST *rp)
 {  {
     VL tv,fv,vv,vc,av;    VL tv,fv,vv,av;
     NODE fd,fd0,r,r0,t,x,s,xx,alist;    NODE fd,fd0,r0,t,x,s,xx,alist,r;
     int e,max,nvar,i;    int e,max,nvar,i;
     NDV b;    NDV b;
     int ishomo,nalg,mrank,trank,wmax,len;    int ishomo,nalg,mrank,trank,wmax,len;
   NMV a;    NMV a;
     Alg alpha,dp;    P zp;
     P p,zp;    Q dmy;
     Q dmy;    LIST f1,zpl;
     LIST f1,f2,zpl;    struct order_spec *ord1;
     Obj obj;    NODE tr,tl1,tl2,tl3,tl4,nzlist;
     NumberField nf;    LIST l1,l2,l3,l4,l5;
     struct order_spec *ord1;  
     NODE tr,tl1,tl2,tl3,tl4,nzlist;  
     LIST l1,l2,l3,l4,l5;  
   int j;    int j;
   Z jq,bpe,last_nonzero;    Z jq,bpe,last_nonzero;
     int *perm;    int *perm;
     EPOS oepos;    EPOS oepos;
     int obpe,oadv,ompos,cbpe;    int obpe,oadv,ompos,cbpe;
     VECT hvect;    VECT hvect;
   
     NcriB = NcriMF = Ncri2 = 0;    NcriB = NcriMF = Ncri2 = 0;
     nd_module = 0;    nd_module = 0;
     if ( !m && Demand ) nd_demand = 1;    if ( !m && Demand ) nd_demand = 1;
     else nd_demand = 0;    else nd_demand = 0;
   
     if ( DP_Multiple )    if ( DP_Multiple )
         nd_scale = ((double)DP_Multiple)/(double)(Denominator?Denominator:1);      nd_scale = ((double)DP_Multiple)/(double)(Denominator?Denominator:1);
 #if 0  #if 0
     ndv_alloc = 0;    ndv_alloc = 0;
 #endif  #endif
     get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc);    get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc);
     parse_nd_option(vv,current_option);    parse_nd_option(vv,current_option);
     if ( m && nd_vc )    if ( m && nd_vc )
        error("nd_{gr,f4} : computation over Fp(X) is unsupported. Use dp_gr_mod_main().");      error("nd_{gr,f4} : computation over Fp(X) is unsupported. Use dp_gr_mod_main().");
     for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ );    for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ );
     switch ( ord->id ) {    switch ( ord->id ) {
         case 1:      case 1:
             if ( ord->nv != nvar )        if ( ord->nv != nvar )
                 error("nd_{gr,f4} : invalid order specification");          error("nd_{gr,f4} : invalid order specification");
             break;        break;
         default:      default:
             break;        break;
     }
     nd_nalg = 0;
     av = 0;
     if ( !m ) {
       get_algtree((Obj)f,&av);
       for ( nalg = 0, tv = av; tv; tv = NEXT(tv), nalg++ );
       nd_ntrans = nvar;
       nd_nalg = nalg;
       /* #i -> t#i */
       if ( nalg ) {
         preprocess_algcoef(vv,av,ord,f,&ord1,&f1,&alist);
         ord = ord1;
         f = f1;
     }      }
     nd_nalg = 0;      nvar += nalg;
     av = 0;    }
     if ( !m ) {    nd_init_ord(ord);
         get_algtree((Obj)f,&av);    mrank = 0;
         for ( nalg = 0, tv = av; tv; tv = NEXT(tv), nalg++ );    for ( t = BDY(f), max = 1; t; t = NEXT(t) )
         nd_ntrans = nvar;      for ( tv = vv; tv; tv = NEXT(tv) ) {
         nd_nalg = nalg;  
         /* #i -> t#i */  
         if ( nalg ) {  
             preprocess_algcoef(vv,av,ord,f,&ord1,&f1,&alist);  
             ord = ord1;  
             f = f1;  
         }  
         nvar += nalg;  
     }  
     nd_init_ord(ord);  
     mrank = 0;  
     for ( t = BDY(f), max = 1; t; t = NEXT(t) )  
         for ( tv = vv; tv; tv = NEXT(tv) ) {  
             if ( nd_module ) {  
                 if ( OID(BDY(t)) == O_DPM ) {  
                   e = dpm_getdeg((DPM)BDY(t),&trank);  
                   max = MAX(e,max);  
                   mrank = MAX(mrank,trank);  
                 } else {  
                   s = BDY((LIST)BDY(t));  
                   trank = length(s);  
                   mrank = MAX(mrank,trank);  
                   for ( ; s; s = NEXT(s) ) {  
                       e = getdeg(tv->v,(P)BDY(s));  
                       max = MAX(e,max);  
                   }  
                 }  
             } else {  
                 if ( OID(BDY(t)) == O_DP ) {  
                   e = dp_getdeg((DP)BDY(t));  
                   max = MAX(e,max);  
                 } else {  
                   e = getdeg(tv->v,(P)BDY(t));  
                   max = MAX(e,max);  
                 }  
             }  
         }  
     nd_setup_parameters(nvar,nd_nzlist?0:max);  
     obpe = nd_bpe; oadv = nmv_adv; oepos = nd_epos; ompos = nd_mpos;  
     ishomo = 1;  
     for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) {  
       if ( nd_module ) {        if ( nd_module ) {
         if ( OID(BDY(t)) == O_DPM ) {          if ( OID(BDY(t)) == O_DPM ) {
           Z cont;            e = dpm_getdeg((DPM)BDY(t),&trank);
           DPM zdpm;            max = MAX(e,max);
             mrank = MAX(mrank,trank);
           if ( !m && !nd_gentrace ) dpm_ptozp((DPM)BDY(t),&cont,&zdpm);  
           else zdpm = (DPM)BDY(t);  
           b = (pointer)dpmtondv(m,zdpm);  
         } else {          } else {
           if ( !m && !nd_gentrace ) pltozpl((LIST)BDY(t),&dmy,&zpl);            s = BDY((LIST)BDY(t));
           else zpl = (LIST)BDY(t);            trank = length(s);
           b = (pointer)pltondv(CO,vv,zpl);            mrank = MAX(mrank,trank);
             for ( ; s; s = NEXT(s) ) {
               e = getdeg(tv->v,(P)BDY(s));
               max = MAX(e,max);
             }
         }          }
       } else {        } else {
         if ( OID(BDY(t)) == O_DP ) {          if ( OID(BDY(t)) == O_DP ) {
           DP zdp;            e = dp_getdeg((DP)BDY(t));
             max = MAX(e,max);
           if ( !m && !nd_gentrace ) dp_ptozp((DP)BDY(t),&zdp);  
           else zdp = (DP)BDY(t);  
           b = (pointer)dptondv(m,zdp);  
         } else {          } else {
           if ( !m && !nd_gentrace ) ptozp((P)BDY(t),1,&dmy,&zp);            e = getdeg(tv->v,(P)BDY(t));
           else zp = (P)BDY(t);            max = MAX(e,max);
           b = (pointer)ptondv(CO,vv,zp);  
         }          }
       }        }
       if ( ishomo )  
         ishomo = ishomo && ndv_ishomo(b);  
       if ( m ) ndv_mod(m,b);  
       if ( b ) { NEXTNODE(fd0,fd); BDY(fd) = (pointer)b; }  
     }      }
     if ( fd0 ) NEXT(fd) = 0;    nd_setup_parameters(nvar,nd_nzlist?0:max);
     obpe = nd_bpe; oadv = nmv_adv; oepos = nd_epos; ompos = nd_mpos;
     ishomo = 1;
     for ( fd0 = 0, t = BDY(f); t; t = NEXT(t) ) {
       if ( nd_module ) {
         if ( OID(BDY(t)) == O_DPM ) {
           Z cont;
           DPM zdpm;
   
           if ( !m && !nd_gentrace ) dpm_ptozp((DPM)BDY(t),&cont,&zdpm);
           else zdpm = (DPM)BDY(t);
           b = (pointer)dpmtondv(m,zdpm);
         } else {
           if ( !m && !nd_gentrace ) pltozpl((LIST)BDY(t),&dmy,&zpl);
           else zpl = (LIST)BDY(t);
           b = (pointer)pltondv(CO,vv,zpl);
         }
       } else {
         if ( OID(BDY(t)) == O_DP ) {
           DP zdp;
   
           if ( !m && !nd_gentrace ) dp_ptozp((DP)BDY(t),&zdp);
           else zdp = (DP)BDY(t);
           b = (pointer)dptondv(m,zdp);
         } else {
           if ( !m && !nd_gentrace ) ptozp((P)BDY(t),1,&dmy,&zp);
           else zp = (P)BDY(t);
           b = (pointer)ptondv(CO,vv,zp);
         }
       }
       if ( ishomo )
         ishomo = ishomo && ndv_ishomo(b);
       if ( m ) ndv_mod(m,b);
       if ( b ) { NEXTNODE(fd0,fd); BDY(fd) = (pointer)b; }
     }
     if ( fd0 ) NEXT(fd) = 0;
   
   if ( !ishomo && homo ) {    if ( !ishomo && homo ) {
         for ( t = fd0, wmax = max; t; t = NEXT(t) ) {          for ( t = fd0, wmax = max; t; t = NEXT(t) ) {
             b = (NDV)BDY(t); len = LEN(b);              b = (NDV)BDY(t); len = LEN(b);
             for ( a = BDY(b), i = 0; i < len; i++, NMV_ADV(a) )              for ( a = BDY(b), i = 0; i < len; i++, NMV_ADV(a) )
                 wmax = MAX(TD(DL(a)),wmax);                  wmax = MAX((int)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,nd_nzlist?0:wmax);          nd_setup_parameters(nvar+1,nd_nzlist?0:wmax);
         for ( t = fd0; t; t = NEXT(t) )          for ( t = fd0; t; t = NEXT(t) )
             ndv_homogenize((NDV)BDY(t),obpe,oadv,oepos,ompos);              ndv_homogenize((NDV)BDY(t),obpe,oadv,oepos,ompos);
     }    }
   
     ndv_setup(m,0,fd0,(nd_gbblock||nd_splist||nd_check_splist)?1:0,0,0);    ndv_setup(m,0,fd0,(nd_gbblock||nd_splist||nd_check_splist)?1:0,0,0);
     if ( nd_gentrace ) {    if ( nd_gentrace ) {
         MKLIST(l1,nd_tracelist); MKNODE(nd_alltracelist,l1,0);        MKLIST(l1,nd_tracelist); MKNODE(nd_alltracelist,l1,0);
     }    }
   if ( nd_splist ) {    if ( nd_splist ) {
     *rp = compute_splist();      *rp = compute_splist();
     return;      return;
   }    }
   if ( nd_check_splist ) {    if ( nd_check_splist ) {
         if ( f4 ) {      if ( f4 ) {
             if ( check_splist_f4(m,nd_check_splist) ) *rp = (LIST)ONE;        if ( check_splist_f4(m,nd_check_splist) ) *rp = (LIST)ONE;
             else *rp = 0;        else *rp = 0;
         } else {      } else {
             if ( check_splist(m,nd_check_splist) ) *rp = (LIST)ONE;        if ( check_splist(m,nd_check_splist) ) *rp = (LIST)ONE;
             else *rp = 0;        else *rp = 0;
         }      }
     return;      return;
   }    }
     x = f4?nd_f4(m,0,&perm):nd_gb(m,ishomo || homo,0,0,&perm);    x = f4?nd_f4(m,0,&perm):nd_gb(m,ishomo || homo,0,0,&perm);
   if ( !x ) {    if ( !x ) {
     *rp = 0; return;      *rp = 0; return;
   }    }
   if ( nd_gentrace ) {    if ( nd_gentrace ) {
     MKVECT(hvect,nd_psn);      MKVECT(hvect,nd_psn);
     for ( i = 0; i < nd_psn; i++ )      for ( i = 0; i < nd_psn; i++ )
        ndltodp(nd_psh[i]->dl,(DP *)&BDY(hvect)[i]);        ndltodp(nd_psh[i]->dl,(DP *)&BDY(hvect)[i]);
   }    }
   if ( !ishomo && homo ) {    if ( !ishomo && homo ) {
        /* dehomogenization */         /* dehomogenization */
Line 5030  void nd_gr(LIST f,LIST v,int m,int homo,int retdp,int 
Line 4982  void nd_gr(LIST f,LIST v,int m,int homo,int retdp,int 
     nd_init_ord(ord);      nd_init_ord(ord);
     nd_setup_parameters(nvar,0);      nd_setup_parameters(nvar,0);
   }    }
     nd_demand = 0;    nd_demand = 0;
   if ( nd_module && nd_intersect ) {    if ( nd_module && nd_intersect ) {
     for ( j = nd_psn-1, x = 0; j >= 0; j-- )      for ( j = nd_psn-1, x = 0; j >= 0; j-- )
       if ( MPOS(DL(nd_psh[j])) > nd_intersect ) {        if ( MPOS(DL(nd_psh[j])) > (UINT)nd_intersect ) {
         MKNODE(xx,(pointer)((unsigned long)j),x); x = xx;          MKNODE(xx,(pointer)((unsigned long)j),x); x = xx;
       }        }
     conv_ilist(nd_demand,0,x,0);      conv_ilist(nd_demand,0,x,0);
     goto FINAL;      goto FINAL;
   }    }
     if ( nd_gentrace  && f4 ) { nzlist = nd_alltracelist; }    if ( nd_gentrace  && f4 ) { nzlist = nd_alltracelist; }
     x = ndv_reducebase(x,perm);    x = ndv_reducebase(x,perm);
     if ( nd_gentrace  && !f4 ) { tl1 = nd_alltracelist; nd_alltracelist = 0; }    if ( nd_gentrace  && !f4 ) { tl1 = nd_alltracelist; nd_alltracelist = 0; }
     x = ndv_reduceall(m,x);    x = ndv_reduceall(m,x);
     cbpe = nd_bpe;    cbpe = nd_bpe;
     if ( nd_gentrace && !f4 ) {    if ( nd_gentrace && !f4 ) {
         tl2 = nd_alltracelist; nd_alltracelist = 0;      tl2 = nd_alltracelist; nd_alltracelist = 0;
         ndv_check_membership(m,fd0,obpe,oadv,oepos,x);      ndv_check_membership(m,fd0,obpe,oadv,oepos,x);
         tl3 = nd_alltracelist; nd_alltracelist = 0;      tl3 = nd_alltracelist; nd_alltracelist = 0;
         if ( nd_gensyz ) {      if ( nd_gensyz ) {
           nd_gb(m,0,1,1,0);        nd_gb(m,0,1,1,0);
             tl4 = nd_alltracelist; nd_alltracelist = 0;        tl4 = nd_alltracelist; nd_alltracelist = 0;
         } else tl4 = 0;      } else tl4 = 0;
     }    }
     nd_bpe = cbpe;    nd_bpe = cbpe;
     nd_setup_parameters(nd_nvar,0);    nd_setup_parameters(nd_nvar,0);
 FINAL:  FINAL:
     for ( r0 = 0, t = x; t; t = NEXT(t) ) {    for ( r0 = 0, t = x; t; t = NEXT(t) ) {
       NEXTNODE(r0,r);      NEXTNODE(r0,r);
       if ( nd_module ) {      if ( nd_module ) {
         if ( retdp ) BDY(r) = ndvtodpm(m,BDY(t));        if ( retdp ) BDY(r) = ndvtodpm(m,BDY(t));
         else BDY(r) = ndvtopl(m,CO,vv,BDY(t),mrank);        else BDY(r) = ndvtopl(m,CO,vv,BDY(t),mrank);
       } else if ( retdp ) BDY(r) = ndvtodp(m,BDY(t));      } else if ( retdp ) BDY(r) = ndvtodp(m,BDY(t));
       else BDY(r) = ndvtop(m,CO,vv,BDY(t));      else BDY(r) = ndvtop(m,CO,vv,BDY(t));
     }    }
     if ( r0 ) NEXT(r) = 0;    if ( r0 ) NEXT(r) = 0;
     if ( !m && nd_nalg )    if ( !m && nd_nalg )
         r0 = postprocess_algcoef(av,alist,r0);          r0 = postprocess_algcoef(av,alist,r0);
     MKLIST(*rp,r0);    MKLIST(*rp,r0);
     if ( nd_gentrace ) {    if ( nd_gentrace ) {
   if ( f4 ) {    if ( f4 ) {
             STOZ(16,bpe);              STOZ(16,bpe);
             STOZ(nd_last_nonzero,last_nonzero);              STOZ(nd_last_nonzero,last_nonzero);
Line 5104  NODE nd_sba_f4(int m,int **indp);
Line 5056  NODE nd_sba_f4(int m,int **indp);
   
 void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int f4,struct order_spec *ord,LIST *rp)  void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int f4,struct order_spec *ord,LIST *rp)
 {  {
   VL tv,fv,vv,vc,av;    VL tv,fv,vv;
   NODE fd,fd0,r,r0,t,x,s,xx,nd,nd1,syz;    NODE fd,fd0,r,r0,t,x,nd,nd1,syz;
   int e,max,nvar,i;    int e,max,nvar,i;
   NDV b;    NDV b;
   int ishomo,nalg,wmax,len;    int ishomo,wmax,len;
   NMV a;    NMV a;
   P p,zp;    P zp;
   Q dmy;    Q dmy;
   struct order_spec *ord1;    struct order_spec *ord1;
   int j;  
   int *perm;    int *perm;
   EPOS oepos;    EPOS oepos;
   int obpe,oadv,ompos,cbpe;    int obpe,oadv,ompos;
   struct oEGT eg0,eg1,egconv,egintred;    struct oEGT eg0,eg1,egconv,egintred;
   LIST l1,redind;    LIST l1,redind;
   Z z;    Z z;
Line 5135  void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int
Line 5086  void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int
     case 1:      case 1:
       if ( ord->nv != nvar )        if ( ord->nv != nvar )
         error("nd_sba : invalid order specification");          error("nd_sba : invalid order specification");
         break;        break;
       default:      default:
         break;        break;
   }    }
   nd_nalg = 0;    nd_nalg = 0;
   nd_init_ord(ord);    nd_init_ord(ord);
Line 5180  void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int
Line 5131  void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int
     for ( t = fd0, wmax = max; t; t = NEXT(t) ) {      for ( t = fd0, wmax = max; t; t = NEXT(t) ) {
       b = (NDV)BDY(t); len = LEN(b);        b = (NDV)BDY(t); len = LEN(b);
       for ( a = BDY(b), i = 0; i < len; i++, NMV_ADV(a) )        for ( a = BDY(b), i = 0; i < len; i++, NMV_ADV(a) )
         wmax = MAX(TD(DL(a)),wmax);          wmax = MAX((int)TD(DL(a)),wmax);
       }        }
       homogenize_order(ord,nvar,&ord1);        homogenize_order(ord,nvar,&ord1);
       nd_init_ord(ord1);        nd_init_ord(ord1);
Line 5247  void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int
Line 5198  void nd_sba(LIST f,LIST v,int m,int homo,int retdp,int
   
 void nd_gr_postproc(LIST f,LIST v,int m,struct order_spec *ord,int do_check,LIST *rp)  void nd_gr_postproc(LIST f,LIST v,int m,struct order_spec *ord,int do_check,LIST *rp)
 {  {
     VL tv,fv,vv,vc,av;      VL tv,fv,vv,av;
     NODE fd,fd0,r,r0,t,x,s,xx,alist;      NODE fd,fd0,r,r0,t,x,alist;
     int e,max,nvar,i;      int e,max,nvar,i,nalg;
     NDV b;      NDV b;
     int ishomo,nalg;      int ishomo;
     Alg alpha,dp;      P zp;
     P p,zp;  
     Q dmy;      Q dmy;
     LIST f1,f2;      LIST f1;
     Obj obj;  
     NumberField nf;  
     struct order_spec *ord1;      struct order_spec *ord1;
     int *perm;      int *perm;
   
Line 5393  NDV recompute_trace(NODE ti,NDV *p,int mod)
Line 5341  NDV recompute_trace(NODE ti,NDV *p,int mod)
   
 void nd_gr_recompute_trace(LIST f,LIST v,int m,struct order_spec *ord,LIST tlist,LIST *rp)  void nd_gr_recompute_trace(LIST f,LIST v,int m,struct order_spec *ord,LIST tlist,LIST *rp)
 {  {
     VL tv,fv,vv,vc,av;    VL tv,fv,vv;
     NODE fd,fd0,r,r0,t,x,s,xx,alist;    NODE r,r0,t;
     int e,max,nvar,i;    int nvar,i;
     NDV b;    NDV b;
     int ishomo,nalg;    P zp;
     Alg alpha,dp;    Q dmy;
     P p,zp;  
     Q dmy;  
     LIST f1,f2;  
     Obj obj;  
     NumberField nf;  
     struct order_spec *ord1;  
   NODE permtrace,intred,ind,perm,trace,ti;    NODE permtrace,intred,ind,perm,trace,ti;
   int len,n,j;    int len,n,j;
   NDV *db,*pb;    NDV *db,*pb;
   
     get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc);    get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc);
     parse_nd_option(vv,current_option);    parse_nd_option(vv,current_option);
     for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ );    for ( nvar = 0, tv = vv; tv; tv = NEXT(tv), nvar++ );
     switch ( ord->id ) {    switch ( ord->id ) {
         case 1:      case 1:
             if ( ord->nv != nvar )        if ( ord->nv != nvar )
                 error("nd_check : invalid order specification");          error("nd_check : invalid order specification");
             break;        break;
         default:      default:
             break;        break;
     }    }
     nd_init_ord(ord);    nd_init_ord(ord);
   nd_bpe = ZTOS((Q)ARG7(BDY(tlist)));    nd_bpe = (int)ZTOS((Q)ARG7(BDY(tlist)));
     nd_setup_parameters(nvar,0);    nd_setup_parameters(nvar,0);
   
   len = length(BDY(f));    len = length(BDY(f));
   db = (NDV *)MALLOC(len*sizeof(NDV *));    db = (NDV *)MALLOC(len*sizeof(NDV *));
   for ( i = 0, t = BDY(f); t; i++, t = NEXT(t) ) {    for ( i = 0, t = BDY(f); t; i++, t = NEXT(t) ) {
       ptozp((P)BDY(t),1,&dmy,&zp);      ptozp((P)BDY(t),1,&dmy,&zp);
       b = ptondv(CO,vv,zp);      b = ptondv(CO,vv,zp);
         ndv_mod(m,b);      ndv_mod(m,b);
     ndv_mul_c(m,b,invm(HCM(b),m));      ndv_mul_c(m,b,invm(HCM(b),m));
     db[i] = b;      db[i] = b;
     }    }
   
   permtrace = BDY((LIST)ARG2(BDY(tlist)));    permtrace = BDY((LIST)ARG2(BDY(tlist)));
   intred = BDY((LIST)ARG3(BDY(tlist)));    intred = BDY((LIST)ARG3(BDY(tlist)));
Line 5441  void nd_gr_recompute_trace(LIST f,LIST v,int m,struct 
Line 5383  void nd_gr_recompute_trace(LIST f,LIST v,int m,struct 
   trace = NEXT(permtrace);    trace = NEXT(permtrace);
   
   for ( i = length(perm)-1, t = trace; t; t = NEXT(t) ) {    for ( i = length(perm)-1, t = trace; t; t = NEXT(t) ) {
     j = ZTOS((Q)ARG0(BDY((LIST)BDY(t))));      j = (int)ZTOS((Q)ARG0(BDY((LIST)BDY(t))));
     if ( j > i ) i = j;      if ( j > i ) i = j;
   }    }
   n = i+1;    n = i+1;
Line 5463  void nd_gr_recompute_trace(LIST f,LIST v,int m,struct 
Line 5405  void nd_gr_recompute_trace(LIST f,LIST v,int m,struct 
     pb[ZTOS((Q)ARG0(ti))] = recompute_trace(BDY((LIST)ARG1(ti)),pb,m);      pb[ZTOS((Q)ARG0(ti))] = recompute_trace(BDY((LIST)ARG1(ti)),pb,m);
     if ( !pb[ZTOS((Q)ARG0(ti))] ) { *rp = 0; return; }      if ( !pb[ZTOS((Q)ARG0(ti))] ) { *rp = 0; return; }
       if ( DP_Print ) {        if ( DP_Print ) {
            fprintf(asir_out,"*"); fflush(asir_out);          fprintf(asir_out,"*"); fflush(asir_out);
       }      }
   }    }
     for ( r0 = 0, t = ind; t; t = NEXT(t) ) {    for ( r0 = 0, t = ind; t; t = NEXT(t) ) {
         NEXTNODE(r0,r);      NEXTNODE(r0,r);
     b = pb[ZTOS((Q)BDY(t))];      b = pb[ZTOS((Q)BDY(t))];
         ndv_mul_c(m,b,invm(HCM(b),m));      ndv_mul_c(m,b,invm(HCM(b),m));
 #if 0  #if 0
         BDY(r) = ndvtop(m,CO,vv,pb[ZTOS((Q)BDY(t))]);      BDY(r) = ndvtop(m,CO,vv,pb[ZTOS((Q)BDY(t))]);
 #else  #else
         BDY(r) = ndvtodp(m,pb[ZTOS((Q)BDY(t))]);      BDY(r) = ndvtodp(m,pb[ZTOS((Q)BDY(t))]);
 #endif  #endif
     }    }
     if ( r0 ) NEXT(r) = 0;    if ( r0 ) NEXT(r) = 0;
     MKLIST(*rp,r0);    MKLIST(*rp,r0);
     if ( DP_Print ) fprintf(asir_out,"\n");    if ( DP_Print ) fprintf(asir_out,"\n");
 }  }
   
 void nd_gr_trace(LIST f,LIST v,int trace,int homo,int retdp,int f4,struct order_spec *ord,LIST *rp)  void nd_gr_trace(LIST f,LIST v,int trace,int homo,int retdp,int f4,struct order_spec *ord,LIST *rp)
 {  {
     VL tv,fv,vv,vc,av;      VL tv,fv,vv,av;
     NODE fd,fd0,in0,in,r,r0,t,s,cand,alist;      NODE fd,fd0,in0,in,r,t,s,cand,alist;
     int m,nocheck,nvar,mindex,e,max;      int m,nocheck,nvar,mindex,e,max;
     NDV c;      NDV c;
     NMV a;      NMV a;
     P p,zp;      P zp;
     Q dmy;      Q dmy;
     EPOS oepos;      EPOS oepos;
     int obpe,oadv,wmax,i,len,cbpe,ishomo,nalg,mrank,trank,ompos;      int obpe,oadv,wmax,i,len,cbpe,ishomo,nalg,mrank,trank,ompos;
     Alg alpha,dp;      LIST f1,zpl;
     P poly;  
     LIST f1,f2,zpl;  
     Obj obj;  
     NumberField nf;  
     struct order_spec *ord1;      struct order_spec *ord1;
     struct oEGT eg_check,eg_gb,eg_intred,eg0,eg1;      struct oEGT eg_check,eg_gb,eg_intred,eg0,eg1;
     NODE tr,tl1,tl2,tl3,tl4;      NODE tr,tl1,tl2,tl3,tl4;
Line 5626  void nd_gr_trace(LIST f,LIST v,int trace,int homo,int 
Line 5564  void nd_gr_trace(LIST f,LIST v,int trace,int homo,int 
         for ( t = in0, wmax = max; t; t = NEXT(t) ) {          for ( t = in0, wmax = max; t; t = NEXT(t) ) {
             c = (NDV)BDY(t); len = LEN(c);              c = (NDV)BDY(t); len = LEN(c);
             for ( a = BDY(c), i = 0; i < len; i++, NMV_ADV(a) )              for ( a = BDY(c), i = 0; i < len; i++, NMV_ADV(a) )
                 wmax = MAX(TD(DL(a)),wmax);                  wmax = MAX((int)TD(DL(a)),wmax);
         }          }
         homogenize_order(ord,nvar,&ord1);          homogenize_order(ord,nvar,&ord1);
         nd_init_ord(ord1);          nd_init_ord(ord1);
Line 5958  void ndv_removecont(int mod,NDV p)
Line 5896  void ndv_removecont(int mod,NDV p)
     int i,len,all_p;      int i,len,all_p;
     Z *c;      Z *c;
     P *w;      P *w;
     Z dvr,t;      Z dvr;
     P g,cont,tp;      P g,cont,tp;
     NMV m;      NMV m;
   
Line 6003  void ndv_homogenize(NDV p,int obpe,int oadv,EPOS oepos
Line 5941  void ndv_homogenize(NDV p,int obpe,int oadv,EPOS oepos
   
     len = p->len;      len = p->len;
     for ( m = BDY(p), i = 0, max = 0; i < len; NMV_OADV(m), i++ )      for ( m = BDY(p), i = 0, max = 0; i < len; NMV_OADV(m), i++ )
         max = MAX(max,TD(DL(m)));          max = MAX(max,(int)TD(DL(m)));
     mr0 = nmv_adv>oadv?(NMV)REALLOC(BDY(p),len*nmv_adv):BDY(p);      mr0 = nmv_adv>oadv?(NMV)REALLOC(BDY(p),len*nmv_adv):BDY(p);
     m = (NMV)((char *)mr0+(len-1)*oadv);      m = (NMV)((char *)mr0+(len-1)*oadv);
     mr = (NMV)((char *)mr0+(len-1)*nmv_adv);      mr = (NMV)((char *)mr0+(len-1)*nmv_adv);
Line 6021  void ndv_dehomogenize(NDV p,struct order_spec *ord)
Line 5959  void ndv_dehomogenize(NDV p,struct order_spec *ord)
 {  {
     int i,j,adj,len,newnvar,newwpd,newadv,newexporigin,newmpos;      int i,j,adj,len,newnvar,newwpd,newadv,newexporigin,newmpos;
     int pos;      int pos;
     Q *w;  
     Q dvr,t;  
     NMV m,r;      NMV m,r;
   
     len = p->len;      len = p->len;
Line 6082  void nd_heu_nezgcdnpz(VL vl,P *pl,int m,int full,P *pr
Line 6018  void nd_heu_nezgcdnpz(VL vl,P *pl,int m,int full,P *pr
   
 void removecont_array(P *p,int n,int full)  void removecont_array(P *p,int n,int full)
 {  {
     int all_p,all_q,i;      int all_q,i;
     Z *c;      Z *c;
     P *w;      P *w;
     P t,s;      P t,s;
Line 6111  void removecont_array_q(Z *c,int n)
Line 6047  void removecont_array_q(Z *c,int n)
 {  {
   struct oVECT v;    struct oVECT v;
   Z d0,d1,a,u,u1,gcd;    Z d0,d1,a,u,u1,gcd;
   int i,j;    int i;
   Z *q,*r;    Z *q,*r;
   
   q = (Z *)MALLOC(n*sizeof(Z));    q = (Z *)MALLOC(n*sizeof(Z));
Line 6255  void ndv_free(NDV p)
Line 6191  void ndv_free(NDV p)
   
 void nd_append_red(UINT *d,int i)  void nd_append_red(UINT *d,int i)
 {  {
     RHist m,m0;      RHist m;
     int h;      int h;
   
     NEWRHist(m);      NEWRHist(m);
Line 6299  UINT *nd_compute_bound(ND p)
Line 6235  UINT *nd_compute_bound(ND p)
 {  {
     UINT *d1,*d2,*t;      UINT *d1,*d2,*t;
     UINT u;      UINT u;
     int i,j,k,l,len,ind;      int i,j,k,l,ind;
     NM m;      NM m;
   
     if ( !p )      if ( !p )
         return 0;          return 0;
     d1 = (UINT *)MALLOC(nd_wpd*sizeof(UINT));      d1 = (UINT *)MALLOC(nd_wpd*sizeof(UINT));
     d2 = (UINT *)MALLOC(nd_wpd*sizeof(UINT));      d2 = (UINT *)MALLOC(nd_wpd*sizeof(UINT));
     len = LEN(p);  
     m = BDY(p); ndl_copy(DL(m),d1); m = NEXT(m);      m = BDY(p); ndl_copy(DL(m),d1); m = NEXT(m);
     for ( m = NEXT(m); m; m = NEXT(m) ) {      for ( m = NEXT(m); m; m = NEXT(m) ) {
         ndl_lcm(DL(m),d1,d2);          ndl_lcm(DL(m),d1,d2);
Line 6350  int nd_get_exporigin(struct order_spec *ord)
Line 6285  int nd_get_exporigin(struct order_spec *ord)
 }  }
   
 void nd_setup_parameters(int nvar,int max) {  void nd_setup_parameters(int nvar,int max) {
     int i,j,n,elen,ord_o,ord_l,l,s,wpd;      int i,j,elen,wpd;
     struct order_pair *op;  
     extern int CNVars;      extern int CNVars;
   
     nd_nvar = nvar;      nd_nvar = nvar;
Line 6372  void nd_setup_parameters(int nvar,int max) {
Line 6306  void nd_setup_parameters(int nvar,int max) {
     }      }
     if ( !do_weyl && weight_check && (current_dl_weight_vector || nd_matrix) ) {      if ( !do_weyl && weight_check && (current_dl_weight_vector || nd_matrix) ) {
         UINT t;          UINT t;
     int st;          int st;
         int *v;          int *v;
   /* t = max(weights) */    /* t = max(weights) */
         t = 0;          t = 0;
         if ( current_dl_weight_vector )          if ( current_dl_weight_vector )
             for ( i = 0, t = 0; i < nd_nvar; i++ ) {              for ( i = 0, t = 0; i < nd_nvar; i++ ) {
                 if ( (st=current_dl_weight_vector[i]) < 0 ) st = -st;                  if ( (st=current_dl_weight_vector[i]) < 0 ) st = -st;
                 if ( t < st ) t = st;                  if ( t < (UINT)st ) t = st;
             }              }
         if ( nd_matrix )          if ( nd_matrix )
             for ( i = 0; i < nd_matrix_len; i++ )              for ( i = 0; i < nd_matrix_len; i++ )
                 for ( j = 0, v = nd_matrix[i]; j < nd_nvar; j++ ) {                  for ( j = 0, v = nd_matrix[i]; j < nd_nvar; j++ ) {
                     if ( (st=v[j]) < 0 ) st = -st;                      if ( (st=v[j]) < 0 ) st = -st;
                     if ( t < st ) t = st;                      if ( t < (UINT)st ) t = st;
         }          }
         /* i = bitsize of t */          /* i = bitsize of t */
         for ( i = 0; t; t >>=1, i++ );          for ( i = 0; t; t >>=1, i++ );
Line 6429  ND_pairs nd_reconstruct(int trace,ND_pairs d)
Line 6363  ND_pairs nd_reconstruct(int trace,ND_pairs d)
     int i,obpe,oadv,h;      int i,obpe,oadv,h;
     static NM prev_nm_free_list;      static NM prev_nm_free_list;
     static ND_pairs prev_ndp_free_list;      static ND_pairs prev_ndp_free_list;
     RHist mr0,mr;      RHist mr;
     RHist r;      RHist r;
     RHist *old_red;      RHist *old_red;
     ND_pairs s0,s,t;      ND_pairs s0,s,t;
Line 6511  void nd_reconstruct_s(int trace,ND_pairs *d)
Line 6445  void nd_reconstruct_s(int trace,ND_pairs *d)
     int i,obpe,oadv,h;      int i,obpe,oadv,h;
     static NM prev_nm_free_list;      static NM prev_nm_free_list;
     static ND_pairs prev_ndp_free_list;      static ND_pairs prev_ndp_free_list;
     RHist mr0,mr;      RHist mr;
     RHist r;      RHist r;
     RHist *old_red;      RHist *old_red;
     ND_pairs s0,s,t;      ND_pairs s0,s,t;
Line 6594  void nd_reconstruct_s(int trace,ND_pairs *d)
Line 6528  void nd_reconstruct_s(int trace,ND_pairs *d)
   
 void ndl_reconstruct(UINT *d,UINT *r,int obpe,EPOS oepos)  void ndl_reconstruct(UINT *d,UINT *r,int obpe,EPOS oepos)
 {  {
     int n,i,ei,oepw,omask0,j,s,ord_l,l;      int n,i,ei,omask0,j,s,ord_l,l;
     struct order_pair *op;      struct order_pair *op;
   
     n = nd_nvar;      n = nd_nvar;
     oepw = (sizeof(UINT)*8)/obpe;  //    oepw = (sizeof(UINT)*8)/obpe;
     omask0 = (1<<obpe)-1;      omask0 = (1<<obpe)-1;
     TD(r) = TD(d);      TD(r) = TD(d);
     for ( i = nd_exporigin; i < nd_wpd; i++ ) r[i] = 0;      for ( i = nd_exporigin; i < nd_wpd; i++ ) r[i] = 0;
Line 6626  void ndl_reconstruct(UINT *d,UINT *r,int obpe,EPOS oep
Line 6560  void ndl_reconstruct(UINT *d,UINT *r,int obpe,EPOS oep
 ND nd_copy(ND p)  ND nd_copy(ND p)
 {  {
     NM m,mr,mr0;      NM m,mr,mr0;
     int c,n;  
     ND r;      ND r;
   
     if ( !p )      if ( !p )
Line 6653  int nd_sp(int mod,int trace,ND_pairs p,ND *rp)
Line 6586  int nd_sp(int mod,int trace,ND_pairs p,ND *rp)
     P gp,tp;      P gp,tp;
     Z g,t;      Z g,t;
     Z iq;      Z iq;
     int td;  
     LIST hist;      LIST hist;
     NODE node;      NODE node;
     DP d;      DP d;
Line 6906  ND ndv_mul_nm_symbolic(NM m0,NDV p)
Line 6838  ND ndv_mul_nm_symbolic(NM m0,NDV p)
 {  {
     NM mr,mr0;      NM mr,mr0;
     NMV m;      NMV m;
     UINT *d,*dt,*dm;      UINT *d;
     int c,n,td,i,c1,c2,len;      int i,len;
     Q q;  
     ND r;      ND r;
   
     if ( !p ) return 0;      if ( !p ) return 0;
     else {      else {
         n = NV(p); m = BDY(p);          m = BDY(p);
         d = DL(m0);          d = DL(m0);
         len = LEN(p);          len = LEN(p);
         mr0 = 0;          mr0 = 0;
         td = TD(d);  
         c = CM(m0);  
         for ( i = 0; i < len; i++, NMV_ADV(m) ) {          for ( i = 0; i < len; i++, NMV_ADV(m) ) {
             NEXTNM(mr0,mr);              NEXTNM(mr0,mr);
             CM(mr) = 1;              CM(mr) = 1;
Line 6935  ND ndv_mul_nm(int mod,NM m0,NDV p)
Line 6864  ND ndv_mul_nm(int mod,NM m0,NDV p)
 {  {
     NM mr,mr0;      NM mr,mr0;
     NMV m;      NMV m;
     UINT *d,*dt,*dm;      UINT *d;
     int c,n,td,i,c1,c2,len;      int c,i,c1,c2,len;
     P q;      P q;
     ND r;      ND r;
   
Line 6948  ND ndv_mul_nm(int mod,NM m0,NDV p)
Line 6877  ND ndv_mul_nm(int mod,NM m0,NDV p)
         } else          } else
             return weyl_ndv_mul_nm(mod,m0,p);              return weyl_ndv_mul_nm(mod,m0,p);
     } else {      } else {
         n = NV(p); m = BDY(p);          m = BDY(p);
         d = DL(m0);          d = DL(m0);
         len = LEN(p);          len = LEN(p);
         mr0 = 0;          mr0 = 0;
         td = TD(d);  
         if ( mod == -1 ) {          if ( mod == -1 ) {
             c = CM(m0);              c = CM(m0);
             for ( i = 0; i < len; i++, NMV_ADV(m) ) {              for ( i = 0; i < len; i++, NMV_ADV(m) ) {
Line 6996  ND nd_quo(int mod,PGeoBucket bucket,NDV d)
Line 6924  ND nd_quo(int mod,PGeoBucket bucket,NDV d)
 {  {
     NM mq0,mq;      NM mq0,mq;
     NMV tm;      NMV tm;
     Q q;      int i,nv,c,c1,c2,hindex;
     int i,nv,sg,c,c1,c2,hindex;  
     ND p,t,r;      ND p,t,r;
   
     if ( bucket->m < 0 ) return 0;      if ( bucket->m < 0 ) return 0;
Line 7144  ND nd_dup(ND p)
Line 7071  ND nd_dup(ND p)
 void ndv_mod(int mod,NDV p)  void ndv_mod(int mod,NDV p)
 {  {
     NMV t,d;      NMV t,d;
     int r,s,u;      int r;
     int i,len,dlen;      int i,len,dlen;
     P cp;      P cp;
     Z c;      Z c;
Line 7256  NDV pltondv(VL vl,VL dvl,LIST p)
Line 7183  NDV pltondv(VL vl,VL dvl,LIST p)
   
 ND ptond(VL vl,VL dvl,P p)  ND ptond(VL vl,VL dvl,P p)
 {  {
     int n,i,j,k,e;      int j,k,e,i;
     VL tvl;      VL tvl;
     V v;      V v;
     DCP dc;      DCP dc;
     DCP *w;      DCP *w;
     ND r,s,t,u;      ND r,t,s;
     P x;      P x;
     int c;  
     UINT *d;      UINT *d;
     NM m,m0;      NM m,m0;
   
Line 7295  ND ptond(VL vl,VL dvl,P p)
Line 7221  ND ptond(VL vl,VL dvl,P p)
         } else {          } else {
             NEWNM(m0); d = DL(m0);              NEWNM(m0); d = DL(m0);
             for ( j = k-1, s = 0; j >= 0; j-- ) {              for ( j = k-1, s = 0; j >= 0; j-- ) {
                 ndl_zero(d); e = ZTOS(DEG(w[j])); PUT_EXP(d,i,e);                  ndl_zero(d); e = (int)ZTOS(DEG(w[j])); PUT_EXP(d,i,e);
                 TD(d) = MUL_WEIGHT(e,i);                  TD(d) = MUL_WEIGHT(e,i);
                 if ( nd_blockmask) ndl_weight_mask(d);                  if ( nd_blockmask) ndl_weight_mask(d);
                 if ( nd_module ) MPOS(d) = 0;                  if ( nd_module ) MPOS(d) = 0;
Line 7355  LIST ndvtopl(int mod,VL vl,VL dvl,NDV p,int rank)
Line 7281  LIST ndvtopl(int mod,VL vl,VL dvl,NDV p,int rank)
     Z q;      Z q;
     P c;      P c;
     UINT *d;      UINT *d;
     P s,r,u,t,w;      P r,u,t,w;
     GFS gfs;      GFS gfs;
     P *a;      P *a;
     LIST l;      LIST l;
Line 7491  NDV dptondv(int mod,DP p)
Line 7417  NDV dptondv(int mod,DP p)
   NDV d;    NDV d;
   NMV m,m0;    NMV m,m0;
   MP t;    MP t;
   MP *a;  
   int i,len,n;    int i,len,n;
   
   if ( !p ) return 0;    if ( !p ) return 0;
Line 7628  DPM ndvtodpm(int mod,NDV p)
Line 7553  DPM ndvtodpm(int mod,NDV p)
   
 DP ndtodp(int mod,ND p)  DP ndtodp(int mod,ND p)
 {  {
     MP m,m0;    MP m,m0;
   DP d;    DP d;
     NM t;    NM t;
     int i,len;  
   
     if ( !p ) return 0;    if ( !p ) return 0;
     m0 = 0;    m0 = 0;
     len = p->len;    for ( t = BDY(p); t; t = NEXT(t) ) {
     for ( t = BDY(p); t; t = NEXT(t) ) {      NEXTMP(m0,m);
         NEXTMP(m0,m);      m->dl = ndltodl(nd_nvar,DL(t));
       m->dl = ndltodl(nd_nvar,DL(t));      m->c = (Obj)ndctop(mod,t->c);
       m->c = (Obj)ndctop(mod,t->c);    }
     }    NEXT(m) = 0;
     NEXT(m) = 0;  
   MKDP(nd_nvar,m0,d);    MKDP(nd_nvar,m0,d);
     SG(d) = SG(p);    SG(d) = SG(p);
     return d;    return d;
 }  }
   
 void ndv_print(NDV p)  void ndv_print(NDV p)
Line 7944  void nd_nf_p(Obj f,LIST g,LIST v,int m,struct order_sp
Line 7867  void nd_nf_p(Obj f,LIST g,LIST v,int m,struct order_sp
     NDV ndvf;      NDV ndvf;
     VL vv,tv;      VL vv,tv;
     int stat,nvar,max,mrank;      int stat,nvar,max,mrank;
     union oNDC dn;  
     Q cont;      Q cont;
     P pp;      P pp;
     LIST ppl;      LIST ppl;
Line 8113  IndArray nm_ind_pair_to_vect_compress(int trace,UINT *
Line 8035  IndArray nm_ind_pair_to_vect_compress(int trace,UINT *
 {  {
     NM m;      NM m;
     NMV mr;      NMV mr;
     UINT *d,*t,*s,*u;      UINT *d,*t,*u;
     NDV p;      NDV p;
     unsigned char *ivc;      unsigned char *ivc;
     unsigned short *ivs;      unsigned short *ivs;
     UINT *v,*ivi,*s0v;      UINT *v,*ivi;
     int i,j,len,prev,diff,cdiff,h,st,ed,md,c;      int i,j,len,prev,diff,cdiff,st,ed,md,c;
     IndArray r;      IndArray r;
   
     m = pair->mul;      m = pair->mul;
Line 8279  int ndv_reduce_vect_q(Z *svect0,int trace,int col,IndA
Line 8201  int ndv_reduce_vect_q(Z *svect0,int trace,int col,IndA
     unsigned int *ivi;      unsigned int *ivi;
     NDV redv;      NDV redv;
     NMV mr;      NMV mr;
     NODE rp;  
     int maxrs;      int maxrs;
     double hmag;      double hmag;
     int l;  
     static mpz_t *svect;      static mpz_t *svect;
     static int svect_len=0;      static int svect_len=0;
   
Line 8374  int ndv_reduce_vect(int m,UINT *svect,int col,IndArray
Line 8294  int ndv_reduce_vect(int m,UINT *svect,int col,IndArray
     unsigned int *ivi;      unsigned int *ivi;
     NDV redv;      NDV redv;
     NMV mr;      NMV mr;
     NODE rp;  
     int maxrs;      int maxrs;
   
     maxrs = 0;      maxrs = 0;
Line 8436  int ndv_reduce_vect(int m,UINT *svect,int col,IndArray
Line 8355  int ndv_reduce_vect(int m,UINT *svect,int col,IndArray
 int ndv_reduce_vect_sf(int m,UINT *svect,int col,IndArray *imat,NM_ind_pair *rp0,int nred)  int ndv_reduce_vect_sf(int m,UINT *svect,int col,IndArray *imat,NM_ind_pair *rp0,int nred)
 {  {
     int i,j,k,len,pos,prev;      int i,j,k,len,pos,prev;
     UINT c,c1,c2,c3,up,lo,dmy;      UINT c;
     IndArray ivect;      IndArray ivect;
     unsigned char *ivc;      unsigned char *ivc;
     unsigned short *ivs;      unsigned short *ivs;
     unsigned int *ivi;      unsigned int *ivi;
     NDV redv;      NDV redv;
     NMV mr;      NMV mr;
     NODE rp;  
     int maxrs;      int maxrs;
   
     maxrs = 0;      maxrs = 0;
Line 8485  int ndv_reduce_vect_sf(int m,UINT *svect,int col,IndAr
Line 8403  int ndv_reduce_vect_sf(int m,UINT *svect,int col,IndAr
   
 ND nd_add_lf(ND p1,ND p2)  ND nd_add_lf(ND p1,ND p2)
 {  {
     int n,c,can;      int c,can;
     ND r;  
     NM m1,m2,mr0,mr,s;      NM m1,m2,mr0,mr,s;
     Z t;      Z t;
   
Line 8494  ND nd_add_lf(ND p1,ND p2)
Line 8411  ND nd_add_lf(ND p1,ND p2)
     else if ( !p2 ) return p1;      else if ( !p2 ) return p1;
     else {      else {
         can = 0;          can = 0;
         for ( n = NV(p1), m1 = BDY(p1), m2 = BDY(p2), mr0 = 0; m1 && m2; ) {          for (  m1 = BDY(p1), m2 = BDY(p2), mr0 = 0; m1 && m2; ) {
             c = DL_COMPARE(DL(m1),DL(m2));              c = DL_COMPARE(DL(m1),DL(m2));
             switch ( c ) {              switch ( c ) {
                 case 0:                  case 0:
Line 8533  ND nd_add_lf(ND p1,ND p2)
Line 8450  ND nd_add_lf(ND p1,ND p2)
 int ndv_reduce_vect_lf(mpz_t *svect,int trace,int col,IndArray *imat,NM_ind_pair *rp0,int nred)  int ndv_reduce_vect_lf(mpz_t *svect,int trace,int col,IndArray *imat,NM_ind_pair *rp0,int nred)
 {  {
     int i,j,k,len,pos,prev;      int i,j,k,len,pos,prev;
     mpz_t c,mc,c1;  
     IndArray ivect;      IndArray ivect;
     unsigned char *ivc;      unsigned char *ivc;
     unsigned short *ivs;      unsigned short *ivs;
     unsigned int *ivi;      unsigned int *ivi;
     NDV redv;      NDV redv;
     NMV mr;      NMV mr;
     NODE rp;  
     int maxrs;      int maxrs;
   
     maxrs = 0;      maxrs = 0;
Line 8591  int ndv_reduce_vect_lf(mpz_t *svect,int trace,int col,
Line 8506  int ndv_reduce_vect_lf(mpz_t *svect,int trace,int col,
 int nd_gauss_elim_lf(mpz_t **mat0,int *sugar,int row,int col,int *colstat)  int nd_gauss_elim_lf(mpz_t **mat0,int *sugar,int row,int col,int *colstat)
 {  {
     int i,j,k,l,rank,s;      int i,j,k,l,rank,s;
     mpz_t a,a1,inv;      mpz_t a,inv;
     mpz_t *t,*pivot,*pk;      mpz_t *t,*pivot,*pk;
     mpz_t **mat;      mpz_t **mat;
     struct oEGT eg0,eg1,eg_forward,eg_mod,eg_back;  
     int size,size1;  
   
     mpz_init(inv);      mpz_init(inv);
     mpz_init(a);      mpz_init(a);
     mat = (mpz_t **)mat0;      mat = (mpz_t **)mat0;
         size = 0;  
     for ( rank = 0, j = 0; j < col; j++ ) {      for ( rank = 0, j = 0; j < col; j++ ) {
         for ( i = rank; i < row; i++ ) {          for ( i = rank; i < row; i++ ) {
             mpz_mod(mat[i][j],mat[i][j],BDY(current_mod_lf));              mpz_mod(mat[i][j],mat[i][j],BDY(current_mod_lf));
Line 8715  NDV vect_to_ndv_s(UINT *vect,int col,UINT *s0vect)
Line 8627  NDV vect_to_ndv_s(UINT *vect,int col,UINT *s0vect)
   
 NDV vect_to_ndv_2(unsigned long *vect,int col,UINT *s0vect)  NDV vect_to_ndv_2(unsigned long *vect,int col,UINT *s0vect)
 {  {
     int j,k,len;      int j,len;
     UINT *p;      UINT *p;
     NDV r;      NDV r;
     NMV mr0,mr;      NMV mr0,mr;
Line 8759  NDV vect_to_ndv_q(Z *vect,int spcol,int col,int *rhead
Line 8671  NDV vect_to_ndv_q(Z *vect,int spcol,int col,int *rhead
         if ( (c = vect[k++]) != 0 ) {          if ( (c = vect[k++]) != 0 ) {
           if ( !INT(c) )            if ( !INT(c) )
             error("vect_to_ndv_q : components must be integers");              error("vect_to_ndv_q : components must be integers");
             ndl_copy(p,DL(mr)); CZ(mr) = c; NMV_ADV(mr);            ndl_copy(p,DL(mr)); CZ(mr) = c; NMV_ADV(mr);
         }          }
       }        }
     }      }
Line 8830  NDV plain_vect_to_ndv_q(Z *vect,int col,UINT *s0vect)
Line 8742  NDV plain_vect_to_ndv_q(Z *vect,int col,UINT *s0vect)
 int nd_sp_f4(int m,int trace,ND_pairs l,PGeoBucket bucket)  int nd_sp_f4(int m,int trace,ND_pairs l,PGeoBucket bucket)
 {  {
     ND_pairs t;      ND_pairs t;
     NODE sp0,sp;  
     int stat;      int stat;
     ND spol;      ND spol;
   
Line 8902  void print_ndp(ND_pairs l)
Line 8813  void print_ndp(ND_pairs l)
   
 NODE nd_f4(int m,int checkonly,int **indp)  NODE nd_f4(int m,int checkonly,int **indp)
 {  {
     int i,nh,stat,index,f4red;    int i,nh,stat,f4red;
     NODE r,g,tn0,tn,node;    NODE r,g,tn0,tn,node;
     ND_pairs d,l,t,ll0,ll,lh;    ND_pairs d,l,t,ll,lh;
   LIST l0,l1;    LIST l0,l1;
     ND spol,red;    NDV nf;
     NDV nf,redv;    NODE rp0,nflist,nzlist,nzlist_t;
     NM s0,s;    int col;
     NODE rp0,srp0,nflist,nzlist,nzlist_t;    UINT *s0vect;
     int nsp,nred,col,rank,len,k,j,a,i1s,i2s;    int sugar;
     UINT c;    PGeoBucket bucket;
     UINT **spmat;    struct oEGT eg0,eg1,eg_f4;
     UINT *s0vect,*svect,*p,*v;    Z i1,i2,sugarq;
     int *colstat;  
     IndArray *imat;  
     int *rhead;  
     int spcol,sprow;  
     int sugar,sugarh;  
     PGeoBucket bucket;  
     struct oEGT eg0,eg1,eg_f4;  
     Z i1,i2,sugarq;  
   
     init_eg(&f4_symb); init_eg(&f4_conv); init_eg(&f4_conv); init_eg(&f4_elim1); init_eg(&f4_elim2);    init_eg(&f4_symb); init_eg(&f4_conv); init_eg(&f4_conv); init_eg(&f4_elim1); init_eg(&f4_elim2);
 #if 0  #if 0
     ndv_alloc = 0;    ndv_alloc = 0;
 #endif  #endif
     Nf4_red=0;    Nf4_red=0;
     g = 0; d = 0;    g = 0; d = 0;
     for ( i = 0; i < nd_psn; i++ ) {    for ( i = 0; i < nd_psn; i++ ) {
         d = update_pairs(d,g,i,0);      d = update_pairs(d,g,i,0);
         g = update_base(g,i);      g = update_base(g,i);
     }    }
   nzlist = 0;    nzlist = 0;
     nzlist_t = nd_nzlist;    nzlist_t = nd_nzlist;
     f4red = 1;    f4red = 1;
     nd_last_nonzero = 0;    nd_last_nonzero = 0;
     while ( d ) {    while ( d ) {
         get_eg(&eg0);      get_eg(&eg0);
         l = nd_minsugarp(d,&d);      l = nd_minsugarp(d,&d);
         sugar = nd_sugarweight?l->sugar2:SG(l);      sugar = nd_sugarweight?l->sugar2:SG(l);
         if ( MaxDeg > 0 && sugar > MaxDeg ) break;      if ( MaxDeg > 0 && sugar > MaxDeg ) break;
         if ( nzlist_t ) {      if ( nzlist_t ) {
             node = BDY((LIST)BDY(nzlist_t));        node = BDY((LIST)BDY(nzlist_t));
             sugarh = ZTOS((Q)ARG0(node));  //      sugarh = (int)ZTOS((Q)ARG0(node));
             tn = BDY((LIST)ARG1(node));        tn = BDY((LIST)ARG1(node));
             if ( !tn ) {        if ( !tn ) {
               nzlist_t = NEXT(nzlist_t);          nzlist_t = NEXT(nzlist_t);
               continue;          continue;
             }        }
             /* tn = [[i1,i2],...] */        /* tn = [[i1,i2],...] */
             lh = nd_ipairtospair(tn);            lh = nd_ipairtospair(tn);
         }      }
         bucket = create_pbucket();      bucket = create_pbucket();
         stat = nd_sp_f4(m,0,l,bucket);      stat = nd_sp_f4(m,0,l,bucket);
         if ( !stat ) {      if ( !stat ) {
             for ( t = l; NEXT(t); t = NEXT(t) );        for ( t = l; NEXT(t); t = NEXT(t) );
             NEXT(t) = d; d = l;        NEXT(t) = d; d = l;
             d = nd_reconstruct(0,d);        d = nd_reconstruct(0,d);
             continue;        continue;
         }      }
         if ( bucket->m < 0 ) continue;      if ( bucket->m < 0 ) continue;
         col = nd_symbolic_preproc(bucket,0,&s0vect,&rp0);      col = nd_symbolic_preproc(bucket,0,&s0vect,&rp0);
         if ( !col ) {      if ( !col ) {
             for ( t = l; NEXT(t); t = NEXT(t) );        for ( t = l; NEXT(t); t = NEXT(t) );
             NEXT(t) = d; d = l;        NEXT(t) = d; d = l;
             d = nd_reconstruct(0,d);        d = nd_reconstruct(0,d);
             continue;        continue;
         }      }
         get_eg(&eg1); init_eg(&eg_f4); add_eg(&eg_f4,&eg0,&eg1); add_eg(&f4_symb,&eg0,&eg1);      get_eg(&eg1); init_eg(&eg_f4); add_eg(&eg_f4,&eg0,&eg1); add_eg(&f4_symb,&eg0,&eg1);
         if ( DP_Print )      if ( DP_Print )
             fprintf(asir_out,"sugar=%d,symb=%.3fsec,",        fprintf(asir_out,"sugar=%d,symb=%.3fsec,",sugar,eg_f4.exectime);
                 sugar,eg_f4.exectime);      nflist = nd_f4_red(m,nd_nzlist?lh:l,0,s0vect,col,rp0,nd_gentrace?&ll:0);
         nflist = nd_f4_red(m,nd_nzlist?lh:l,0,s0vect,col,rp0,nd_gentrace?&ll:0);      if ( checkonly && nflist ) return 0;
         if ( checkonly && nflist ) return 0;      /* adding new bases */
         /* adding new bases */      if ( nflist ) nd_last_nonzero = f4red;
         if ( nflist ) nd_last_nonzero = f4red;      for ( r = nflist; r; r = NEXT(r) ) {
         for ( r = nflist; r; r = NEXT(r) ) {        nf = (NDV)BDY(r);
             nf = (NDV)BDY(r);        if ( nd_f4_td ) SG(nf) = nd_tdeg(nf);
             if ( nd_f4_td ) SG(nf) = nd_tdeg(nf);        ndv_removecont(m,nf);
             ndv_removecont(m,nf);        if ( !m && nd_nalg ) {
             if ( !m && nd_nalg ) {          ND nf1;
                 ND nf1;  
   
                 nf1 = ndvtond(m,nf);          nf1 = ndvtond(m,nf);
                 nd_monic(0,&nf1);          nd_monic(0,&nf1);
                 nd_removecont(m,nf1);          nd_removecont(m,nf1);
                 nf = ndtondv(m,nf1);          nf = ndtondv(m,nf1);
             }        }
             nh = ndv_newps(m,nf,0);        nh = ndv_newps(m,nf,0);
             d = update_pairs(d,g,nh,0);        d = update_pairs(d,g,nh,0);
             g = update_base(g,nh);        g = update_base(g,nh);
         }      }
         if ( DP_Print ) {      if ( DP_Print ) {
           fprintf(asir_out,"f4red=%d,gblen=%d\n",f4red,length(g)); fflush(asir_out);        fprintf(asir_out,"f4red=%d,gblen=%d\n",f4red,length(g)); fflush(asir_out);
         }      }
         if ( nd_gentrace ) {      if ( nd_gentrace ) {
       for ( t = ll, tn0 = 0; t; t = NEXT(t) ) {        for ( t = ll, tn0 = 0; t; t = NEXT(t) ) {
         NEXTNODE(tn0,tn);          NEXTNODE(tn0,tn);
                 STOZ(t->i1,i1); STOZ(t->i2,i2);          STOZ(t->i1,i1); STOZ(t->i2,i2);
                 node = mknode(2,i1,i2); MKLIST(l0,node);          node = mknode(2,i1,i2); MKLIST(l0,node);
         BDY(tn) = l0;          BDY(tn) = l0;
       }        }
       if ( tn0 ) NEXT(tn) = 0; MKLIST(l0,tn0);        if ( tn0 ) NEXT(tn) = 0; MKLIST(l0,tn0);
             STOZ(sugar,sugarq); node = mknode(2,sugarq,l0); MKLIST(l1,node);          STOZ(sugar,sugarq); node = mknode(2,sugarq,l0); MKLIST(l1,node);
             MKNODE(node,l1,nzlist); nzlist = node;          MKNODE(node,l1,nzlist); nzlist = node;
         }  
         if ( nd_nzlist ) nzlist_t = NEXT(nzlist_t);  
         f4red++;  
         if ( nd_f4red && f4red > nd_f4red ) break;  
         if ( nd_rank0 && !nflist ) break;  
     }      }
     if ( nd_gentrace ) {      if ( nd_nzlist ) nzlist_t = NEXT(nzlist_t);
     MKLIST(l0,reverse_node(nzlist));      f4red++;
         MKNODE(nd_alltracelist,l0,0);      if ( nd_f4red && f4red > nd_f4red ) break;
     }      if ( nd_rank0 && !nflist ) break;
     }
     if ( nd_gentrace ) {
     MKLIST(l0,reverse_node(nzlist));
         MKNODE(nd_alltracelist,l0,0);
     }
 #if 0  #if 0
     fprintf(asir_out,"ndv_alloc=%d\n",ndv_alloc);    fprintf(asir_out,"ndv_alloc=%d\n",ndv_alloc);
 #endif  #endif
   if ( DP_Print ) {    if ( DP_Print ) {
     fprintf(asir_out,"number of red=%d,",Nf4_red);    fprintf(asir_out,"number of red=%d,",Nf4_red);
     fprintf(asir_out,"symb=%.3fsec,conv=%.3fsec,elim1=%.3fsec,elim2=%.3fsec\n",    fprintf(asir_out,"symb=%.3fsec,conv=%.3fsec,elim1=%.3fsec,elim2=%.3fsec\n",
       f4_symb.exectime,f4_conv.exectime,f4_elim1.exectime,f4_elim2.exectime);      f4_symb.exectime,f4_conv.exectime,f4_elim1.exectime,f4_elim2.exectime);
     fprintf(asir_out,"number of removed pairs=%d\n,",NcriB+NcriMF+Ncri2);    fprintf(asir_out,"number of removed pairs=%d\n,",NcriB+NcriMF+Ncri2);
   }    }
   conv_ilist(nd_demand,0,g,indp);    conv_ilist(nd_demand,0,g,indp);
     return g;    return g;
 }  }
   
 NODE nd_f4_trace(int m,int **indp)  NODE nd_f4_trace(int m,int **indp)
 {  {
     int i,nh,stat,index;      int i,nh,stat;
     NODE r,g;      NODE r,g;
     ND_pairs d,l,l0,t;      ND_pairs d,l,l0,t;
     ND spol,red;      NDV nfqv,nfv;
     NDV nf,redv,nfqv,nfv;      NODE rp0,nflist;
     NM s0,s;      int col;
     NODE rp0,srp0,nflist;      UINT *s0vect;
     int nsp,nred,col,rank,len,k,j,a;  
     UINT c;  
     UINT **spmat;  
     UINT *s0vect,*svect,*p,*v;  
     int *colstat;  
     IndArray *imat;  
     int *rhead;  
     int spcol,sprow;  
     int sugar;      int sugar;
     PGeoBucket bucket;      PGeoBucket bucket;
     struct oEGT eg0,eg1,eg_f4;      struct oEGT eg0,eg1,eg_f4;
Line 9232  void red_by_vect_2(matrix mat,int *sugar,unsigned long
Line 9126  void red_by_vect_2(matrix mat,int *sugar,unsigned long
   
 NODE nd_f4_red_2(ND_pairs sp0,UINT *s0vect,int col,NODE rp0,ND_pairs *nz)  NODE nd_f4_red_2(ND_pairs sp0,UINT *s0vect,int col,NODE rp0,ND_pairs *nz)
 {  {
     int nsp,nred,i,i0,k,rank,row;    int nsp,i,rank;
     NODE r0,rp;    NODE r0,rp;
     ND_pairs sp;    ND_pairs sp;
   ND spol;    ND spol;
   NM_ind_pair rt;    NM_ind_pair rt;
     int *s0hash;    int *s0hash;
   UINT *s;    UINT *s;
   int *pivot,*sugar,*head;    int *sugar;
   matrix mat;    matrix mat;
     NM m;    NODE r;
     NODE r;  
   struct oEGT eg0,eg1,eg2,eg_elim1,eg_elim2;    struct oEGT eg0,eg1,eg2,eg_elim1,eg_elim2;
   int rhead,rsugar,size;    int rhead,rsugar,size;
     unsigned long *v;    unsigned long *v;
   
     get_eg(&eg0);    get_eg(&eg0);
     for ( sp = sp0, nsp = 0; sp; sp = NEXT(sp), nsp++ );    for ( sp = sp0, nsp = 0; sp; sp = NEXT(sp), nsp++ );
     nred = length(rp0);  //  nred = length(rp0);
     mat = alloc_matrix(nsp,col);    mat = alloc_matrix(nsp,col);
     s0hash = (int *)MALLOC(col*sizeof(int));    s0hash = (int *)MALLOC(col*sizeof(int));
     for ( i = 0, s = s0vect; i < col; i++, s += nd_wpd )    for ( i = 0, s = s0vect; i < col; i++, s += nd_wpd )
         s0hash[i] = ndl_hash_value(s);      s0hash[i] = ndl_hash_value(s);
   
   sugar = (int *)MALLOC(nsp*sizeof(int));    sugar = (int *)MALLOC(nsp*sizeof(int));
   for ( i = 0, sp = sp0; sp; sp = NEXT(sp) ) {    for ( i = 0, sp = sp0; sp; sp = NEXT(sp) ) {
Line 9307  NODE nd_f4_red(int m,ND_pairs sp0,int trace,UINT *s0ve
Line 9200  NODE nd_f4_red(int m,ND_pairs sp0,int trace,UINT *s0ve
     NODE r0,rp;      NODE r0,rp;
     ND_pairs sp;      ND_pairs sp;
     NM_ind_pair *rvect;      NM_ind_pair *rvect;
     UINT *s;  
     int *s0hash;  
     struct oEGT eg0,eg1,eg_conv;      struct oEGT eg0,eg1,eg_conv;
   
     if ( m == 2 && nd_rref2 )      if ( m == 2 && nd_rref2 )
Line 9359  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
Line 9250  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
         NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred,ND_pairs *nz)          NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred,ND_pairs *nz)
 {  {
     int spcol,sprow,a;      int spcol,sprow,a;
     int i,j,k,l,rank;      int i,j,k,rank;
     NODE r0,r;      NODE r0,r;
     ND_pairs sp;      ND_pairs sp;
     ND spol;      ND spol;
Line 9444  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
Line 9335  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
 NODE nd_f4_red_main_s(int m,ND_pairs sp0,int nsp,UINT *s0vect,int col,  NODE nd_f4_red_main_s(int m,ND_pairs sp0,int nsp,UINT *s0vect,int col,
         NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred,NODE *syzlistp)          NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred,NODE *syzlistp)
 {  {
     int spcol,sprow,a;      int sprow,a;
     int i,j,k,l,rank;      int i,rank;
     NODE r0,r;      NODE r0,r;
     ND_pairs sp;      ND_pairs sp;
     ND spol;      ND spol;
     UINT **spmat;      UINT **spmat;
     UINT *svect,*cvect;      UINT *svect;
     UINT *v;  
     int *colstat;      int *colstat;
     struct oEGT eg0,eg1,eg2,eg_f4,eg_f4_1,eg_f4_2;      struct oEGT eg0,eg1,eg2,eg_f4,eg_f4_1,eg_f4_2;
     int maxrs;      int maxrs;
     int *spsugar;      int *spsugar;
     ND_pairs *spactive;  
     SIG *spsig;      SIG *spsig;
   
     get_eg(&eg0);      get_eg(&eg0);
Line 9525  NODE nd_f4_red_sf_main(int m,ND_pairs sp0,int nsp,UINT
Line 9414  NODE nd_f4_red_sf_main(int m,ND_pairs sp0,int nsp,UINT
         NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred,ND_pairs *nz)          NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred,ND_pairs *nz)
 {  {
     int spcol,sprow,a;      int spcol,sprow,a;
     int i,j,k,l,rank;      int i,j,k,rank;
     NODE r0,r;      NODE r0,r;
     ND_pairs sp;      ND_pairs sp;
     ND spol;      ND spol;
Line 9605  NODE nd_f4_red_lf_main(int m,ND_pairs sp0,int nsp,int 
Line 9494  NODE nd_f4_red_lf_main(int m,ND_pairs sp0,int nsp,int 
         NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred)          NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred)
 {  {
     int spcol,sprow,a;      int spcol,sprow,a;
     int i,j,k,l,rank;      int i,j,k,rank;
     NODE r0,r;      NODE r0,r;
     ND_pairs sp;      ND_pairs sp;
     ND spol;      ND spol;
Line 9687  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,int trace,U
Line 9576  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,int trace,U
         NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred)          NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred)
 {  {
     int spcol,sprow,a;      int spcol,sprow,a;
     int i,j,k,l,rank;      int i,j,k,rank;
     NODE r0,r;      NODE r0,r;
     ND_pairs sp;      ND_pairs sp;
     ND spol;      ND spol;
Line 9841  NDV nd_recv_ndv()
Line 9730  NDV nd_recv_ndv()
   
 int nd_gauss_elim_q(Z **mat0,int *sugar,int row,int col,int *colstat)  int nd_gauss_elim_q(Z **mat0,int *sugar,int row,int col,int *colstat)
 {  {
     int i,j,t,c,rank,inv;      int i,j,c,rank;
     int *ci,*ri;      int *ci,*ri;
     Z dn;      Z dn;
     MAT m,nm;      MAT m,nm;
Line 9932  int nd_gauss_elim_mod(UINT **mat0,int *sugar,ND_pairs 
Line 9821  int nd_gauss_elim_mod(UINT **mat0,int *sugar,ND_pairs 
   
 int nd_gauss_elim_mod_s(UINT **mat,int *sugar,ND_pairs *spactive,int row,int col,int md,int *colstat,SIG *sig)  int nd_gauss_elim_mod_s(UINT **mat,int *sugar,ND_pairs *spactive,int row,int col,int md,int *colstat,SIG *sig)
 {  {
   int i,j,k,l,rank,s,imin;    int i,j,k,rank,s;
   UINT inv;    UINT inv;
   UINT a;    UINT a;
   UINT *t,*pivot,*pk;    UINT *pk;
   UINT *ck;  
   UINT *ct;  
   ND_pairs pair;  
   SIG sg;  
   int *used;    int *used;
   
   used = (int *)MALLOC(row*sizeof(int));    used = (int *)MALLOC(row*sizeof(int));
Line 9959  int nd_gauss_elim_mod_s(UINT **mat,int *sugar,ND_pairs
Line 9844  int nd_gauss_elim_mod_s(UINT **mat,int *sugar,ND_pairs
     s = sugar[i];      s = sugar[i];
     inv = invm(mat[i][j],md);      inv = invm(mat[i][j],md);
     /* normalize pivot row */      /* normalize pivot row */
     for ( k = j, pk = mat[i]+j; k < col; k++, pk++, ck++ ) {      for ( k = j, pk = mat[i]+j; k < col; k++, pk++ ) {
       DMAR(*pk,inv,0,md,*pk);        DMAR(*pk,inv,0,md,*pk);
     }      }
     for ( k = i+1; k < row; k++ ) {      for ( k = i+1; k < row; k++ ) {
Line 10054  void ndv_save(NDV p,int index)
Line 9939  void ndv_save(NDV p,int index)
     FILE *s;      FILE *s;
     char name[BUFSIZ];      char name[BUFSIZ];
     short id;      short id;
     int nv,sugar,len,n,i,td,e,j;      int nv,sugar,len,i,td,e,j;
     NMV m;      NMV m;
     unsigned int *dl;      unsigned int *dl;
     int mpos;      int mpos;
Line 10120  NDV ndv_load(int index)
Line 10005  NDV ndv_load(int index)
     FILE *s;      FILE *s;
     char name[BUFSIZ];      char name[BUFSIZ];
     short id;      short id;
     int nv,sugar,len,n,i,td,e,j;      int nv,sugar,len,i,td,e,j;
     NDV d;      NDV d;
     NMV m0,m;      NMV m0,m;
     unsigned int *dl;      unsigned int *dl;
Line 10353  ND ndv_mul_nmv_trunc(int mod,NMV m0,NDV p,UINT *d)
Line 10238  ND ndv_mul_nmv_trunc(int mod,NMV m0,NDV p,UINT *d)
     NM mr,mr0;      NM mr,mr0;
     NM tnm;      NM tnm;
     NMV m;      NMV m;
     UINT *d0,*dt,*dm;      UINT *d0;
     int c,n,td,i,c1,c2,len;      int c,i,c1,c2,len;
     Z q;      Z q;
     ND r;      ND r;
   
     if ( !p ) return 0;      if ( !p ) return 0;
     else {      else {
         n = NV(p); m = BDY(p); len = LEN(p);          m = BDY(p); len = LEN(p);
         d0 = DL(m0);          d0 = DL(m0);
         td = TD(d);  
         mr0 = 0;          mr0 = 0;
         NEWNM(tnm);          NEWNM(tnm);
         if ( mod ) {          if ( mod ) {
Line 10400  ND ndv_mul_nmv_trunc(int mod,NMV m0,NDV p,UINT *d)
Line 10284  ND ndv_mul_nmv_trunc(int mod,NMV m0,NDV p,UINT *d)
   
 void nd_det_reconstruct(NDV **dm,int n,int j,NDV d)  void nd_det_reconstruct(NDV **dm,int n,int j,NDV d)
 {  {
     int i,obpe,oadv,h,k,l;      int obpe,oadv,k,l;
     static NM prev_nm_free_list;      static NM prev_nm_free_list;
     EPOS oepos;      EPOS oepos;
   
Line 10435  void nd_det_reconstruct(NDV **dm,int n,int j,NDV d)
Line 10319  void nd_det_reconstruct(NDV **dm,int n,int j,NDV d)
   
 UINT *nd_det_compute_bound(NDV **dm,int n,int j)  UINT *nd_det_compute_bound(NDV **dm,int n,int j)
 {  {
     UINT *d0,*d1,*d,*t,*r;      UINT *d0,*d;
     int k,l,i;      int k,l,i;
   
     d0 = (UINT *)MALLOC(nd_nvar*sizeof(UINT));      d0 = (UINT *)MALLOC(nd_nvar*sizeof(UINT));
Line 10452  UINT *nd_det_compute_bound(NDV **dm,int n,int j)
Line 10336  UINT *nd_det_compute_bound(NDV **dm,int n,int j)
   
 DL nd_separate_d(UINT *d,UINT *trans)  DL nd_separate_d(UINT *d,UINT *trans)
 {  {
     int n,td,i,e,j;      int td,i,e,j;
     DL a;      DL a;
   
     ndl_zero(trans);      ndl_zero(trans);
Line 10485  DL nd_separate_d(UINT *d,UINT *trans)
Line 10369  DL nd_separate_d(UINT *d,UINT *trans)
   
 int nd_monic(int mod,ND *p)  int nd_monic(int mod,ND *p)
 {  {
     UINT *trans,*t;  
     DL alg;      DL alg;
     MP mp0,mp;      MP mp0,mp;
     NM m,m0,m1,ma0,ma,mb,mr0,mr;      NM m,ma0,ma,mb,mr0,mr;
     ND r;      ND r;
     DL dl;      DL dl;
     DP nm;      DP nm;
     NDV ndv;  
     DAlg inv,cd;      DAlg inv,cd;
     ND s,c;  
     Z l,mul;      Z l,mul;
     Z ln;      Z ln;
     int n,ntrans,i,e,td,is_lc,len;      int i,e,td,is_lc,len;
     NumberField nf;      NumberField nf;
     struct oEGT eg0,eg1;      struct oEGT eg0,eg1;
   
Line 10658  void conv_ilist(int demand,int trace,NODE g,int **indp
Line 10539  void conv_ilist(int demand,int trace,NODE g,int **indp
   
 NODE conv_ilist_s(int demand,int trace,int **indp)  NODE conv_ilist_s(int demand,int trace,int **indp)
 {  {
   int n,i,j;    int n,i;
   int *ind;    int *ind;
   NODE g0,g;    NODE g0,g;
   
Line 10710  void parse_nd_option(VL vl,NODE opt)
Line 10591  void parse_nd_option(VL vl,NODE opt)
         nd_gbblock = MALLOC((2*length(u)+1)*sizeof(int));          nd_gbblock = MALLOC((2*length(u)+1)*sizeof(int));
         for ( i = 0; u; u = NEXT(u) ) {          for ( i = 0; u; u = NEXT(u) ) {
           p = BDY((LIST)BDY(u));            p = BDY((LIST)BDY(u));
           s = nd_gbblock[i++] = ZTOS((Q)BDY(p));            s = nd_gbblock[i++] = (int)ZTOS((Q)BDY(p));
           nd_gbblock[i++] = s+ZTOS((Q)BDY(NEXT(p)))-1;            nd_gbblock[i++] = (int)(s+ZTOS((Q)BDY(NEXT(p)))-1);
         }          }
         nd_gbblock[i] = -1;          nd_gbblock[i] = -1;
       } else        } else
Line 10721  void parse_nd_option(VL vl,NODE opt)
Line 10602  void parse_nd_option(VL vl,NODE opt)
     else if ( !strcmp(key,"intersect") )      else if ( !strcmp(key,"intersect") )
             nd_intersect = value?1:0;              nd_intersect = value?1:0;
     else if ( !strcmp(key,"syzgen") )      else if ( !strcmp(key,"syzgen") )
             nd_intersect = ZTOS((Q)value);              nd_intersect = (int)ZTOS((Q)value);
     else if ( !strcmp(key,"lf") )      else if ( !strcmp(key,"lf") )
             nd_lf = value?1:0;              nd_lf = value?1:0;
     else if ( !strcmp(key,"trace") ) {      else if ( !strcmp(key,"trace") ) {
       if ( value ) {        if ( value ) {
         u = BDY((LIST)value);          u = BDY((LIST)value);
         nd_nzlist = BDY((LIST)ARG2(u));          nd_nzlist = BDY((LIST)ARG2(u));
         nd_bpe = ZTOS((Q)ARG3(u));          nd_bpe = (int)ZTOS((Q)ARG3(u));
       }        }
     } else if ( !strcmp(key,"f4red") ) {      } else if ( !strcmp(key,"f4red") ) {
       nd_f4red = ZTOS((Q)value);        nd_f4red = (int)ZTOS((Q)value);
     } else if ( !strcmp(key,"rank0") ) {      } else if ( !strcmp(key,"rank0") ) {
       nd_rank0 = value?1:0;        nd_rank0 = value?1:0;
     } else if ( !strcmp(key,"splist") ) {      } else if ( !strcmp(key,"splist") ) {
Line 10746  void parse_nd_option(VL vl,NODE opt)
Line 10627  void parse_nd_option(VL vl,NODE opt)
       n = length(u);        n = length(u);
       nd_sugarweight = MALLOC(n*sizeof(int));        nd_sugarweight = MALLOC(n*sizeof(int));
       for ( i = 0; i < n; i++, u = NEXT(u) )        for ( i = 0; i < n; i++, u = NEXT(u) )
         nd_sugarweight[i] = ZTOS((Q)BDY(u));          nd_sugarweight[i] = (int)ZTOS((Q)BDY(u));
     } else if ( !strcmp(key,"f4_td") ) {      } else if ( !strcmp(key,"f4_td") ) {
       nd_f4_td = value?1:0;        nd_f4_td = value?1:0;
     } else if ( !strcmp(key,"sba_f4step") ) {      } else if ( !strcmp(key,"sba_f4step") ) {
       nd_sba_f4step = value?ZTOS((Q)value):0;        nd_sba_f4step = value?(int)ZTOS((Q)value):0;
     } else if ( !strcmp(key,"sba_pot") ) {      } else if ( !strcmp(key,"sba_pot") ) {
       nd_sba_pot = ZTOS((Q)value);        nd_sba_pot = (int)ZTOS((Q)value);
     } else if ( !strcmp(key,"sba_largelcm") ) {      } else if ( !strcmp(key,"sba_largelcm") ) {
       nd_sba_largelcm = value?1:0;        nd_sba_largelcm = value?1:0;
     } else if ( !strcmp(key,"sba_dontsort") ) {      } else if ( !strcmp(key,"sba_dontsort") ) {
Line 10833  ND nd_mul_nm(int mod,NM m0,ND p)
Line 10714  ND nd_mul_nm(int mod,NM m0,ND p)
 ND nd_mul_nm_lf(NM m0,ND p)  ND nd_mul_nm_lf(NM m0,ND p)
 {  {
   UINT *d0;    UINT *d0;
   Z c0,c1,c;    Z c0,c1;
   NM tm,mr,mr0;    NM tm,mr,mr0;
   ND r;    ND r;
   
Line 10843  ND nd_mul_nm_lf(NM m0,ND p)
Line 10724  ND nd_mul_nm_lf(NM m0,ND p)
   mr0 = 0;    mr0 = 0;
   for ( tm = BDY(p); tm; tm = NEXT(tm) ) {    for ( tm = BDY(p); tm; tm = NEXT(tm) ) {
     NEXTNM(mr0,mr);      NEXTNM(mr0,mr);
     c = CZ(tm); mullf(c0,CZ(tm),&c1); CZ(mr) = c1;      mullf(c0,CZ(tm),&c1); CZ(mr) = c1;
     ndl_add(d0,DL(tm),DL(mr));      ndl_add(d0,DL(tm),DL(mr));
   }    }
   NEXT(mr) = 0;    NEXT(mr) = 0;
Line 10932  ND *btog_lf(NODE ti,ND **p,int nb)
Line 10813  ND *btog_lf(NODE ti,ND **p,int nb)
 ND btog_one(NODE ti,ND *p,int nb,int mod)  ND btog_one(NODE ti,ND *p,int nb,int mod)
 {  {
   PGeoBucket r;    PGeoBucket r;
   int i,ci,j;    int ci,j;
   NODE t,s;    NODE t,s;
   ND m,tp;    ND m,tp;
   ND pi,rd;    ND pi,rd;
Line 10946  ND btog_one(NODE ti,ND *p,int nb,int mod)
Line 10827  ND btog_one(NODE ti,ND *p,int nb,int mod)
     ptomp(mod,(P)HCZ(m),&c);      ptomp(mod,(P)HCZ(m),&c);
     if ( (ci = ((MQ)c)->cont) != 0 ) {      if ( (ci = ((MQ)c)->cont) != 0 ) {
       HCM(m) = ci;        HCM(m) = ci;
       pi = p[j=ZTOS((Q)ARG1(s))];        pi = p[j=(int)ZTOS((Q)ARG1(s))];
     if ( !pi ) {      if ( !pi ) {
       pi = nd_load_mod(j);        pi = nd_load_mod(j);
       tp = nd_mul_nm(mod,BDY(m),pi);        tp = nd_mul_nm(mod,BDY(m),pi);
Line 11008  MAT nd_btog(LIST f,LIST v,int mod,struct order_spec *o
Line 10889  MAT nd_btog(LIST f,LIST v,int mod,struct order_spec *o
   ind = BDY((LIST)ARG4(BDY(tlist)));    ind = BDY((LIST)ARG4(BDY(tlist)));
   perm = BDY((LIST)BDY(permtrace)); trace =NEXT(permtrace);    perm = BDY((LIST)BDY(permtrace)); trace =NEXT(permtrace);
   for ( i = length(perm)-1, t = trace; t; t = NEXT(t) ) {    for ( i = length(perm)-1, t = trace; t; t = NEXT(t) ) {
     j = ZTOS((Q)BDY(BDY((LIST)BDY(t))));      j = (int)ZTOS((Q)BDY(BDY((LIST)BDY(t))));
   if ( j > i ) i = j;    if ( j > i ) i = j;
   }    }
   n = i+1;    n = i+1;
Line 11016  MAT nd_btog(LIST f,LIST v,int mod,struct order_spec *o
Line 10897  MAT nd_btog(LIST f,LIST v,int mod,struct order_spec *o
   p = (ND **)MALLOC(n*sizeof(ND *));    p = (ND **)MALLOC(n*sizeof(ND *));
   for ( t = perm, i = 0; t; t = NEXT(t), i++ ) {    for ( t = perm, i = 0; t; t = NEXT(t), i++ ) {
     pi = BDY((LIST)BDY(t));      pi = BDY((LIST)BDY(t));
     pi0 = ZTOS((Q)ARG0(pi)); pi1 = ZTOS((Q)ARG1(pi));      pi0 = (int)ZTOS((Q)ARG0(pi)); pi1 = (int)ZTOS((Q)ARG1(pi));
     p[pi0] = c = (ND *)MALLOC(nb*sizeof(ND));      p[pi0] = c = (ND *)MALLOC(nb*sizeof(ND));
     ptomp(mod,(P)ARG2(pi),&inv);      ptomp(mod,(P)ARG2(pi),&inv);
     ((MQ)inv)->cont = invm(((MQ)inv)->cont,mod);      ((MQ)inv)->cont = invm(((MQ)inv)->cont,mod);
Line 11027  MAT nd_btog(LIST f,LIST v,int mod,struct order_spec *o
Line 10908  MAT nd_btog(LIST f,LIST v,int mod,struct order_spec *o
   for ( t = trace,i=0; t; t = NEXT(t), i++ ) {    for ( t = trace,i=0; t; t = NEXT(t), i++ ) {
     printf("%d ",i); fflush(stdout);      printf("%d ",i); fflush(stdout);
     ti = BDY((LIST)BDY(t));      ti = BDY((LIST)BDY(t));
     p[j=ZTOS((Q)ARG0(ti))] = btog(BDY((LIST)ARG1(ti)),p,nb,mod);      p[j=(int)ZTOS((Q)ARG0(ti))] = btog(BDY((LIST)ARG1(ti)),p,nb,mod);
   }    }
   for ( t = intred, i=0; t; t = NEXT(t), i++ ) {    for ( t = intred, i=0; t; t = NEXT(t), i++ ) {
     printf("%d ",i); fflush(stdout);      printf("%d ",i); fflush(stdout);
     ti = BDY((LIST)BDY(t));      ti = BDY((LIST)BDY(t));
     p[j=ZTOS((Q)ARG0(ti))] = btog(BDY((LIST)ARG1(ti)),p,nb,mod);      p[j=(int)ZTOS((Q)ARG0(ti))] = btog(BDY((LIST)ARG1(ti)),p,nb,mod);
   }    }
   m = length(ind);    m = length(ind);
   MKMAT(mat,nb,m);    MKMAT(mat,nb,m);
Line 11077  MAT nd_btog_lf(LIST f,LIST v,struct order_spec *ord,LI
Line 10958  MAT nd_btog_lf(LIST f,LIST v,struct order_spec *ord,LI
   ind = BDY((LIST)ARG4(BDY(tlist)));    ind = BDY((LIST)ARG4(BDY(tlist)));
   perm = BDY((LIST)BDY(permtrace)); trace =NEXT(permtrace);    perm = BDY((LIST)BDY(permtrace)); trace =NEXT(permtrace);
   for ( i = length(perm)-1, t = trace; t; t = NEXT(t) ) {    for ( i = length(perm)-1, t = trace; t; t = NEXT(t) ) {
     j = ZTOS((Q)BDY(BDY((LIST)BDY(t))));      j = (int)ZTOS((Q)BDY(BDY((LIST)BDY(t))));
   if ( j > i ) i = j;    if ( j > i ) i = j;
   }    }
   n = i+1;    n = i+1;
Line 11085  MAT nd_btog_lf(LIST f,LIST v,struct order_spec *ord,LI
Line 10966  MAT nd_btog_lf(LIST f,LIST v,struct order_spec *ord,LI
   p = (ND **)MALLOC(n*sizeof(ND *));    p = (ND **)MALLOC(n*sizeof(ND *));
   for ( t = perm, i = 0; t; t = NEXT(t), i++ ) {    for ( t = perm, i = 0; t; t = NEXT(t), i++ ) {
     pi = BDY((LIST)BDY(t));      pi = BDY((LIST)BDY(t));
     pi0 = ZTOS((Q)ARG0(pi)); pi1 = ZTOS((Q)ARG1(pi));      pi0 = (int)ZTOS((Q)ARG0(pi)); pi1 = (int)ZTOS((Q)ARG1(pi));
     p[pi0] = c = (ND *)MALLOC(nb*sizeof(ND));      p[pi0] = c = (ND *)MALLOC(nb*sizeof(ND));
     simp_ff((Obj)ARG2(pi),(Obj *)&lm); lmtolf(lm,&lf); invz(lf,current_mod_lf,&inv);      simp_ff((Obj)ARG2(pi),(Obj *)&lm); lmtolf(lm,&lf); invz(lf,current_mod_lf,&inv);
     u = ptond(CO,vv,(P)ONE);      u = ptond(CO,vv,(P)ONE);
Line 11095  MAT nd_btog_lf(LIST f,LIST v,struct order_spec *ord,LI
Line 10976  MAT nd_btog_lf(LIST f,LIST v,struct order_spec *ord,LI
   for ( t = trace,i=0; t; t = NEXT(t), i++ ) {    for ( t = trace,i=0; t; t = NEXT(t), i++ ) {
     printf("%d ",i); fflush(stdout);      printf("%d ",i); fflush(stdout);
     ti = BDY((LIST)BDY(t));      ti = BDY((LIST)BDY(t));
     p[j=ZTOS((Q)ARG0(ti))] = btog_lf(BDY((LIST)ARG1(ti)),p,nb);      p[j=(int)ZTOS((Q)ARG0(ti))] = btog_lf(BDY((LIST)ARG1(ti)),p,nb);
   }    }
   for ( t = intred, i=0; t; t = NEXT(t), i++ ) {    for ( t = intred, i=0; t; t = NEXT(t), i++ ) {
     printf("%d ",i); fflush(stdout);      printf("%d ",i); fflush(stdout);
     ti = BDY((LIST)BDY(t));      ti = BDY((LIST)BDY(t));
     p[j=ZTOS((Q)ARG0(ti))] = btog_lf(BDY((LIST)ARG1(ti)),p,nb);      p[j=(int)ZTOS((Q)ARG0(ti))] = btog_lf(BDY((LIST)ARG1(ti)),p,nb);
   }    }
   m = length(ind);    m = length(ind);
   MKMAT(mat,nb,m);    MKMAT(mat,nb,m);
Line 11117  VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp
Line 10998  VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp
   VL fv,tv,vv;    VL fv,tv,vv;
   NODE permtrace,perm,trace,intred,ind,t,pi,ti;    NODE permtrace,perm,trace,intred,ind,t,pi,ti;
   ND *p;    ND *p;
   ND *c;  
   ND u;    ND u;
   P inv;    P inv;
   VECT vect;    VECT vect;
Line 11148  VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp
Line 11028  VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp
   ind = BDY((LIST)ARG4(BDY(tlist)));    ind = BDY((LIST)ARG4(BDY(tlist)));
   perm = BDY((LIST)BDY(permtrace)); trace =NEXT(permtrace);    perm = BDY((LIST)BDY(permtrace)); trace =NEXT(permtrace);
   for ( i = length(perm)-1, t = trace; t; t = NEXT(t) ) {    for ( i = length(perm)-1, t = trace; t; t = NEXT(t) ) {
     j = ZTOS((Q)BDY(BDY((LIST)BDY(t))));      j = (int)ZTOS((Q)BDY(BDY((LIST)BDY(t))));
   if ( j > i ) i = j;    if ( j > i ) i = j;
   }    }
   n = i+1;    n = i+1;
Line 11156  VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp
Line 11036  VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp
   p = (ND *)MALLOC(n*sizeof(ND *));    p = (ND *)MALLOC(n*sizeof(ND *));
   for ( t = perm, i = 0; t; t = NEXT(t), i++ ) {    for ( t = perm, i = 0; t; t = NEXT(t), i++ ) {
     pi = BDY((LIST)BDY(t));      pi = BDY((LIST)BDY(t));
   pi0 = ZTOS((Q)ARG0(pi)); pi1 = ZTOS((Q)ARG1(pi));    pi0 = (int)ZTOS((Q)ARG0(pi)); pi1 = (int)ZTOS((Q)ARG1(pi));
   if ( pi1 == pos ) {    if ( pi1 == pos ) {
     ptomp(mod,(P)ARG2(pi),&inv);      ptomp(mod,(P)ARG2(pi),&inv);
     ((MQ)inv)->cont = invm(((MQ)inv)->cont,mod);      ((MQ)inv)->cont = invm(((MQ)inv)->cont,mod);
Line 11168  VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp
Line 11048  VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp
   for ( t = trace,i=0; t; t = NEXT(t), i++ ) {    for ( t = trace,i=0; t; t = NEXT(t), i++ ) {
   printf("%d ",i); fflush(stdout);    printf("%d ",i); fflush(stdout);
     ti = BDY((LIST)BDY(t));      ti = BDY((LIST)BDY(t));
     p[j=ZTOS((Q)ARG0(ti))] = btog_one(BDY((LIST)ARG1(ti)),p,nb,mod);      p[j=(int)ZTOS((Q)ARG0(ti))] = btog_one(BDY((LIST)ARG1(ti)),p,nb,mod);
     if ( Demand ) {      if ( Demand ) {
         nd_save_mod(p[j],j); nd_free(p[j]); p[j] = 0;          nd_save_mod(p[j],j); nd_free(p[j]); p[j] = 0;
   }    }
Line 11176  VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp
Line 11056  VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp
   for ( t = intred, i=0; t; t = NEXT(t), i++ ) {    for ( t = intred, i=0; t; t = NEXT(t), i++ ) {
   printf("%d ",i); fflush(stdout);    printf("%d ",i); fflush(stdout);
     ti = BDY((LIST)BDY(t));      ti = BDY((LIST)BDY(t));
     p[j=ZTOS((Q)ARG0(ti))] = btog_one(BDY((LIST)ARG1(ti)),p,nb,mod);      p[j=(int)ZTOS((Q)ARG0(ti))] = btog_one(BDY((LIST)ARG1(ti)),p,nb,mod);
     if ( Demand ) {      if ( Demand ) {
         nd_save_mod(p[j],j); nd_free(p[j]); p[j] = 0;          nd_save_mod(p[j],j); nd_free(p[j]); p[j] = 0;
   }    }
Line 11186  VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp
Line 11066  VECT nd_btog_one(LIST f,LIST v,int mod,struct order_sp
   for ( j = 0, t = ind; j < m; j++, t = NEXT(t) ) {    for ( j = 0, t = ind; j < m; j++, t = NEXT(t) ) {
   u = p[ZTOS((Q)BDY(t))];    u = p[ZTOS((Q)BDY(t))];
   if ( !u ) {    if ( !u ) {
     u = nd_load_mod(ZTOS((Q)BDY(t)));      u = nd_load_mod((int)ZTOS((Q)BDY(t)));
     BDY(vect)[j] = ndtodp(mod,u);      BDY(vect)[j] = ndtodp(mod,u);
     nd_free(u);      nd_free(u);
   } else    } else
Line 11215  void ndv_print_lf(NDV p)
Line 11095  void ndv_print_lf(NDV p)
   
 void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,struct order_spec *ord,LIST *rp)  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,struct order_spec *ord,LIST *rp)
 {  {
     VL tv,fv,vv,vc,av;      VL tv,fv,vv;
     NODE fd,fd0,in0,in,r,r0,t,s,cand,alist;      NODE fd,fd0,in0,in,r,t,s,cand;
     int m,nocheck,nvar,mindex,e,max;      int m,nvar,mindex,e,max;
     NDV c;      NDV c;
     NMV a;      NMV a;
     P p,zp;  
     Q dmy;  
     EPOS oepos;      EPOS oepos;
     int obpe,oadv,wmax,i,len,cbpe,ishomo,nalg,mrank,trank,ompos;      int obpe,oadv,wmax,i,len,cbpe,ishomo,mrank,trank,ompos;
     Alg alpha,dp;  
     P poly;  
     LIST f1,f2,zpl;  
     Obj obj;  
     NumberField nf;  
     struct order_spec *ord1;      struct order_spec *ord1;
     struct oEGT eg_check,eg0,eg1;      struct oEGT eg_check,eg0,eg1;
     NODE tr,tl1,tl2,tl3,tl4;  
     LIST l1,l2,l3,l4,l5;  
     int *perm;      int *perm;
     int j,ret;      int ret;
     NODE retn;      NODE retn;
     Q jq,bpe;  
   
     nd_module = 0;      nd_module = 0;
     get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc);      get_vars((Obj)f,&fv); pltovl(v,&vv); vlminus(fv,vv,&nd_vc);
Line 11256  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
Line 11126  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
     nd_ntrans = nvar;      nd_ntrans = nvar;
     nd_nalg = 0;      nd_nalg = 0;
   
     nocheck = 0;  //    nocheck = 0;
     mindex = 0;      mindex = 0;
   
     /* do not use on-demand load/save */      /* do not use on-demand load/save */
Line 11303  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
Line 11173  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
         for ( t = in0, wmax = max; t; t = NEXT(t) ) {          for ( t = in0, wmax = max; t; t = NEXT(t) ) {
             c = (NDV)BDY(t); len = LEN(c);              c = (NDV)BDY(t); len = LEN(c);
             for ( a = BDY(c), i = 0; i < len; i++, NMV_ADV(a) )              for ( a = BDY(c), i = 0; i < len; i++, NMV_ADV(a) )
                 wmax = MAX(TD(DL(a)),wmax);                  wmax = MAX((int)TD(DL(a)),wmax);
         }          }
         homogenize_order(ord,nvar,&ord1);          homogenize_order(ord,nvar,&ord1);
         nd_init_ord(ord1);          nd_init_ord(ord1);
Line 11311  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
Line 11181  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
         for ( t = fd0; t; t = NEXT(t) )          for ( t = fd0; t; t = NEXT(t) )
             ndv_homogenize((NDV)BDY(t),obpe,oadv,oepos,ompos);              ndv_homogenize((NDV)BDY(t),obpe,oadv,oepos,ompos);
     }      }
     if ( MaxDeg > 0 ) nocheck = 1;  //    if ( MaxDeg > 0 ) nocheck = 1;
     ret = ndv_setup(-2,m,fd0,nd_gbblock?1:0,0,0);      ret = ndv_setup(-2,m,fd0,nd_gbblock?1:0,0,0);
     if ( ret )      if ( ret )
       cand = nd_f4_lf_trace_main(m,&perm);        cand = nd_f4_lf_trace_main(m,&perm);
Line 11331  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
Line 11201  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
     if ( (ret = ndv_check_membership(-2,in0,obpe,oadv,oepos,cand)) != 0 ) {      if ( (ret = ndv_check_membership(-2,in0,obpe,oadv,oepos,cand)) != 0 ) {
       /* gbcheck : cand is a GB of Id(cand) ? */        /* gbcheck : cand is a GB of Id(cand) ? */
       retn = nd_f4(-2,0,0);        retn = nd_f4(-2,0,0);
         if ( !retn ) {
           /* failure */
           *rp = 0; return;
         }
     }      }
   if ( !retn ) {  
       /* failure */  
       *rp = 0; return;  
     }  
     get_eg(&eg1); init_eg(&eg_check); add_eg(&eg_check,&eg0,&eg1);      get_eg(&eg1); init_eg(&eg_check); add_eg(&eg_check,&eg0,&eg1);
     if ( DP_Print )      if ( DP_Print )
         fprintf(asir_out,"check=%.3fsec\n",eg_check.exectime);          fprintf(asir_out,"check=%.3fsec\n",eg_check.exectime);
Line 11351  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
Line 11221  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
   
 NODE nd_f4_lf_trace_main(int m,int **indp)  NODE nd_f4_lf_trace_main(int m,int **indp)
 {  {
     int i,nh,stat,index;      int i,nh,stat;
     NODE r,rm,g;      NODE r,rm,g;
     ND_pairs d,l,l0,t;      ND_pairs d,l,l0,t;
     ND spol,red;      NDV nfqv,nfv;
     NDV nf,redv,nfqv,nfv;      NODE rp0,nflist,nflist_lf;
     NM s0,s;      UINT *s0vect;
     NODE rp0,srp0,nflist,nflist_lf;      int col;
     int nsp,nred,col,rank,len,k,j,a;  
     UINT c;  
     UINT **spmat;  
     UINT *s0vect,*svect,*p,*v;  
     int *colstat;  
     IndArray *imat;  
     int *rhead;  
     int spcol,sprow;  
     int sugar;      int sugar;
     PGeoBucket bucket;      PGeoBucket bucket;
     struct oEGT eg0,eg1,eg_f4;      struct oEGT eg0,eg1,eg_f4;
Line 11896  NODE nd_f4_red_s(int m,ND_pairs sp0,int trace,UINT *s0
Line 11758  NODE nd_f4_red_s(int m,ND_pairs sp0,int trace,UINT *s0
   NODE r0,rp;    NODE r0,rp;
   ND_pairs sp;    ND_pairs sp;
   NM_ind_pair *rvect;    NM_ind_pair *rvect;
   UINT *s;  
   int *s0hash;  
   struct oEGT eg0,eg1,eg_conv;    struct oEGT eg0,eg1,eg_conv;
   
   for ( sp = sp0, nsp = 0; sp; sp = NEXT(sp), nsp++ );    for ( sp = sp0, nsp = 0; sp; sp = NEXT(sp), nsp++ );
Line 11930  NODE nd_f4_red_s(int m,ND_pairs sp0,int trace,UINT *s0
Line 11790  NODE nd_f4_red_s(int m,ND_pairs sp0,int trace,UINT *s0
 #else  #else
     r0 = nd_f4_red_main_s(m,sp0,nsp,s0vect,col,rvect,rhead,imat,nred,syzlistp);      r0 = nd_f4_red_main_s(m,sp0,nsp,s0vect,col,rvect,rhead,imat,nred,syzlistp);
 #endif  #endif
   else    else {
 //    r0 = nd_f4_red_q_main_s(sp0,nsp,trace,s0vect,col,rvect,rhead,imat,nred);  //    r0 = nd_f4_red_q_main_s(sp0,nsp,trace,s0vect,col,rvect,rhead,imat,nred);
       r0 = 0;
     error("nd_f4_red_q_main_s : not implemented yet");      error("nd_f4_red_q_main_s : not implemented yet");
     }
   return r0;    return r0;
 }  }
   
 INLINE int ndl_find_reducer_minsig(UINT *dg)  INLINE int ndl_find_reducer_minsig(UINT *dg)
 {  {
   RHist r;    RHist r;
   int i,singular,ret,d,k,imin;    int i,imin;
   SIG t;    SIG t;
   static int wpd,nvar;    static int wpd,nvar;
   static SIG quo,quomin;    static SIG quo,quomin;
Line 12038  int nd_symbolic_preproc_s(PGeoBucket bucket,int trace,
Line 11900  int nd_symbolic_preproc_s(PGeoBucket bucket,int trace,
   
 NODE nd_sba_f4(int m,int **indp)  NODE nd_sba_f4(int m,int **indp)
 {  {
   int i,nh,stat,index,f4red,f4step;    int i,nh,stat,f4red,f4step;
   int col,rank,len,k,j,a,sugar,nbase,psugar,ms;    int col,psugar,ms;
   NODE r,g,rp0,nflist;    NODE r,g,rp0,nflist;
   ND_pairs d,l,t,l1;    ND_pairs d,l,t,l1;
   ND h,nf;    ND h,nf;
   NDV nfv;    NDV nfv;
   union oNDC hc;  //  union oNDC hc;
   UINT *s0vect;    UINT *s0vect;
   UINT c;  
   PGeoBucket bucket;    PGeoBucket bucket;
   NODE *syzlist;    NODE *syzlist;
   SIG sig;    SIG sig;
   struct oEGT eg0,eg1,eg_f4;    struct oEGT eg1;
   struct oEGT eg2,eg_update,eg_remove,eg_large,eg_nf,eg_nfzero;    struct oEGT eg2,eg_remove,eg_nf,eg_nfzero;
   
   Nf4_red=0;    Nf4_red=0;
   d = 0;    d = 0;
Line 12107  again:
Line 11968  again:
       } else if ( nf ) {        } else if ( nf ) {
         if ( DP_Print ) { printf("+"); fflush(stdout); }          if ( DP_Print ) { printf("+"); fflush(stdout); }
         add_eg(&eg_nf,&eg1,&eg2);          add_eg(&eg_nf,&eg1,&eg2);
         hc = HCU(nf);  //        hc = HCU(nf);
         nd_removecont(m,nf);          nd_removecont(m,nf);
         nfv = ndtondv(m,nf); nd_free(nf);          nfv = ndtondv(m,nf); nd_free(nf);
         nh = ndv_newps(m,nfv,0);          nh = ndv_newps(m,nfv,0);
Line 12131  again:
Line 11992  again:
 again2:  again2:
       psugar = ms;        psugar = ms;
       l = nd_minsugarp_s(d,&d);        l = nd_minsugarp_s(d,&d);
       sugar = nd_sugarweight?d->sugar2:SG(d);  //      sugar = nd_sugarweight?d->sugar2:SG(d);
       bucket = create_pbucket();        bucket = create_pbucket();
       stat = nd_sp_f4(m,0,l,bucket);        stat = nd_sp_f4(m,0,l,bucket);
       if ( !stat ) {        if ( !stat ) {

Legend:
Removed from v.1.64  
changed lines
  Added in v.1.65

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