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

Diff for /OpenXM_contrib2/asir2000/engine/nd.c between version 1.234 and 1.235

version 1.234, 2017/02/21 09:20:23 version 1.235, 2017/02/28 07:06:28
Line 1 
Line 1 
 /* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.233 2017/02/07 08:30:30 noro Exp $ */  /* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.234 2017/02/21 09:20:23 noro Exp $ */
   
 #include "nd.h"  #include "nd.h"
   
Line 1456  int nd_nf(int mod,ND d,ND g,NDV *ps,int full,NDC dn,ND
Line 1456  int nd_nf(int mod,ND d,ND g,NDV *ps,int full,NDC dn,ND
   
     sugar0 = sugar = SG(g);      sugar0 = sugar = SG(g);
     n = NV(g);      n = NV(g);
     mul = (NM)ALLOCA(sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT));      mul = (NM)MALLOC(sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT));
     if ( d )      if ( d )
         for ( tail = BDY(d); NEXT(tail); tail = NEXT(tail) );          for ( tail = BDY(d); NEXT(tail); tail = NEXT(tail) );
     for ( ; g; ) {      for ( ; g; ) {
Line 1544  int nd_nf_pbucket(int mod,ND g,NDV *ps,int full,ND *rp
Line 1544  int nd_nf_pbucket(int mod,ND g,NDV *ps,int full,ND *rp
     bucket = create_pbucket();      bucket = create_pbucket();
     add_pbucket(mod,bucket,g);      add_pbucket(mod,bucket,g);
     d = 0;      d = 0;
     mul = (NM)ALLOCA(sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT));      mul = (NM)MALLOC(sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT));
     while ( 1 ) {      while ( 1 ) {
         if ( mod > 0 || mod == -1 )          if ( mod > 0 || mod == -1 )
           hindex = head_pbucket(mod,bucket);            hindex = head_pbucket(mod,bucket);
Line 2667  ND_pairs crit_B( ND_pairs d, int s )
Line 2667  ND_pairs crit_B( ND_pairs d, int s )
     t = DL(nd_psh[s]);      t = DL(nd_psh[s]);
     prev = 0;      prev = 0;
     head = cur = d;      head = cur = d;
     lcm = (UINT *)ALLOCA(nd_wpd*sizeof(UINT));      lcm = (UINT *)MALLOC(nd_wpd*sizeof(UINT));
     while ( cur ) {      while ( cur ) {
         tl = cur->lcm;          tl = cur->lcm;
         if ( ndl_reducible(tl,t) ) {          if ( ndl_reducible(tl,t) ) {
Line 2950  int ndv_newps(int m,NDV a,NDV aq,int f4)
Line 2950  int ndv_newps(int m,NDV a,NDV aq,int f4)
     if ( nd_demand ) {      if ( nd_demand ) {
         if ( aq ) {          if ( aq ) {
             ndv_save(nd_ps_trace[nd_psn],nd_psn);              ndv_save(nd_ps_trace[nd_psn],nd_psn);
               nd_ps_sym[nd_psn] = ndv_symbolic(m,nd_ps_trace[nd_psn]);
             nd_ps_trace_sym[nd_psn] = ndv_symbolic(m,nd_ps_trace[nd_psn]);              nd_ps_trace_sym[nd_psn] = ndv_symbolic(m,nd_ps_trace[nd_psn]);
             nd_ps_trace[nd_psn] = 0;              nd_ps_trace[nd_psn] = 0;
         } else {          } else {
Line 2989  int ndv_setup(int mod,int trace,NODE f,int dont_sort,i
Line 2990  int ndv_setup(int mod,int trace,NODE f,int dont_sort,i
     nd_tracelist = 0;      nd_tracelist = 0;
   
     for ( nd_psn = 0, s = f; s; s = NEXT(s) ) if ( BDY(s) ) nd_psn++;      for ( nd_psn = 0, s = f; s; s = NEXT(s) ) if ( BDY(s) ) nd_psn++;
     w = (NDVI)ALLOCA(nd_psn*sizeof(struct oNDVI));      w = (NDVI)MALLOC(nd_psn*sizeof(struct oNDVI));
     for ( i = j = 0, s = f; s; s = NEXT(s), j++ )      for ( i = j = 0, s = f; s; s = NEXT(s), j++ )
         if ( BDY(s) ) { w[i].p = BDY(s); w[i].i = j; i++; }          if ( BDY(s) ) { w[i].p = BDY(s); w[i].i = j; i++; }
     if ( !dont_sort ) {      if ( !dont_sort ) {
Line 3062  int ndv_setup(int mod,int trace,NODE f,int dont_sort,i
Line 3063  int ndv_setup(int mod,int trace,NODE f,int dont_sort,i
         if ( nd_demand ) {          if ( nd_demand ) {
             if ( trace ) {              if ( trace ) {
                 ndv_save(nd_ps_trace[i],i);                  ndv_save(nd_ps_trace[i],i);
                   nd_ps_sym[i] = ndv_symbolic(mod,nd_ps_trace[i]);
                 nd_ps_trace_sym[i] = ndv_symbolic(mod,nd_ps_trace[i]);                  nd_ps_trace_sym[i] = ndv_symbolic(mod,nd_ps_trace[i]);
                 nd_ps_trace[i] = 0;                  nd_ps_trace[i] = 0;
             } else {              } else {
Line 3489  NDV recompute_trace(NODE ti,NDV *p,int mod)
Line 3491  NDV recompute_trace(NODE ti,NDV *p,int mod)
         static int afo=0;          static int afo=0;
   
         afo++;          afo++;
         mul = (NM)ALLOCA(sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT));          mul = (NM)MALLOC(sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT));
         CM(mul) = 1;          CM(mul) = 1;
         tail = 0;          tail = 0;
         for ( i = 0, d = r = 0; ti; ti = NEXT(ti), i++ ) {          for ( i = 0, d = r = 0; ti; ti = NEXT(ti), i++ ) {
Line 3649  void nd_gr_trace(LIST f,LIST v,int trace,int homo,int 
Line 3651  void nd_gr_trace(LIST f,LIST v,int trace,int homo,int 
     Q jq,bpe;      Q jq,bpe;
   
     nd_module = 0;      nd_module = 0;
       nd_lf = 0;
     parse_nd_option(current_option);      parse_nd_option(current_option);
     if ( nd_lf ) {      if ( nd_lf ) {
       if ( f4 )        if ( f4 )
Line 3986  void nd_removecont(int mod,ND p)
Line 3989  void nd_removecont(int mod,ND p)
     } else if ( mod ) nd_mul_c(mod,p,invm(HCM(p),mod));      } else if ( mod ) nd_mul_c(mod,p,invm(HCM(p),mod));
     else {      else {
         for ( m = BDY(p), n = 0; m; m = NEXT(m), n++ );          for ( m = BDY(p), n = 0; m; m = NEXT(m), n++ );
         w = (Q *)ALLOCA(n*sizeof(Q));          w = (Q *)MALLOC(n*sizeof(Q));
         v.len = n;          v.len = n;
         v.body = (pointer *)w;          v.body = (pointer *)w;
         for ( m = BDY(p), i = 0; i < n; m = NEXT(m), i++ ) w[i] = CQ(m);          for ( m = BDY(p), i = 0; i < n; m = NEXT(m), i++ ) w[i] = CQ(m);
Line 4007  void nd_removecont2(ND p1,ND p2)
Line 4010  void nd_removecont2(ND p1,ND p2)
     n1 = nd_length(p1);      n1 = nd_length(p1);
     n2 = nd_length(p2);      n2 = nd_length(p2);
     n = n1+n2;      n = n1+n2;
     w = (Q *)ALLOCA(n*sizeof(Q));      w = (Q *)MALLOC(n*sizeof(Q));
     v.len = n;      v.len = n;
     v.body = (pointer *)w;      v.body = (pointer *)w;
     i = 0;      i = 0;
Line 4042  void ndv_removecont(int mod,NDV p)
Line 4045  void ndv_removecont(int mod,NDV p)
         ndv_mul_c(mod,p,invm(HCM(p),mod));          ndv_mul_c(mod,p,invm(HCM(p),mod));
     else {      else {
         len = p->len;          len = p->len;
         w = (P *)ALLOCA(len*sizeof(P));          w = (P *)MALLOC(len*sizeof(P));
         c = (Q *)ALLOCA(len*sizeof(Q));          c = (Q *)MALLOC(len*sizeof(Q));
         for ( m = BDY(p), all_p = 1, i = 0; i < len; NMV_ADV(m), i++ ) {          for ( m = BDY(p), all_p = 1, i = 0; i < len; NMV_ADV(m), i++ ) {
             ptozp(CP(m),1,&c[i],&w[i]);              ptozp(CP(m),1,&c[i],&w[i]);
             all_p = all_p && !NUM(w[i]);              all_p = all_p && !NUM(w[i]);
Line 4077  void ndv_homogenize(NDV p,int obpe,int oadv,EPOS oepos
Line 4080  void ndv_homogenize(NDV p,int obpe,int oadv,EPOS oepos
     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);
     t = (NMV)ALLOCA(nmv_adv);      t = (NMV)MALLOC(nmv_adv);
     for ( i = 0; i < len; i++, NMV_OPREV(m), NMV_PREV(mr) ) {      for ( i = 0; i < len; i++, NMV_OPREV(m), NMV_PREV(mr) ) {
         ndl_homogenize(DL(m),DL(t),obpe,oepos,ompos,max);          ndl_homogenize(DL(m),DL(t),obpe,oepos,ompos,max);
         CQ(mr) = CQ(m);          CQ(mr) = CQ(m);
Line 4125  void nd_heu_nezgcdnpz(VL vl,P *pl,int m,int full,P *pr
Line 4128  void nd_heu_nezgcdnpz(VL vl,P *pl,int m,int full,P *pr
     NODE l;      NODE l;
     P h,gcd,t;      P h,gcd,t;
   
     tpl = (P *)ALLOCA(m*sizeof(P));      tpl = (P *)MALLOC(m*sizeof(P));
     tpl1 = (P *)ALLOCA(m*sizeof(P));      tpl1 = (P *)MALLOC(m*sizeof(P));
     bcopy(pl,tpl,m*sizeof(P));      bcopy(pl,tpl,m*sizeof(P));
     gcd = (P)ONE;      gcd = (P)ONE;
     for ( l = nd_hcf; l; l = NEXT(l) ) {      for ( l = nd_hcf; l; l = NEXT(l) ) {
Line 4162  void removecont_array(P *p,int n,int full)
Line 4165  void removecont_array(P *p,int n,int full)
     if ( all_q ) {      if ( all_q ) {
         removecont_array_q((Q *)p,n);          removecont_array_q((Q *)p,n);
     } else {      } else {
         c = (Q *)ALLOCA(n*sizeof(Q));          c = (Q *)MALLOC(n*sizeof(Q));
         w = (P *)ALLOCA(n*sizeof(P));          w = (P *)MALLOC(n*sizeof(P));
         for ( i = 0; i < n; i++ ) {          for ( i = 0; i < n; i++ ) {
             ptozp(p[i],1,&c[i],&w[i]);              ptozp(p[i],1,&c[i],&w[i]);
         }          }
Line 4183  void removecont_array_q(Q *c,int n)
Line 4186  void removecont_array_q(Q *c,int n)
     N qn,rn,gn;      N qn,rn,gn;
     Q *q,*r;      Q *q,*r;
   
     q = (Q *)ALLOCA(n*sizeof(Q));      q = (Q *)MALLOC(n*sizeof(Q));
     r = (Q *)ALLOCA(n*sizeof(Q));      r = (Q *)MALLOC(n*sizeof(Q));
     v.id = O_VECT; v.len = n; v.body = (pointer *)c;      v.id = O_VECT; v.len = n; v.body = (pointer *)c;
     igcdv_estimate(&v,&d0);      igcdv_estimate(&v,&d0);
     for ( i = 0; i < n; i++ ) {      for ( i = 0; i < n; i++ ) {
Line 4302  UINT *ndv_compute_bound(NDV p)
Line 4305  UINT *ndv_compute_bound(NDV p)
   
     if ( !p )      if ( !p )
         return 0;          return 0;
     d1 = (UINT *)ALLOCA(nd_wpd*sizeof(UINT));      d1 = (UINT *)MALLOC(nd_wpd*sizeof(UINT));
     d2 = (UINT *)ALLOCA(nd_wpd*sizeof(UINT));      d2 = (UINT *)MALLOC(nd_wpd*sizeof(UINT));
     len = LEN(p);      len = LEN(p);
     m = BDY(p); ndl_copy(DL(m),d1); NMV_ADV(m);      m = BDY(p); ndl_copy(DL(m),d1); NMV_ADV(m);
     for ( i = 1; i < len; i++, NMV_ADV(m) ) {      for ( i = 1; i < len; i++, NMV_ADV(m) ) {
Line 4331  UINT *nd_compute_bound(ND p)
Line 4334  UINT *nd_compute_bound(ND p)
   
     if ( !p )      if ( !p )
         return 0;          return 0;
     d1 = (UINT *)ALLOCA(nd_wpd*sizeof(UINT));      d1 = (UINT *)MALLOC(nd_wpd*sizeof(UINT));
     d2 = (UINT *)ALLOCA(nd_wpd*sizeof(UINT));      d2 = (UINT *)MALLOC(nd_wpd*sizeof(UINT));
     len = LEN(p);      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) ) {
Line 4491  ND_pairs nd_reconstruct(int trace,ND_pairs d)
Line 4494  ND_pairs nd_reconstruct(int trace,ND_pairs d)
         ndl_reconstruct(LCM(t),LCM(s),obpe,oepos);          ndl_reconstruct(LCM(t),LCM(s),obpe,oepos);
     }      }
   
     old_red = (RHist *)ALLOCA(REDTAB_LEN*sizeof(RHist));      old_red = (RHist *)MALLOC(REDTAB_LEN*sizeof(RHist));
     for ( i = 0; i < REDTAB_LEN; i++ ) {      for ( i = 0; i < REDTAB_LEN; i++ ) {
         old_red[i] = nd_red[i];          old_red[i] = nd_red[i];
         nd_red[i] = 0;          nd_red[i] = 0;
Line 4688  ND weyl_ndv_mul_nm(int mod,NM m0,NDV p) {
Line 4691  ND weyl_ndv_mul_nm(int mod,NM m0,NDV p) {
     d0 = DL(m0);      d0 = DL(m0);
     l = LEN(p);      l = LEN(p);
     for ( i = 0, tlen = 1; i < n2; i++ ) tlen *= (GET_EXP(d0,n2+i)+1);      for ( i = 0, tlen = 1; i < n2; i++ ) tlen *= (GET_EXP(d0,n2+i)+1);
     tab = (NM *)ALLOCA(tlen*sizeof(NM));      tab = (NM *)MALLOC(tlen*sizeof(NM));
     psum = (NM *)ALLOCA(tlen*sizeof(NM));      psum = (NM *)MALLOC(tlen*sizeof(NM));
     for ( i = 0; i < tlen; i++ ) psum[i] = 0;      for ( i = 0; i < tlen; i++ ) psum[i] = 0;
     m1 = (NMV)(((char *)BDY(p))+nmv_adv*(l-1));      m1 = (NMV)(((char *)BDY(p))+nmv_adv*(l-1));
     for ( i = l-1; i >= 0; i--, NMV_PREV(m1) ) {      for ( i = l-1; i >= 0; i--, NMV_PREV(m1) ) {
Line 4767  void weyl_mul_nm_nmv(int n,int mod,NM m0,NMV m1,NM *ta
Line 4770  void weyl_mul_nm_nmv(int n,int mod,NM m0,NMV m1,NM *ta
         }          }
         min = MIN(k,l);          min = MIN(k,l);
         if ( mod ) {          if ( mod ) {
             ctab = (UINT *)ALLOCA((min+1)*sizeof(UINT));              ctab = (UINT *)MALLOC((min+1)*sizeof(UINT));
             mkwcm(k,l,mod,ctab);              mkwcm(k,l,mod,ctab);
         } else {          } else {
             ctab_q = (Q *)ALLOCA((min+1)*sizeof(Q));              ctab_q = (Q *)MALLOC((min+1)*sizeof(Q));
             mkwc(k,l,ctab_q);              mkwc(k,l,ctab_q);
         }          }
         for ( j = min; j >= 0; j-- ) {          for ( j = min; j >= 0; j-- ) {
Line 4930  ND nd_quo(int mod,PGeoBucket bucket,NDV d)
Line 4933  ND nd_quo(int mod,PGeoBucket bucket,NDV d)
     else {      else {
         nv = NV(d);          nv = NV(d);
         mq0 = 0;          mq0 = 0;
         tm = (NMV)ALLOCA(nmv_adv);          tm = (NMV)MALLOC(nmv_adv);
         while ( 1 ) {          while ( 1 ) {
             if ( mod > 0 || mod == -1 )              if ( mod > 0 || mod == -1 )
               hindex = head_pbucket(mod,bucket);                hindex = head_pbucket(mod,bucket);
Line 4980  void ndv_realloc(NDV p,int obpe,int oadv,EPOS oepos)
Line 4983  void ndv_realloc(NDV p,int obpe,int oadv,EPOS oepos)
     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);
     t = (NMV)ALLOCA(nmv_adv);      t = (NMV)MALLOC(nmv_adv);
     for ( i = 0; i < len; i++, NMV_OPREV(m), NMV_PREV(mr) ) {      for ( i = 0; i < len; i++, NMV_OPREV(m), NMV_PREV(mr) ) {
         CQ(t) = CQ(m);          CQ(t) = CQ(m);
         for ( k = 0; k < nd_wpd; k++ ) DL(t)[k] = 0;          for ( k = 0; k < nd_wpd; k++ ) DL(t)[k] = 0;
Line 5128  void ndv_mod(int mod,NDV p)
Line 5131  void ndv_mod(int mod,NDV p)
     if ( mod == -1 )      if ( mod == -1 )
         for ( t = d = BDY(p), i = 0; i < len; i++, NMV_ADV(t) ) {          for ( t = d = BDY(p), i = 0; i < len; i++, NMV_ADV(t) ) {
             simp_ff((Obj)CP(t),&gfs);              simp_ff((Obj)CP(t),&gfs);
             r = FTOIF(CONT((GFS)gfs));              if ( gfs ) {
             CM(d) = r;                r = FTOIF(CONT((GFS)gfs));
             ndl_copy(DL(t),DL(d));                CM(d) = r;
             NMV_ADV(d);                ndl_copy(DL(t),DL(d));
             dlen++;                NMV_ADV(d);
                 dlen++;
               }
         }          }
     else if ( mod == -2 )      else if ( mod == -2 )
         for ( t = d = BDY(p), i = 0; i < len; i++, NMV_ADV(t) ) {          for ( t = d = BDY(p), i = 0; i < len; i++, NMV_ADV(t) ) {
             simp_ff((Obj)CP(t),&gfs); lmtolf(gfs,&CZ(d));              simp_ff((Obj)CP(t),&gfs);
             ndl_copy(DL(t),DL(d));              if ( gfs ) {
             NMV_ADV(d);                lmtolf(gfs,&CZ(d));
             dlen++;                ndl_copy(DL(t),DL(d));
                 NMV_ADV(d);
                 dlen++;
               }
         }          }
     else      else
         for ( t = d = BDY(p), i = 0; i < len; i++, NMV_ADV(t) ) {          for ( t = d = BDY(p), i = 0; i < len; i++, NMV_ADV(t) ) {
Line 5188  void pltozpl(LIST l,Q *cont,LIST *pp)
Line 5196  void pltozpl(LIST l,Q *cont,LIST *pp)
     LIST r;      LIST r;
   
     nd = BDY(l); n = length(nd);      nd = BDY(l); n = length(nd);
     pl = (P *)ALLOCA(n*sizeof(P));      pl = (P *)MALLOC(n*sizeof(P));
     cl = (Q *)ALLOCA(n*sizeof(P));      cl = (Q *)MALLOC(n*sizeof(P));
     for ( i = 0; i < n; i++, nd = NEXT(nd) )      for ( i = 0; i < n; i++, nd = NEXT(nd) )
         ptozp((P)BDY(nd),1,&cl[i],&dmy);          ptozp((P)BDY(nd),1,&cl[i],&dmy);
     qltozl(cl,n,&dvr);      qltozl(cl,n,&dvr);
Line 5254  ND ptond(VL vl,VL dvl,P p)
Line 5262  ND ptond(VL vl,VL dvl,P p)
         return r;          return r;
     } else {      } else {
         for ( dc = DC(p), k = 0; dc; dc = NEXT(dc), k++ );          for ( dc = DC(p), k = 0; dc; dc = NEXT(dc), k++ );
         w = (DCP *)ALLOCA(k*sizeof(DCP));          w = (DCP *)MALLOC(k*sizeof(DCP));
         for ( dc = DC(p), j = 0; j < k; dc = NEXT(dc), j++ ) w[j] = dc;          for ( dc = DC(p), j = 0; j < k; dc = NEXT(dc), j++ ) w[j] = dc;
         for ( i = 0, tvl = dvl, v = VR(p);          for ( i = 0, tvl = dvl, v = VR(p);
             tvl && tvl->v != v; tvl = NEXT(tvl), i++ );              tvl && tvl->v != v; tvl = NEXT(tvl), i++ );
Line 5336  LIST ndvtopl(int mod,VL vl,VL dvl,NDV p,int rank)
Line 5344  LIST ndvtopl(int mod,VL vl,VL dvl,NDV p,int rank)
   
     if ( !p ) return 0;      if ( !p ) return 0;
     else {      else {
         a = (P *)ALLOCA((rank+1)*sizeof(P));          a = (P *)MALLOC((rank+1)*sizeof(P));
         for ( i = 0; i <= rank; i++ ) a[i] = 0;          for ( i = 0; i <= rank; i++ ) a[i] = 0;
         len = LEN(p);          len = LEN(p);
         n = NV(p);          n = NV(p);
Line 5494  NODE ndv_reducebase(NODE x,int *perm)
Line 5502  NODE ndv_reducebase(NODE x,int *perm)
     NODE t,t0;      NODE t,t0;
   
     len = length(x);      len = length(x);
     w = (NDVI)ALLOCA(len*sizeof(struct oNDVI));      w = (NDVI)MALLOC(len*sizeof(struct oNDVI));
     for ( i = 0, t = x; i < len; i++, t = NEXT(t) ) {      for ( i = 0, t = x; i < len; i++, t = NEXT(t) ) {
         w[i].p = BDY(t); w[i].i = perm[i];          w[i].p = BDY(t); w[i].i = perm[i];
     }      }
Line 5842  int nd_nm_to_vect_2(UINT *s0,int n,int *s0hash,NDV p,N
Line 5850  int nd_nm_to_vect_2(UINT *s0,int n,int *s0hash,NDV p,N
   
     d = DL(m);      d = DL(m);
     len = LEN(p);      len = LEN(p);
     t = (UINT *)ALLOCA(nd_wpd*sizeof(UINT));      t = (UINT *)MALLOC(nd_wpd*sizeof(UINT));
     for ( i = j = 0, s = s0, mr = BDY(p); j < len; j++, NMV_ADV(mr) ) {      for ( i = j = 0, s = s0, mr = BDY(p); j < len; j++, NMV_ADV(mr) ) {
         ndl_add(d,DL(mr),t);          ndl_add(d,DL(mr),t);
                 h = ndl_hash_value(t);                  h = ndl_hash_value(t);
Line 5867  Q *nm_ind_pair_to_vect(int mod,UINT *s0,int n,NM_ind_p
Line 5875  Q *nm_ind_pair_to_vect(int mod,UINT *s0,int n,NM_ind_p
     p = nd_ps[pair->index];      p = nd_ps[pair->index];
     len = LEN(p);      len = LEN(p);
     r = (Q *)CALLOC(n,sizeof(Q));      r = (Q *)CALLOC(n,sizeof(Q));
     t = (UINT *)ALLOCA(nd_wpd*sizeof(UINT));      t = (UINT *)MALLOC(nd_wpd*sizeof(UINT));
     for ( i = j = 0, s = s0, mr = BDY(p); j < len; j++, NMV_ADV(mr) ) {      for ( i = j = 0, s = s0, mr = BDY(p); j < len; j++, NMV_ADV(mr) ) {
         ndl_add(d,DL(mr),t);          ndl_add(d,DL(mr),t);
         for ( ; !ndl_equal(t,s); s += nd_wpd, i++ );          for ( ; !ndl_equal(t,s); s += nd_wpd, i++ );
Line 5876  Q *nm_ind_pair_to_vect(int mod,UINT *s0,int n,NM_ind_p
Line 5884  Q *nm_ind_pair_to_vect(int mod,UINT *s0,int n,NM_ind_p
     return r;      return r;
 }  }
   
 IndArray nm_ind_pair_to_vect_compress(int mod,UINT *s0,int n,int *s0hash,NM_ind_pair pair)  IndArray nm_ind_pair_to_vect_compress(int trace,UINT *s0,int n,int *s0hash,NM_ind_pair pair)
 {  {
     NM m;      NM m;
     NMV mr;      NMV mr;
Line 5891  struct oEGT eg0,eg1;
Line 5899  struct oEGT eg0,eg1;
   
     m = pair->mul;      m = pair->mul;
     d = DL(m);      d = DL(m);
     p = nd_demand?nd_ps_sym[pair->index]:nd_ps[pair->index];      if ( trace )
         p = nd_demand?nd_ps_trace_sym[pair->index]:nd_ps_trace[pair->index];
       else
         p = nd_demand?nd_ps_sym[pair->index]:nd_ps[pair->index];
   
     len = LEN(p);      len = LEN(p);
     t = (UINT *)ALLOCA(nd_wpd*sizeof(UINT));      t = (UINT *)MALLOC(nd_wpd*sizeof(UINT));
     v = (unsigned int *)ALLOCA(len*sizeof(unsigned int));      v = (unsigned int *)MALLOC(len*sizeof(unsigned int));
 get_eg(&eg0);  get_eg(&eg0);
     for ( i = j = 0, s = s0, mr = BDY(p); j < len; j++, NMV_ADV(mr) ) {      for ( i = j = 0, s = s0, mr = BDY(p); j < len; j++, NMV_ADV(mr) ) {
         ndl_add(d,DL(mr),t);          ndl_add(d,DL(mr),t);
Line 5964  int ndv_reduce_vect_q(Q *svect,int trace,int col,IndAr
Line 5976  int ndv_reduce_vect_q(Q *svect,int trace,int col,IndAr
     for ( i = 0; i < col && !svect[i]; i++ );      for ( i = 0; i < col && !svect[i]; i++ );
     if ( i == col ) return maxrs;      if ( i == col ) return maxrs;
     hmag = p_mag((P)svect[i])*nd_scale;      hmag = p_mag((P)svect[i])*nd_scale;
     cvect = (Q *)ALLOCA(col*sizeof(Q));      cvect = (Q *)MALLOC(col*sizeof(Q));
     for ( i = 0; i < nred; i++ ) {      for ( i = 0; i < nred; i++ ) {
         ivect = imat[i];          ivect = imat[i];
         k = ivect->head;          k = ivect->head;
Line 6599  int nd_symbolic_preproc(PGeoBucket bucket,int trace,UI
Line 6611  int nd_symbolic_preproc(PGeoBucket bucket,int trace,UI
     NM_ind_pair pair;      NM_ind_pair pair;
     ND red;      ND red;
     NDV *ps;      NDV *ps;
       static int afo;
   
     s0 = 0; rp0 = 0; col = 0;      s0 = 0; rp0 = 0; col = 0;
         if ( nd_demand )          if ( nd_demand )
Line 6616  int nd_symbolic_preproc(PGeoBucket bucket,int trace,UI
Line 6629  int nd_symbolic_preproc(PGeoBucket bucket,int trace,UI
             h = nd_psh[index];              h = nd_psh[index];
             NEWNM(mul);              NEWNM(mul);
             ndl_sub(DL(head),DL(h),DL(mul));              ndl_sub(DL(head),DL(h),DL(mul));
             if ( ndl_check_bound2(index,DL(mul)) ) return 0;              if ( ndl_check_bound2(index,DL(mul)) )
                   return 0;
             sugar = TD(DL(mul))+SG(ps[index]);              sugar = TD(DL(mul))+SG(ps[index]);
             MKNM_ind_pair(pair,mul,index,sugar);              MKNM_ind_pair(pair,mul,index,sugar);
             red = ndv_mul_nm_symbolic(mul,ps[index]);              red = ndv_mul_nm_symbolic(mul,ps[index]);
Line 6856  NODE nd_f4_trace(int m,int **indp)
Line 6870  NODE nd_f4_trace(int m,int **indp)
     return g;      return g;
 }  }
   
 NODE nd_f4_pseudo_trace(int m,int **indp)  
 {  
     int i,nh,stat,index;  
     NODE r,g;  
     ND_pairs d,l,l0,t;  
     ND spol,red;  
     NDV nf,redv,nfqv,nfv;  
     NM s0,s;  
     NODE rp0,srp0,nflist;  
     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;  
     PGeoBucket bucket;  
     struct oEGT eg0,eg1,eg_f4;  
   
     g = 0; d = 0;  
     for ( i = 0; i < nd_psn; i++ ) {  
         d = update_pairs(d,g,i,0);  
         g = update_base(g,i);  
     }  
     while ( d ) {  
         get_eg(&eg0);  
         l = nd_minsugarp(d,&d);  
         sugar = SG(l);  
         bucket = create_pbucket();  
         stat = nd_sp_f4(m,0,l,bucket);  
         if ( !stat ) {  
             for ( t = l; NEXT(t); t = NEXT(t) );  
             NEXT(t) = d; d = l;  
             d = nd_reconstruct(1,d);  
             continue;  
         }  
         if ( bucket->m < 0 ) continue;  
         col = nd_symbolic_preproc(bucket,0,&s0vect,&rp0);  
         if ( !col ) {  
             for ( t = l; NEXT(t); t = NEXT(t) );  
             NEXT(t) = d; d = l;  
             d = nd_reconstruct(1,d);  
             continue;  
         }  
         get_eg(&eg1); init_eg(&eg_f4); add_eg(&eg_f4,&eg0,&eg1);  
         if ( DP_Print )  
             fprintf(asir_out,"sugar=%d,symb=%fsec,",  
                 sugar,eg_f4.exectime+eg_f4.gctime);  
         nflist = nd_f4_red(m,l,0,s0vect,col,rp0,&l0);  
         if ( !l0 ) continue;  
         l = l0;  
   
         /* over Q */  
                 while ( 1 ) {  
                 bucket = create_pbucket();  
                 stat = nd_sp_f4(0,1,l,bucket);  
                 if ( !stat ) {  
                 for ( t = l; NEXT(t); t = NEXT(t) );  
                 NEXT(t) = d; d = l;  
                 d = nd_reconstruct(1,d);  
                 continue;  
                 }  
                 if ( bucket->m < 0 ) continue;  
                 col = nd_symbolic_preproc(bucket,1,&s0vect,&rp0);  
                 if ( !col ) {  
                 for ( t = l; NEXT(t); t = NEXT(t) );  
                 NEXT(t) = d; d = l;  
                 d = nd_reconstruct(1,d);  
                 continue;  
                 }  
                 nflist = nd_f4_red(0,l,1,s0vect,col,rp0,0);  
                 }  
   
         /* adding new bases */  
         for ( r = nflist; r; r = NEXT(r) ) {  
             nfqv = (NDV)BDY(r);  
             ndv_removecont(0,nfqv);  
             if ( !rem(NM(HCQ(nfqv)),m) ) return 0;  
             if ( nd_nalg ) {  
                 ND nf1;  
   
                 nf1 = ndvtond(m,nfqv);  
                 nd_monic(0,&nf1);  
                 nd_removecont(0,nf1);  
                 nfqv = ndtondv(0,nf1); nd_free(nf1);  
             }  
             nfv = ndv_dup(0,nfqv);  
             ndv_mod(m,nfv);  
             ndv_removecont(m,nfv);  
             nh = ndv_newps(0,nfv,nfqv,1);  
             d = update_pairs(d,g,nh,0);  
             g = update_base(g,nh);  
         }  
     }  
 #if 0  
     fprintf(asir_out,"ndv_alloc=%d\n",ndv_alloc);  
 #endif  
         conv_ilist(0,1,g,indp);  
     return g;  
 }  
   
 int rref(matrix mat,int *sugar)  int rref(matrix mat,int *sugar)
 {  {
   int row,col,i,j,k,l,s,wcol,wj;    int row,col,i,j,k,l,s,wcol,wj;
Line 7041  void red_by_vect_2(matrix mat,int *sugar,unsigned long
Line 6952  void red_by_vect_2(matrix mat,int *sugar,unsigned long
   row = mat->row;    row = mat->row;
   col = mat->col;    col = mat->col;
   wcol = (col+BLEN-1)/BLEN;    wcol = (col+BLEN-1)/BLEN;
   pos = (int *)ALLOCA(wcol*sizeof(int));    pos = (int *)MALLOC(wcol*sizeof(int));
   bzero(pos,wcol*sizeof(int));    bzero(pos,wcol*sizeof(int));
   for ( i = j = 0; i < wcol; i++ )    for ( i = j = 0; i < wcol; i++ )
     if ( v[i] ) pos[j++] = i;;      if ( v[i] ) pos[j++] = i;;
Line 7081  init_eg(&eg_search);
Line 6992  init_eg(&eg_search);
     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 *)ALLOCA(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 *)ALLOCA(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) ) {
                 nd_sp(2,0,sp,&spol);                  nd_sp(2,0,sp,&spol);
                 if ( spol ) {                  if ( spol ) {
Line 7146  NODE nd_f4_red(int m,ND_pairs sp0,int trace,UINT *s0ve
Line 7057  NODE nd_f4_red(int m,ND_pairs sp0,int trace,UINT *s0ve
 init_eg(&eg_search);  init_eg(&eg_search);
     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);
     imat = (IndArray *)ALLOCA(nred*sizeof(IndArray));      imat = (IndArray *)MALLOC(nred*sizeof(IndArray));
     rhead = (int *)ALLOCA(col*sizeof(int));      rhead = (int *)MALLOC(col*sizeof(int));
     for ( i = 0; i < col; i++ ) rhead[i] = 0;      for ( i = 0; i < col; i++ ) rhead[i] = 0;
   
     /* construction of index arrays */      /* construction of index arrays */
     if ( DP_Print ) {      if ( DP_Print ) {
           fprintf(stderr,"%dx%d,",nsp+nred,col);            fprintf(stderr,"%dx%d,",nsp+nred,col);
     }      }
     rvect = (NM_ind_pair *)ALLOCA(nred*sizeof(NM_ind_pair));      rvect = (NM_ind_pair *)MALLOC(nred*sizeof(NM_ind_pair));
     s0hash = (int *)ALLOCA(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);
     for ( rp = rp0, i = 0; rp; i++, rp = NEXT(rp) ) {      for ( rp = rp0, i = 0; rp; i++, rp = NEXT(rp) ) {
         rvect[i] = (NM_ind_pair)BDY(rp);          rvect[i] = (NM_ind_pair)BDY(rp);
         imat[i] = nm_ind_pair_to_vect_compress(m,s0vect,col,s0hash,rvect[i]);          imat[i] = nm_ind_pair_to_vect_compress(trace,s0vect,col,s0hash,rvect[i]);
         rhead[imat[i]->head] = 1;          rhead[imat[i]->head] = 1;
     }      }
     if ( m > 0 || m == -1 )      if ( m > 0 || m == -1 )
Line 7193  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
Line 7104  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
     spcol = col-nred;      spcol = col-nred;
     get_eg(&eg0);      get_eg(&eg0);
     /* elimination (1st step) */      /* elimination (1st step) */
     spmat = (int **)ALLOCA(nsp*sizeof(UINT *));      spmat = (int **)MALLOC(nsp*sizeof(UINT *));
     svect = (UINT *)ALLOCA(col*sizeof(UINT));      svect = (UINT *)MALLOC(col*sizeof(UINT));
     spsugar = (int *)ALLOCA(nsp*sizeof(int));      spsugar = (int *)MALLOC(nsp*sizeof(int));
     spactive = !nz?0:(ND_pairs *)ALLOCA(nsp*sizeof(ND_pairs));      spactive = !nz?0:(ND_pairs *)MALLOC(nsp*sizeof(ND_pairs));
     for ( a = sprow = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) {      for ( a = sprow = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) {
         nd_sp(m,0,sp,&spol);          nd_sp(m,0,sp,&spol);
         if ( !spol ) continue;          if ( !spol ) continue;
Line 7226  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
Line 7137  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
     for ( i = 0; i < nred; i++ ) GCFREE(imat[i]->index.c);      for ( i = 0; i < nred; i++ ) GCFREE(imat[i]->index.c);
   
     /* elimination (2nd step) */      /* elimination (2nd step) */
     colstat = (int *)ALLOCA(spcol*sizeof(int));      colstat = (int *)MALLOC(spcol*sizeof(int));
     if ( m == -1 )      if ( m == -1 )
         rank = nd_gauss_elim_sf(spmat,spsugar,sprow,spcol,m,colstat);          rank = nd_gauss_elim_sf(spmat,spsugar,sprow,spcol,m,colstat);
     else      else
Line 7279  NODE nd_f4_red_lf_main(int m,ND_pairs sp0,int nsp,int 
Line 7190  NODE nd_f4_red_lf_main(int m,ND_pairs sp0,int nsp,int 
     spcol = col-nred;      spcol = col-nred;
     get_eg(&eg0);      get_eg(&eg0);
     /* elimination (1st step) */      /* elimination (1st step) */
     spmat = (mpz_t **)ALLOCA(nsp*sizeof(mpz_t *));      spmat = (mpz_t **)MALLOC(nsp*sizeof(mpz_t *));
     svect = (mpz_t *)ALLOCA(col*sizeof(mpz_t));      svect = (mpz_t *)MALLOC(col*sizeof(mpz_t));
     spsugar = (int *)ALLOCA(nsp*sizeof(int));      spsugar = (int *)MALLOC(nsp*sizeof(int));
     for ( a = sprow = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) {      for ( a = sprow = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) {
         nd_sp(m,trace,sp,&spol);          nd_sp(m,trace,sp,&spol);
         if ( !spol ) continue;          if ( !spol ) continue;
Line 7306  NODE nd_f4_red_lf_main(int m,ND_pairs sp0,int nsp,int 
Line 7217  NODE nd_f4_red_lf_main(int m,ND_pairs sp0,int nsp,int 
 /*    for ( i = 0; i < nred; i++ ) GCFREE(imat[i]->index.c); */  /*    for ( i = 0; i < nred; i++ ) GCFREE(imat[i]->index.c); */
   
     /* elimination (2nd step) */      /* elimination (2nd step) */
     colstat = (int *)ALLOCA(spcol*sizeof(int));      colstat = (int *)MALLOC(spcol*sizeof(int));
     rank = nd_gauss_elim_lf(spmat,spsugar,sprow,spcol,colstat);      rank = nd_gauss_elim_lf(spmat,spsugar,sprow,spcol,colstat);
     w = (pointer *)ALLOCA(rank*sizeof(pointer));      w = (pointer *)MALLOC(rank*sizeof(pointer));
     for ( i = 0; i < rank; i++ ) {      for ( i = 0; i < rank; i++ ) {
 #if 0  #if 0
         w[rank-i-1] = (pointer)vect_to_ndv_lf(spmat[i],spcol,col,rhead,s0vect);          w[rank-i-1] = (pointer)vect_to_ndv_lf(spmat[i],spcol,col,rhead,s0vect);
Line 7362  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,int trace,U
Line 7273  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,int trace,U
     spcol = col-nred;      spcol = col-nred;
     get_eg(&eg0);      get_eg(&eg0);
     /* elimination (1st step) */      /* elimination (1st step) */
     spmat = (Q **)ALLOCA(nsp*sizeof(Q *));      spmat = (Q **)MALLOC(nsp*sizeof(Q *));
     svect = (Q *)ALLOCA(col*sizeof(Q));      svect = (Q *)MALLOC(col*sizeof(Q));
     spsugar = (int *)ALLOCA(nsp*sizeof(int));      spsugar = (int *)MALLOC(nsp*sizeof(int));
     for ( a = sprow = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) {      for ( a = sprow = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) {
         nd_sp(0,trace,sp,&spol);          nd_sp(0,trace,sp,&spol);
         if ( !spol ) continue;          if ( !spol ) continue;
Line 7389  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,int trace,U
Line 7300  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,int trace,U
 /*    for ( i = 0; i < nred; i++ ) GCFREE(imat[i]->index.c); */  /*    for ( i = 0; i < nred; i++ ) GCFREE(imat[i]->index.c); */
   
     /* elimination (2nd step) */      /* elimination (2nd step) */
     colstat = (int *)ALLOCA(spcol*sizeof(int));      colstat = (int *)MALLOC(spcol*sizeof(int));
     rank = nd_gauss_elim_q(spmat,spsugar,sprow,spcol,colstat);      rank = nd_gauss_elim_q(spmat,spsugar,sprow,spcol,colstat);
     w = (pointer *)ALLOCA(rank*sizeof(pointer));      w = (pointer *)MALLOC(rank*sizeof(pointer));
     for ( i = 0; i < rank; i++ ) {      for ( i = 0; i < rank; i++ ) {
 #if 0  #if 0
         w[rank-i-1] = (pointer)vect_to_ndv_q(spmat[i],spcol,col,rhead,s0vect);          w[rank-i-1] = (pointer)vect_to_ndv_q(spmat[i],spcol,col,rhead,s0vect);
Line 7443  NODE nd_f4_red_gz_main(ND_pairs sp0,int nsp,int trace,
Line 7354  NODE nd_f4_red_gz_main(ND_pairs sp0,int nsp,int trace,
     spcol = col-nred;      spcol = col-nred;
     get_eg(&eg0);      get_eg(&eg0);
     /* elimination (1st step) */      /* elimination (1st step) */
     spmat = (GZ **)ALLOCA(nsp*sizeof(GZ *));      spmat = (GZ **)MALLOC(nsp*sizeof(GZ *));
     svect = (GZ *)ALLOCA(col*sizeof(GZ));      svect = (GZ *)MALLOC(col*sizeof(GZ));
     spsugar = (int *)ALLOCA(nsp*sizeof(int));      spsugar = (int *)MALLOC(nsp*sizeof(int));
     for ( a = sprow = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) {      for ( a = sprow = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) {
         nd_sp(0,trace,sp,&spol);          nd_sp(0,trace,sp,&spol);
         if ( !spol ) continue;          if ( !spol ) continue;
Line 7471  NODE nd_f4_red_gz_main(ND_pairs sp0,int nsp,int trace,
Line 7382  NODE nd_f4_red_gz_main(ND_pairs sp0,int nsp,int trace,
 /*    for ( i = 0; i < nred; i++ ) GCFREE(imat[i]->index.c); */  /*    for ( i = 0; i < nred; i++ ) GCFREE(imat[i]->index.c); */
   
     /* elimination (2nd step) */      /* elimination (2nd step) */
     colstat = (int *)ALLOCA(spcol*sizeof(int));      colstat = (int *)MALLOC(spcol*sizeof(int));
     rank = nd_gauss_elim_gz(spmat,spsugar,sprow,spcol,colstat);      rank = nd_gauss_elim_gz(spmat,spsugar,sprow,spcol,colstat);
     w = (pointer *)ALLOCA(rank*sizeof(pointer));      w = (pointer *)MALLOC(rank*sizeof(pointer));
     for ( i = 0; i < rank; i++ ) {      for ( i = 0; i < rank; i++ ) {
 #if 0  #if 0
         w[rank-i-1] = (pointer)vect_to_ndv_gz(spmat[i],spcol,col,rhead,s0vect);          w[rank-i-1] = (pointer)vect_to_ndv_gz(spmat[i],spcol,col,rhead,s0vect);
Line 7535  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vec
Line 7446  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vec
   
     row = nsp+nred;      row = nsp+nred;
     /* make the matrix */      /* make the matrix */
     mat = (Q **)ALLOCA(row*sizeof(Q *));      mat = (Q **)MALLOC(row*sizeof(Q *));
     sugar = (int *)ALLOCA(row*sizeof(int));      sugar = (int *)MALLOC(row*sizeof(int));
     for ( row = a = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) {      for ( row = a = 0, sp = sp0; a < nsp; a++, sp = NEXT(sp) ) {
         nd_sp(0,0,sp,&spol);          nd_sp(0,0,sp,&spol);
         if ( !spol ) continue;          if ( !spol ) continue;
Line 7550  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vec
Line 7461  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vec
         sugar[row] = rvect[i]->sugar;          sugar[row] = rvect[i]->sugar;
     }      }
     /* elimination */      /* elimination */
     colstat = (int *)ALLOCA(col*sizeof(int));      colstat = (int *)MALLOC(col*sizeof(int));
     rank = nd_gauss_elim_q(mat,sugar,row,col,colstat);      rank = nd_gauss_elim_q(mat,sugar,row,col,colstat);
     r0 = 0;      r0 = 0;
     for ( i = 0; i < rank; i++ ) {      for ( i = 0; i < rank; i++ ) {
Line 7642  NDV nd_recv_ndv()
Line 7553  NDV nd_recv_ndv()
     }      }
 }  }
   
 int ox_exec_f4_red(Q proc)  
 {  
     Obj obj;  
     STRING fname;  
     NODE arg;  
     int s;  
     extern int ox_need_conv,ox_file_io;  
   
     MKSTR(fname,"nd_exec_f4_red");  
     arg = mknode(2,proc,fname);  
     Pox_cmo_rpc(arg,&obj);  
     s = get_ox_server_id(QTOS(proc));  
     nd_write = iofp[s].out;  
     nd_read = iofp[s].in;  
     ox_need_conv = ox_file_io = 0;  
     return s;  
 }  
   
 #if 0  
 NODE nd_f4_red_dist(int m,ND_pairs sp0,UINT *s0vect,int col,NODE rp0,ND_pairs *nz)  
 {  
     int nsp,nred;  
     int i,rank,s;  
     NODE rp,r0,r;  
     ND_pairs sp;  
     NM_ind_pair pair;  
     NMV nmv;  
     NM nm;  
     NDV nf;  
     Obj proc,dmy;  
   
     ox_launch_main(0,0,&proc);  
     s = ox_exec_f4_red((Q)proc);  
   
     nd_send_int(m);  
     nd_send_int(nd_nvar);  
     nd_send_int(nd_bpe);  
     nd_send_int(nd_wpd);  
     nd_send_int(nmv_adv);  
   
     saveobj(nd_write,dp_current_spec->obj); fflush(nd_write);  
   
     nd_send_int(nd_psn);  
     for ( i = 0; i < nd_psn; i++ ) nd_send_ndv(nd_ps[i]);  
   
     for ( sp = sp0, nsp = 0; sp; sp = NEXT(sp), nsp++ );  
     nd_send_int(nsp);  
     for ( i = 0, sp = sp0; i < nsp; i++, sp = NEXT(sp) ) {  
         nd_send_int(sp->i1); nd_send_int(sp->i2);  
     }  
   
     nd_send_int(col); nd_send_intarray(s0vect,col*nd_wpd);  
   
     nred = length(rp0); nd_send_int(nred);  
     for ( i = 0, rp = rp0; i < nred; i++, rp = NEXT(rp) ) {  
         pair = (NM_ind_pair)BDY(rp);  
         nd_send_int(pair->index);  
         nd_send_intarray(pair->mul->dl,nd_wpd);  
     }  
     fflush(nd_write);  
     rank = nd_recv_int();  
     fprintf(asir_out,"rank=%d\n",rank);  
     r0 = 0;  
     for ( i = 0; i < rank; i++ ) {  
         nf = nd_recv_ndv();  
         NEXTNODE(r0,r); BDY(r) = (pointer)nf;  
     }  
     Pox_shutdown(mknode(1,proc),&dmy);  
     return r0;  
 }  
   
 /* server side */  
   
 void nd_exec_f4_red_dist()  
 {  
     int m,i,nsp,col,s0size,nred,spcol,j,k;  
     NM_ind_pair *rp0;  
     NDV nf;  
     UINT *s0vect;  
     IndArray *imat;  
     int *rhead;  
     int **spmat;  
     UINT *svect,*v;  
     ND_pairs *sp0;  
     int *colstat;  
     int a,sprow,rank;  
     struct order_spec *ord;  
     Obj ordspec;  
     ND spol;  
     int maxrs;  
     int *spsugar;  
   
     nd_read = iofp[0].in;  
     nd_write = iofp[0].out;  
     m = nd_recv_int();  
     nd_nvar = nd_recv_int();  
     nd_bpe = nd_recv_int();  
     nd_wpd = nd_recv_int();  
     nmv_adv = nd_recv_int();  
   
     loadobj(nd_read,&ordspec);  
     create_order_spec(0,ordspec,&ord);  
     nd_init_ord(ord);  
     nd_setup_parameters(nd_nvar,0);  
   
     nd_psn = nd_recv_int();  
     nd_ps = (NDV *)MALLOC(nd_psn*sizeof(NDV));  
     nd_bound = (UINT **)MALLOC(nd_psn*sizeof(UINT *));  
     for ( i = 0; i < nd_psn; i++ ) {  
         nd_ps[i] = nd_recv_ndv();  
         nd_bound[i] = ndv_compute_bound(nd_ps[i]);  
     }  
   
     nsp = nd_recv_int();  
     sp0 = (ND_pairs *)MALLOC(nsp*sizeof(ND_pairs));  
     for ( i = 0; i < nsp; i++ ) {  
         NEWND_pairs(sp0[i]);  
         sp0[i]->i1 = nd_recv_int(); sp0[i]->i2 = nd_recv_int();  
         ndl_lcm(HDL(nd_ps[sp0[i]->i1]),HDL(nd_ps[sp0[i]->i2]),LCM(sp0[i]));  
     }  
   
     col = nd_recv_int();  
     s0size = col*nd_wpd;  
     s0vect = (UINT *)MALLOC(s0size*sizeof(UINT));  
     nd_recv_intarray(s0vect,s0size);  
   
     nred = nd_recv_int();  
     rp0 = (NM_ind_pair *)MALLOC(nred*sizeof(NM_ind_pair));  
     for ( i = 0; i < nred; i++ ) {  
         rp0[i] = (NM_ind_pair)MALLOC(sizeof(struct oNM_ind_pair));  
         rp0[i]->index = nd_recv_int();  
         rp0[i]->mul = (NM)MALLOC(sizeof(struct oNM)+(nd_wpd-1)*sizeof(UINT));  
         nd_recv_intarray(rp0[i]->mul->dl,nd_wpd);  
     }  
   
     spcol = col-nred;  
     imat = (IndArray *)MALLOC(nred*sizeof(IndArray));  
     rhead = (int *)MALLOC(col*sizeof(int));  
     for ( i = 0; i < col; i++ ) rhead[i] = 0;  
   
     /* construction of index arrays */  
     for ( i = 0; i < nred; i++ ) {  
         imat[i] = nm_ind_pair_to_vect_compress(m,s0vect,col,rp0[i]);  
         rhead[imat[i]->head] = 1;  
     }  
   
     /* elimination (1st step) */  
     spmat = (int **)MALLOC(nsp*sizeof(UINT *));  
     svect = (UINT *)MALLOC(col*sizeof(UINT));  
     spsugar = (int *)ALLOCA(nsp*sizeof(int));  
     for ( a = sprow = 0; a < nsp; a++ ) {  
         nd_sp(m,0,sp0[a],&spol);  
         if ( !spol ) continue;  
         nd_to_vect(m,s0vect,col,spol,svect);  
         if ( m == -1 )  
             maxrs = ndv_reduce_vect_sf(m,svect,col,imat,rp0,nred);  
         else  
             maxrs = ndv_reduce_vect(m,svect,col,imat,rp0,nred);  
         for ( i = 0; i < col; i++ ) if ( svect[i] ) break;  
         if ( i < col ) {  
             spmat[sprow] = v = (UINT *)MALLOC(spcol*sizeof(UINT));  
             for ( j = k = 0; j < col; j++ )  
                 if ( !rhead[j] ) v[k++] = svect[j];  
             spsugar[sprow] = MAX(maxrs,SG(spol));  
             sprow++;  
         }  
         nd_free(spol);  
     }  
     /* elimination (2nd step) */  
     colstat = (int *)ALLOCA(spcol*sizeof(int));  
     if ( m == -1 )  
         rank = nd_gauss_elim_sf(spmat,spsugar,sprow,spcol,m,colstat);  
     else  
         rank = nd_gauss_elim_mod(spmat,spsugar,0,sprow,spcol,m,colstat);  
     nd_send_int(rank);  
     for ( i = 0; i < rank; i++ ) {  
         nf = vect_to_ndv(spmat[i],spcol,col,rhead,s0vect);  
         nd_send_ndv(nf);  
     }  
     fflush(nd_write);  
 }  
 #endif  
   
 int nd_gauss_elim_q(Q **mat0,int *sugar,int row,int col,int *colstat)  int nd_gauss_elim_q(Q **mat0,int *sugar,int row,int col,int *colstat)
 {  {
     int i,j,t,c,rank,inv;      int i,j,t,c,rank,inv;
Line 8849  MAT nd_btog(LIST f,LIST v,int mod,struct order_spec *o
Line 8577  MAT nd_btog(LIST f,LIST v,int mod,struct order_spec *o
         printf("%d ",i); fflush(stdout);          printf("%d ",i); fflush(stdout);
     ti = BDY((LIST)BDY(t));      ti = BDY((LIST)BDY(t));
     p[j=QTOS((Q)ARG0(ti))] = btog(BDY((LIST)ARG1(ti)),p,nb,mod);      p[j=QTOS((Q)ARG0(ti))] = btog(BDY((LIST)ARG1(ti)),p,nb,mod);
     if ( j == 441 )  
                 printf("afo");  
   }    }
   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=QTOS((Q)ARG0(ti))] = btog(BDY((LIST)ARG1(ti)),p,nb,mod);      p[j=QTOS((Q)ARG0(ti))] = btog(BDY((LIST)ARG1(ti)),p,nb,mod);
     if ( j == 441 )  
                 printf("afo");  
   }    }
   m = length(ind);    m = length(ind);
   MKMAT(mat,nb,m);    MKMAT(mat,nb,m);
Line 9012  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
Line 8736  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
     nocheck = 0;      nocheck = 0;
     mindex = 0;      mindex = 0;
   
     if ( Demand ) nd_demand = 1;      /* do not use on-demand load/save */
     else nd_demand = 0;      nd_demand = 0;
   
     /* setup modulus */  
     if ( trace < 0 ) {  
         trace = -trace;  
         nocheck = 1;  
     }  
     m = trace > 1 ? trace : get_lprime(mindex);      m = trace > 1 ? trace : get_lprime(mindex);
     nd_init_ord(ord);      nd_init_ord(ord);
     mrank = 0;      mrank = 0;
Line 9070  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
Line 8788  void nd_f4_lf_trace(LIST f,LIST v,int trace,int homo,s
             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;
     while ( 1 ) {      ret = ndv_setup(-2,m,fd0,nd_gbblock?1:0,0);
         if ( Demand )      if ( ret )
             nd_demand = 1;        cand = nd_f4_lf_trace_main(m,&perm);
         ret = ndv_setup(-2,m,fd0,nd_gbblock?1:0,0);      if ( !ret || !cand ) {
         if ( ret )         *rp = 0; return;
           cand = nd_f4_lf_trace_main(m,&perm);  
         if ( !ret || !cand ) {  
             /* failure */  
             if ( trace > 1 ) { *rp = 0; return; }  
             else m = get_lprime(++mindex);  
             continue;  
         }  
         if ( !ishomo && homo ) {  
             /* dehomogenization */  
             for ( t = cand; t; t = NEXT(t) ) ndv_dehomogenize((NDV)BDY(t),ord);  
             nd_init_ord(ord);  
             nd_setup_parameters(nvar,0);  
         }  
         nd_demand = 0;  
         cand = ndv_reducebase(cand,perm);  
         cand = ndv_reduceall(-2,cand);  
         cbpe = nd_bpe;  
         get_eg(&eg0);  
         if ( nocheck )  
             break;  
         if ( ret = ndv_check_membership(-2,in0,obpe,oadv,oepos,cand) ) {  
             /* gbcheck : cand is a GB of Id(cand) ? */  
             ret = nd_f4(-2,0,0);  
                 }  
                 if ( ret ) break;  
         else if ( trace > 1 ) {  
             /* failure */  
             *rp = 0; return;  
         } else {  
             /* try the next modulus */  
             m = get_lprime(++mindex);  
             /* reset the parameters */  
             if ( !ishomo && homo ) {  
                 nd_init_ord(ord1);  
                 nd_setup_parameters(nvar+1,wmax);  
             } else {  
                 nd_init_ord(ord);  
                 nd_setup_parameters(nvar,max);  
             }  
         }  
     }      }
       if ( !ishomo && homo ) {
         /* dehomogenization */
         for ( t = cand; t; t = NEXT(t) ) ndv_dehomogenize((NDV)BDY(t),ord);
         nd_init_ord(ord);
         nd_setup_parameters(nvar,0);
       }
       cand = ndv_reducebase(cand,perm);
       cand = ndv_reduceall(-2,cand);
       cbpe = nd_bpe;
       get_eg(&eg0);
       if ( ret = ndv_check_membership(-2,in0,obpe,oadv,oepos,cand) ) {
         /* gbcheck : cand is a GB of Id(cand) ? */
         ret = nd_f4(-2,0,0);
       }
           if ( !ret ) {
         /* 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=%fsec\n",eg_check.exectime+eg_check.gctime);          fprintf(asir_out,"check=%fsec\n",eg_check.exectime+eg_check.gctime);

Legend:
Removed from v.1.234  
changed lines
  Added in v.1.235

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