[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.130 and 1.143

version 1.130, 2006/05/30 07:35:31 version 1.143, 2006/08/09 02:48:49
Line 1 
Line 1 
 /* $OpenXM: OpenXM_contrib2/asir2000/engine/nd.c,v 1.129 2006/04/17 04:35:20 noro Exp $ */  /* $OpenXM$ */
   
 #include "nd.h"  #include "nd.h"
   
   int diag_period = 6;
 int (*ndl_compare_function)(UINT *a1,UINT *a2);  int (*ndl_compare_function)(UINT *a1,UINT *a2);
 int nd_dcomp;  int nd_dcomp;
 NM _nm_free_list;  NM _nm_free_list;
Line 1591  NODE nd_gb(int m,int ishomo,int checkonly)
Line 1592  NODE nd_gb(int m,int ishomo,int checkonly)
         NDV nfv;          NDV nfv;
         Q q,num,den;          Q q,num,den;
         union oNDC dn;          union oNDC dn;
           int diag_count = 0;
   
         g = 0; d = 0;          g = 0; d = 0;
         for ( i = 0; i < nd_psn; i++ ) {          for ( i = 0; i < nd_psn; i++ ) {
Line 1603  again:
Line 1605  again:
                 l = nd_minp(d,&d);                  l = nd_minp(d,&d);
                 if ( SG(l) != sugar ) {                  if ( SG(l) != sugar ) {
                         if ( ishomo ) {                          if ( ishomo ) {
                                   diag_count = 0;
                                 stat = do_diagonalize(sugar,m);                                  stat = do_diagonalize(sugar,m);
                                 if ( !stat ) {                                  if ( !stat ) {
                                         NEXT(l) = d; d = l;                                          NEXT(l) = d; d = l;
Line 1638  again:
Line 1641  again:
                         }                          }
                         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);
                           if ( !m && (ishomo && ++diag_count == diag_period) ) {
                                   diag_count = 0;
                                   stat = do_diagonalize(sugar,m);
                                   if ( !stat ) {
                                           NEXT(l) = d; d = l;
                                           d = nd_reconstruct(1,d);
                                           goto again;
                                   }
                           }
                         d = update_pairs(d,g,nh);                          d = update_pairs(d,g,nh);
                         g = update_base(g,nh);                          g = update_base(g,nh);
                         FREENDP(l);                          FREENDP(l);
Line 1707  int do_diagonalize_trace(int sugar,int m)
Line 1719  int do_diagonalize_trace(int sugar,int m)
   
 static struct oEGT eg_invdalg;  static struct oEGT eg_invdalg;
 struct oEGT eg_le;  struct oEGT eg_le;
 int diag_period = 6;  
   
 NODE nd_gb_trace(int m,int ishomo)  NODE nd_gb_trace(int m,int ishomo)
 {  {
Line 2208  void ndv_setup(int mod,int trace,NODE f,int dont_sort)
Line 2219  void ndv_setup(int mod,int trace,NODE f,int dont_sort)
         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 = (NDV *)ALLOCA(nd_psn*sizeof(NDV));          w = (NDV *)ALLOCA(nd_psn*sizeof(NDV));
         for ( i = 0, s = f; s; s = NEXT(s) ) if ( BDY(s) ) w[i++] = BDY(s);          for ( i = 0, s = f; s; s = NEXT(s) ) if ( BDY(s) ) w[i++] = BDY(s);
         if ( !dont_sort )          if ( !dont_sort ) {
                 qsort(w,nd_psn,sizeof(NDV),                  /* XXX heuristic */
                         (int (*)(const void *,const void *))ndv_compare);                  if ( !nd_ord->id && (nd_ord->ord.simple<2) )
                           qsort(w,nd_psn,sizeof(NDV),
                                   (int (*)(const void *,const void *))ndv_compare_rev);
                   else
                           qsort(w,nd_psn,sizeof(NDV),
                                   (int (*)(const void *,const void *))ndv_compare);
           }
         nd_pslen = 2*nd_psn;          nd_pslen = 2*nd_psn;
         nd_ps = (NDV *)MALLOC(nd_pslen*sizeof(NDV));          nd_ps = (NDV *)MALLOC(nd_pslen*sizeof(NDV));
         nd_ps_trace = (NDV *)MALLOC(nd_pslen*sizeof(NDV));          nd_ps_trace = (NDV *)MALLOC(nd_pslen*sizeof(NDV));
Line 2510  void nd_gr_postproc(LIST f,LIST v,int m,struct order_s
Line 2527  void nd_gr_postproc(LIST f,LIST v,int m,struct order_s
         MKLIST(*rp,r0);          MKLIST(*rp,r0);
 }  }
   
 void nd_gr_trace(LIST f,LIST v,int trace,int homo,struct order_spec *ord,LIST *rp)  void nd_gr_trace(LIST f,LIST v,int trace,int homo,int f4,struct order_spec *ord,LIST *rp)
 {  {
         VL tv,fv,vv,vc,av;          VL tv,fv,vv,vc,av;
         NODE fd,fd0,in0,in,r,r0,t,s,cand,alist;          NODE fd,fd0,in0,in,r,r0,t,s,cand,alist;
Line 2598  void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru
Line 2615  void nd_gr_trace(LIST f,LIST v,int trace,int homo,stru
                 if ( Demand )                  if ( Demand )
                         nd_demand = 1;                          nd_demand = 1;
                 ndv_setup(m,1,fd0,0);                  ndv_setup(m,1,fd0,0);
                 cand = nd_gb_trace(m,ishomo || homo);                  cand = f4?nd_f4_trace(m):nd_gb_trace(m,ishomo || homo);
                 if ( !cand ) {                  if ( !cand ) {
                         /* failure */                          /* failure */
                         if ( trace > 1 ) { *rp = 0; return; }                          if ( trace > 1 ) { *rp = 0; return; }
Line 4168  IndArray nm_ind_pair_to_vect_compress(int mod,UINT *s0
Line 4185  IndArray nm_ind_pair_to_vect_compress(int mod,UINT *s0
         return r;          return r;
 }  }
   
   int compress_array(Q *svect,Q *cvect,int n)
   {
           int i,j;
   
 int ndv_reduce_vect_q(Q *svect,int col,IndArray *imat,NM_ind_pair *rp0,int nred)          for ( i = j = 0; i < n; i++ )
                   if ( svect[i] ) cvect[j++] = svect[i];
           return j;
   }
   
   void expand_array(Q *svect,Q *cvect,int n)
 {  {
         int i,j,k,len,pos,prev;          int i,j;
   
           for ( i = j = 0; j < n;  i++  )
                   if ( svect[i] ) svect[i] = cvect[j++];
   }
   
   int ndv_reduce_vect_q(Q *svect,int trace,int col,IndArray *imat,NM_ind_pair *rp0,int nred)
   {
           int i,j,k,len,pos,prev,nz;
         Q cs,mcs,c1,c2,cr,gcd,t;          Q cs,mcs,c1,c2,cr,gcd,t;
         IndArray ivect;          IndArray ivect;
         unsigned char *ivc;          unsigned char *ivc;
Line 4181  int ndv_reduce_vect_q(Q *svect,int col,IndArray *imat,
Line 4214  int ndv_reduce_vect_q(Q *svect,int col,IndArray *imat,
         NMV mr;          NMV mr;
         NODE rp;          NODE rp;
         int maxrs;          int maxrs;
           double hmag;
           Q *cvect;
   
         maxrs = 0;          maxrs = 0;
           for ( i = 0; i < col && !svect[i]; i++ );
           if ( i == col ) return maxrs;
           hmag = p_mag((P)svect[i])*nd_scale;
           cvect = (Q *)ALLOCA(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;
                 if ( svect[k] ) {                  if ( svect[k] ) {
                         maxrs = MAX(maxrs,rp0[i]->sugar);                          maxrs = MAX(maxrs,rp0[i]->sugar);
                         redv = nd_ps[rp0[i]->index];                          redv = trace?nd_ps_trace[rp0[i]->index]:nd_ps[rp0[i]->index];
                         len = LEN(redv); mr = BDY(redv);                          len = LEN(redv); mr = BDY(redv);
                         igcd_cofactor(svect[k],CQ(mr),&gcd,&cs,&cr);                          igcd_cofactor(svect[k],CQ(mr),&gcd,&cs,&cr);
                         chsgnq(cs,&mcs);                          chsgnq(cs,&mcs);
Line 4221  int ndv_reduce_vect_q(Q *svect,int col,IndArray *imat,
Line 4260  int ndv_reduce_vect_q(Q *svect,int col,IndArray *imat,
                                         }                                          }
                                         break;                                          break;
                         }                          }
                           for ( j = k+1; j < col && !svect[j]; j++ );
                           if ( j == col ) break;
                           if ( hmag && ((double)p_mag((P)svect[j]) > hmag) ) {
                                   nz = compress_array(svect,cvect,col);
                                   removecont_array(cvect,nz);
                                   expand_array(svect,cvect,nz);
                                   hmag = ((double)p_mag((P)svect[j]))*nd_scale;
                           }
                 }                  }
         }          }
           nz = compress_array(svect,cvect,col);
           removecont_array(cvect,nz);
           expand_array(svect,cvect,nz);
           if ( DP_Print ) {
                   fprintf(asir_out,"-"); fflush(asir_out);
           }
         return maxrs;          return maxrs;
 }  }
   
Line 4427  NDV plain_vect_to_ndv_q(Q *vect,int col,UINT *s0vect)
Line 4480  NDV plain_vect_to_ndv_q(Q *vect,int col,UINT *s0vect)
         }          }
 }  }
   
 int nd_sp_f4(int m,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;          NODE sp0,sp;
Line 4435  int nd_sp_f4(int m,ND_pairs l,PGeoBucket bucket)
Line 4488  int nd_sp_f4(int m,ND_pairs l,PGeoBucket bucket)
         ND spol;          ND spol;
   
         for ( t = l; t; t = NEXT(t) ) {          for ( t = l; t; t = NEXT(t) ) {
                 stat = nd_sp(m,0,t,&spol);                  stat = nd_sp(m,trace,t,&spol);
                 if ( !stat ) return 0;                  if ( !stat ) return 0;
                 if ( spol ) {                  if ( spol ) {
                         add_pbucket_symbolic(bucket,spol);                          add_pbucket_symbolic(bucket,spol);
Line 4444  int nd_sp_f4(int m,ND_pairs l,PGeoBucket bucket)
Line 4497  int nd_sp_f4(int m,ND_pairs l,PGeoBucket bucket)
         return 1;          return 1;
 }  }
   
 int nd_symbolic_preproc(PGeoBucket bucket,UINT **s0vect,NODE *r)  int nd_symbolic_preproc(PGeoBucket bucket,int trace,UINT **s0vect,NODE *r)
 {  {
         NODE rp0,rp;          NODE rp0,rp;
         NM mul,head,s0,s;          NM mul,head,s0,s;
Line 4453  int nd_symbolic_preproc(PGeoBucket bucket,UINT **s0vec
Line 4506  int nd_symbolic_preproc(PGeoBucket bucket,UINT **s0vec
         UINT *s0v,*p;          UINT *s0v,*p;
         NM_ind_pair pair;          NM_ind_pair pair;
         ND red;          ND red;
           NDV *ps;
   
         s0 = 0; rp0 = 0; col = 0;          s0 = 0; rp0 = 0; col = 0;
           ps = trace?nd_ps_trace:nd_ps;
         while ( 1 ) {          while ( 1 ) {
                 head = remove_head_pbucket_symbolic(bucket);                  head = remove_head_pbucket_symbolic(bucket);
                 if ( !head ) break;                  if ( !head ) break;
Line 4467  int nd_symbolic_preproc(PGeoBucket bucket,UINT **s0vec
Line 4522  int nd_symbolic_preproc(PGeoBucket bucket,UINT **s0vec
                         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(nd_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,nd_ps[index]);                          red = ndv_mul_nm_symbolic(mul,ps[index]);
                         add_pbucket_symbolic(bucket,nd_remove_head(red));                          add_pbucket_symbolic(bucket,nd_remove_head(red));
                         NEXTNODE(rp0,rp); BDY(rp) = (pointer)pair;                          NEXTNODE(rp0,rp); BDY(rp) = (pointer)pair;
                 }                  }
Line 4519  NODE nd_f4(int m)
Line 4574  NODE nd_f4(int m)
                 l = nd_minsugarp(d,&d);                  l = nd_minsugarp(d,&d);
                 sugar = SG(l);                  sugar = SG(l);
                 bucket = create_pbucket();                  bucket = create_pbucket();
                 stat = nd_sp_f4(m,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;
Line 4527  NODE nd_f4(int m)
Line 4582  NODE nd_f4(int m)
                         continue;                          continue;
                 }                  }
                 if ( bucket->m < 0 ) continue;                  if ( bucket->m < 0 ) continue;
                 col = nd_symbolic_preproc(bucket,&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;
Line 4539  NODE nd_f4(int m)
Line 4594  NODE nd_f4(int m)
                         fprintf(asir_out,"sugar=%d,symb=%fsec,",                          fprintf(asir_out,"sugar=%d,symb=%fsec,",
                                 sugar,eg_f4.exectime+eg_f4.gctime);                                  sugar,eg_f4.exectime+eg_f4.gctime);
                 if ( 1 )                  if ( 1 )
                         nflist = nd_f4_red(m,l,s0vect,col,rp0);                          nflist = nd_f4_red(m,l,0,s0vect,col,rp0,0);
                 else                  else
                         nflist = nd_f4_red_dist(m,l,s0vect,col,rp0);                          nflist = nd_f4_red_dist(m,l,s0vect,col,rp0,0);
                 /* adding new bases */                  /* adding new bases */
                 for ( r = nflist; r; r = NEXT(r) ) {                  for ( r = nflist; r; r = NEXT(r) ) {
                         nf = (NDV)BDY(r);                          nf = (NDV)BDY(r);
Line 4566  NODE nd_f4(int m)
Line 4621  NODE nd_f4(int m)
         return g;          return g;
 }  }
   
 NODE nd_f4_red(int m,ND_pairs sp0,UINT *s0vect,int col,NODE rp0)  NODE nd_f4_trace(int m)
 {  {
           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;          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);
                   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 */
                   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);
                           d = update_pairs(d,g,nh);
                           g = update_base(g,nh);
                   }
           }
           for ( r = g; r; r = NEXT(r) ) BDY(r) = (pointer)nd_ps_trace[(int)BDY(r)];
   #if 0
           fprintf(asir_out,"ndv_alloc=%d\n",ndv_alloc);
   #endif
           return g;
   }
   
   NODE nd_f4_red(int m,ND_pairs sp0,int trace,UINT *s0vect,int col,NODE rp0,ND_pairs *nz)
   {
           IndArray *imat;
         int nsp,nred,i;          int nsp,nred,i;
         int *rhead;          int *rhead;
         NODE r0,rp;          NODE r0,rp;
Line 4589  NODE nd_f4_red(int m,ND_pairs sp0,UINT *s0vect,int col
Line 4744  NODE nd_f4_red(int m,ND_pairs sp0,UINT *s0vect,int col
                 rhead[imat[i]->head] = 1;                  rhead[imat[i]->head] = 1;
         }          }
         if ( m )          if ( m )
                 r0 = nd_f4_red_main(m,sp0,nsp,s0vect,col,rvect,rhead,imat,nred);                  r0 = nd_f4_red_main(m,sp0,nsp,s0vect,col,rvect,rhead,imat,nred,nz);
         else          else
                 r0 = nd_f4_red_q_main(sp0,nsp,s0vect,col,rvect,rhead,imat,nred);                  r0 = nd_f4_red_q_main(sp0,nsp,trace,s0vect,col,rvect,rhead,imat,nred);
         return r0;          return r0;
 }  }
   
 NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s0vect,int col,  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s0vect,int col,
         NM_ind_pair *rvect,int *rhead,IndArray *imat,int nred)          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,l,rank;
Line 4609  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
Line 4764  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
         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;
   
         spcol = col-nred;          spcol = col-nred;
         get_eg(&eg0);          get_eg(&eg0);
Line 4616  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
Line 4772  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
         spmat = (int **)ALLOCA(nsp*sizeof(UINT *));          spmat = (int **)ALLOCA(nsp*sizeof(UINT *));
         svect = (UINT *)ALLOCA(col*sizeof(UINT));          svect = (UINT *)ALLOCA(col*sizeof(UINT));
         spsugar = (int *)ALLOCA(nsp*sizeof(UINT));          spsugar = (int *)ALLOCA(nsp*sizeof(UINT));
           spactive = !nz?0:(ND_pairs *)ALLOCA(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 4630  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
Line 4787  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
                         for ( j = k = 0; j < col; j++ )                          for ( j = k = 0; j < col; j++ )
                                 if ( !rhead[j] ) v[k++] = svect[j];                                  if ( !rhead[j] ) v[k++] = svect[j];
                         spsugar[sprow] = MAX(maxrs,SG(spol));                          spsugar[sprow] = MAX(maxrs,SG(spol));
                           if ( nz )
                           spactive[sprow] = sp;
                         sprow++;                          sprow++;
                 }                  }
                 nd_free(spol);                  nd_free(spol);
Line 4647  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
Line 4806  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
         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
                 rank = nd_gauss_elim_mod(spmat,spsugar,sprow,spcol,m,colstat);                  rank = nd_gauss_elim_mod(spmat,spsugar,spactive,sprow,spcol,m,colstat);
         r0 = 0;          r0 = 0;
         for ( i = 0; i < rank; i++ ) {          for ( i = 0; i < rank; i++ ) {
                 NEXTNODE(r0,r); BDY(r) =                  NEXTNODE(r0,r); BDY(r) =
Line 4656  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
Line 4815  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
                 GC_free(spmat[i]);                  GC_free(spmat[i]);
         }          }
         if ( r0 ) NEXT(r) = 0;          if ( r0 ) NEXT(r) = 0;
   
         for ( ; i < sprow; i++ ) GC_free(spmat[i]);          for ( ; i < sprow; i++ ) GC_free(spmat[i]);
         get_eg(&eg2); init_eg(&eg_f4_2); add_eg(&eg_f4_2,&eg1,&eg2);          get_eg(&eg2); init_eg(&eg_f4_2); add_eg(&eg_f4_2,&eg1,&eg2);
         init_eg(&eg_f4); add_eg(&eg_f4,&eg0,&eg2);          init_eg(&eg_f4); add_eg(&eg_f4,&eg0,&eg2);
Line 4665  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
Line 4825  NODE nd_f4_red_main(int m,ND_pairs sp0,int nsp,UINT *s
                         nsp,nred,sprow,spcol,rank);                          nsp,nred,sprow,spcol,rank);
                 fprintf(asir_out,"%fsec\n",eg_f4.exectime+eg_f4.gctime);                  fprintf(asir_out,"%fsec\n",eg_f4.exectime+eg_f4.gctime);
         }          }
           if ( nz ) {
                   for ( i = 0; i < rank-1; i++ ) NEXT(spactive[i]) = spactive[i+1];
                   if ( rank > 0 ) {
                           NEXT(spactive[rank-1]) = 0;
                           *nz = spactive[0];
                   } else
                           *nz = 0;
           }
         return r0;          return r0;
 }  }
   
 #if 0  #if 1
 NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vect,int col,  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,int trace,UINT *s0vect,int col,
         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;
Line 4683  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vec
Line 4851  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vec
         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;
           pointer *w;
   
         spcol = col-nred;          spcol = col-nred;
         get_eg(&eg0);          get_eg(&eg0);
Line 4691  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vec
Line 4860  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vec
         svect = (Q *)ALLOCA(col*sizeof(Q));          svect = (Q *)ALLOCA(col*sizeof(Q));
         spsugar = (int *)ALLOCA(nsp*sizeof(Q));          spsugar = (int *)ALLOCA(nsp*sizeof(Q));
         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,0,sp,&spol);                  nd_sp(0,trace,sp,&spol);
                 if ( !spol ) continue;                  if ( !spol ) continue;
                 nd_to_vect_q(s0vect,col,spol,svect);                  nd_to_vect_q(s0vect,col,spol,svect);
                 maxrs = ndv_reduce_vect_q(svect,col,imat,rvect,nred);                  maxrs = ndv_reduce_vect_q(svect,trace,col,imat,rvect,nred);
                 for ( i = 0; i < col; i++ ) if ( svect[i] ) break;                  for ( i = 0; i < col; i++ ) if ( svect[i] ) break;
                 if ( i < col ) {                  if ( i < col ) {
                         spmat[sprow] = v = (Q *)MALLOC(spcol*sizeof(Q));                          spmat[sprow] = v = (Q *)MALLOC(spcol*sizeof(Q));
Line 4716  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vec
Line 4885  NODE nd_f4_red_q_main(ND_pairs sp0,int nsp,UINT *s0vec
         /* elimination (2nd step) */          /* elimination (2nd step) */
         colstat = (int *)ALLOCA(spcol*sizeof(int));          colstat = (int *)ALLOCA(spcol*sizeof(int));
         rank = nd_gauss_elim_q(spmat,spsugar,sprow,spcol,colstat);          rank = nd_gauss_elim_q(spmat,spsugar,sprow,spcol,colstat);
         r0 = 0;          w = (pointer *)ALLOCA(rank*sizeof(pointer));
         for ( i = 0; i < rank; i++ ) {          for ( i = 0; i < rank; i++ ) {
                 NEXTNODE(r0,r); BDY(r) =                  w[rank-i-1] = (pointer)vect_to_ndv_q(spmat[i],spcol,col,rhead,s0vect);
                         (pointer)vect_to_ndv_q(spmat[i],spcol,col,rhead,s0vect);                  SG((NDV)w[rank-i-1]) = spsugar[i];
                 SG((NDV)BDY(r)) = spsugar[i];  
 /*              GC_free(spmat[i]); */  /*              GC_free(spmat[i]); */
         }          }
   #if 0
           qsort(w,rank,sizeof(NDV),
                   (int (*)(const void *,const void *))ndv_compare);
   #endif
           r0 = 0;
           for ( i = 0; i < rank; i++ ) {
                   NEXTNODE(r0,r); BDY(r) = w[i];
           }
         if ( r0 ) NEXT(r) = 0;          if ( r0 ) NEXT(r) = 0;
   
 /*      for ( ; i < sprow; i++ ) GC_free(spmat[i]); */  /*      for ( ; i < sprow; i++ ) GC_free(spmat[i]); */
Line 4888  int ox_exec_f4_red(Q proc)
Line 5064  int ox_exec_f4_red(Q proc)
         return s;          return s;
 }  }
   
 NODE nd_f4_red_dist(int m,ND_pairs sp0,UINT *s0vect,int col,NODE rp0)  NODE nd_f4_red_dist(int m,ND_pairs sp0,UINT *s0vect,int col,NODE rp0,ND_pairs *nz)
 {  {
         int nsp,nred;          int nsp,nred;
         int i,rank,s;          int i,rank,s;
Line 5042  void nd_exec_f4_red_dist()
Line 5218  void nd_exec_f4_red_dist()
         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
                 rank = nd_gauss_elim_mod(spmat,spsugar,sprow,spcol,m,colstat);                  rank = nd_gauss_elim_mod(spmat,spsugar,0,sprow,spcol,m,colstat);
         nd_send_int(rank);          nd_send_int(rank);
         for ( i = 0; i < rank; i++ ) {          for ( i = 0; i < rank; i++ ) {
                 nf = vect_to_ndv(spmat[i],spcol,col,rhead,s0vect);                  nf = vect_to_ndv(spmat[i],spcol,col,rhead,s0vect);
Line 5073  int nd_gauss_elim_q(Q **mat0,int *sugar,int row,int co
Line 5249  int nd_gauss_elim_q(Q **mat0,int *sugar,int row,int co
                                 wmat[i][j] = 0;                                  wmat[i][j] = 0;
                 }                  }
         }          }
         rank0 = nd_gauss_elim_mod(wmat,sugar,row,col,mod,colstat);          rank0 = nd_gauss_elim_mod(wmat,sugar,0,row,col,mod,colstat);
         NEWMAT(m); m->row = row; m->col = col; m->body = (pointer **)mat0;          NEWMAT(m); m->row = row; m->col = col; m->body = (pointer **)mat0;
         rank = generic_gauss_elim(m,&nm,&dn,&ri,&ci);          rank = generic_gauss_elim(m,&nm,&dn,&ri,&ci);
         if ( rank != rank0 )          if ( rank != rank0 )
Line 5103  int nd_gauss_elim_q(Q **mat0,int *sugar,int row,int co
Line 5279  int nd_gauss_elim_q(Q **mat0,int *sugar,int row,int co
         return rank;          return rank;
 }  }
   
 int nd_gauss_elim_mod(int **mat0,int *sugar,int row,int col,int md,int *colstat)  int nd_gauss_elim_mod(int **mat0,int *sugar,ND_pairs *spactive,int row,int col,int md,int *colstat)
 {  {
         int i,j,k,l,inv,a,rank,s;          int i,j,k,l,inv,a,rank,s;
         unsigned int *t,*pivot,*pk;          unsigned int *t,*pivot,*pk;
         unsigned int **mat;          unsigned int **mat;
           ND_pairs pair;
   
         mat = (unsigned int **)mat0;          mat = (unsigned int **)mat0;
         for ( rank = 0, j = 0; j < col; j++ ) {          for ( rank = 0, j = 0; j < col; j++ ) {
Line 5124  int nd_gauss_elim_mod(int **mat0,int *sugar,int row,in
Line 5301  int nd_gauss_elim_mod(int **mat0,int *sugar,int row,in
                 if ( i != rank ) {                  if ( i != rank ) {
                         t = mat[i]; mat[i] = mat[rank]; mat[rank] = t;                          t = mat[i]; mat[i] = mat[rank]; mat[rank] = t;
                         s = sugar[i]; sugar[i] = sugar[rank]; sugar[rank] = s;                          s = sugar[i]; sugar[i] = sugar[rank]; sugar[rank] = s;
                           if ( spactive ) {
                                   pair = spactive[i]; spactive[i] = spactive[rank];
                                   spactive[rank] = pair;
                           }
                 }                  }
                 pivot = mat[rank];                  pivot = mat[rank];
                 s = sugar[rank];                  s = sugar[rank];

Legend:
Removed from v.1.130  
changed lines
  Added in v.1.143

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