| version 1.7, 2018/10/01 05:54:09 |
version 1.10, 2018/12/10 22:24:42 |
|
|
| /* $OpenXM: OpenXM_contrib2/asir2018/engine/Q.c,v 1.6 2018/10/01 05:49:06 noro Exp $ */ |
/* $OpenXM: OpenXM_contrib2/asir2018/engine/Q.c,v 1.9 2018/10/19 23:27:38 noro Exp $ */ |
| #include "ca.h" |
#include "ca.h" |
| #include "gmp.h" |
#include "gmp.h" |
| #include "base.h" |
#include "base.h" |
| Line 11 Z current_mod_lf; |
|
| Line 11 Z current_mod_lf; |
|
| int current_mod_lf_size; |
int current_mod_lf_size; |
| gmp_randstate_t GMP_RAND; |
gmp_randstate_t GMP_RAND; |
| |
|
| #define F4_INTRAT_PERIOD 8 |
#define F4_INTRAT_PERIOD 4 |
| |
|
| extern int DP_Print; |
extern int DP_Print; |
| |
|
| Line 30 void gc_free(void *p,size_t size) |
|
| Line 30 void gc_free(void *p,size_t size) |
|
| |
|
| void init_gmpq() |
void init_gmpq() |
| { |
{ |
| mp_set_memory_functions(Risa_GC_malloc_atomic,gc_realloc,gc_free); |
mp_set_memory_functions(Risa_GC_malloc,gc_realloc,gc_free); |
| |
|
| mpz_init(ONEMPZ); mpz_set_ui(ONEMPZ,1); MPZTOZ(ONEMPZ,ONE); |
mpz_init(ONEMPZ); mpz_set_ui(ONEMPZ,1); MPZTOZ(ONEMPZ,ONE); |
| gmp_randinit_default(GMP_RAND); |
gmp_randinit_default(GMP_RAND); |
| Line 900 int generic_gauss_elim(MAT mat,MAT *nm,Z *dn,int **rin |
|
| Line 900 int generic_gauss_elim(MAT mat,MAT *nm,Z *dn,int **rin |
|
| int row,col,ind,md,i,j,k,l,t,t1,rank,rank0,inv; |
int row,col,ind,md,i,j,k,l,t,t1,rank,rank0,inv; |
| MAT r,crmat; |
MAT r,crmat; |
| int ret; |
int ret; |
| |
MAT mat2,nm2; |
| |
Z dn2; |
| |
int *rind2,*cind2; |
| |
int ret2; |
| |
|
| #if SIZEOF_LONG == 8 |
#if SIZEOF_LONG == 8 |
| return generic_gauss_elim64(mat,nm,dn,rindp,cindp); |
ret = generic_gauss_elim64(mat,nm,dn,rindp,cindp); |
| |
return ret; |
| #endif |
#endif |
| bmat = (Z **)mat->body; |
bmat = (Z **)mat->body; |
| row = mat->row; col = mat->col; |
row = mat->row; col = mat->col; |
| Line 1180 int generic_gauss_elim_direct(MAT mat,MAT *nm,Z *dn,in |
|
| Line 1185 int generic_gauss_elim_direct(MAT mat,MAT *nm,Z *dn,in |
|
| return rank; |
return rank; |
| } |
} |
| |
|
| |
int mpz_intmtoratm(mpz_t **mat,int row,int col,mpz_t md,mpz_t **nm,mpz_t dn) |
| |
{ |
| |
mpz_t t,s,b,u,nm1,dn1; |
| |
int i,j,k,l,ret; |
| |
mpz_t *mi,*nmk; |
| |
|
| |
if ( UNIMPZ(md) ) |
| |
return 0; |
| |
mpz_init(t); mpz_init(s); mpz_init(b); mpz_init(u); |
| |
mpz_init(nm1); mpz_init(dn1); |
| |
mpz_fdiv_q_2exp(t,md,1); mpz_sqrt(s,t); mpz_fdiv_q_2exp(b,s,64); |
| |
if ( !mpz_sgn(b) ) mpz_set_ui(b,1); |
| |
mpz_set_ui(dn,1); |
| |
for ( i = 0; i < row; i++ ) |
| |
for ( j = 0, mi = mat[i]; j < col; j++ ) |
| |
if ( mpz_sgn(mi[j]) ) { |
| |
mpz_mul(s,mi[j],dn); |
| |
mpz_mod(u,s,md); |
| |
ret = mpz_inttorat(u,md,b,nm1,dn1); |
| |
if ( !ret ) |
| |
return 0; |
| |
else { |
| |
if ( !UNIMPZ(dn1) ) { |
| |
for ( k = 0; k < i; k++ ) |
| |
for ( l = 0, nmk = nm[k]; l < col; l++ ) mpz_mul(nmk[l],nmk[l],dn1); |
| |
for ( l = 0, nmk = nm[i]; l < j; l++ ) mpz_mul(nmk[l],nmk[l],dn1); |
| |
} |
| |
mpz_set(nm[i][j],nm1); |
| |
mpz_mul(dn,dn,dn1); |
| |
} |
| |
} |
| |
return 1; |
| |
} |
| |
|
| int intmtoratm(MAT mat,Z md,MAT nm,Z *dn) |
int intmtoratm(MAT mat,Z md,MAT nm,Z *dn) |
| { |
{ |
| Z t,s,b,dn0,dn1,nm1,q,u,unm,udn,dmy; |
Z t,s,b,dn0,dn1,nm1,q,u,unm,udn,dmy; |
| Line 1280 int intvtoratv(Z *v,int n,Z md,Z b,Z *nm,Z *dn) |
|
| Line 1319 int intvtoratv(Z *v,int n,Z md,Z b,Z *nm,Z *dn) |
|
| |
|
| /* assuming 0 < c < m */ |
/* assuming 0 < c < m */ |
| |
|
| |
int mpz_inttorat(mpz_t c,mpz_t m,mpz_t b,mpz_t nm,mpz_t dn) |
| |
{ |
| |
mpz_t u1,v1,u2,v2,r1,r2; |
| |
mpz_t q,t; |
| |
|
| |
mpz_init_set_ui(u1,0); mpz_init_set_ui(v1,1); |
| |
mpz_init_set(u2,m); mpz_init_set(v2,c); |
| |
mpz_init(q); mpz_init(t); mpz_init(r1); mpz_init(r2); |
| |
while ( mpz_cmp(v2,b) >= 0 ) { |
| |
/* r2 = u2-q*v2 */ |
| |
mpz_fdiv_qr(q,r2,u2,v2); |
| |
mpz_set(u2,v2); mpz_set(v2,r2); |
| |
/* r1 = u1-q*v1 */ |
| |
mpz_mul(t,q,v1); mpz_sub(r1,u1,t); |
| |
mpz_set(u1,v1); mpz_set(v1,r1); |
| |
} |
| |
if ( mpz_cmp(v1,b) >= 0 ) return 0; |
| |
else { |
| |
if ( mpz_sgn(v1)<0 ) { |
| |
mpz_neg(dn,v1); mpz_neg(nm,v2); |
| |
} else { |
| |
mpz_set(dn,v1); mpz_set(nm,v2); |
| |
} |
| |
return 1; |
| |
} |
| |
} |
| |
|
| int inttorat(Z c,Z m,Z b,Z *nmp,Z *dnp) |
int inttorat(Z c,Z m,Z b,Z *nmp,Z *dnp) |
| { |
{ |
| Z qq,t,u1,v1,r1; |
Z qq,t,u1,v1,r1; |
| Line 1303 int inttorat(Z c,Z m,Z b,Z *nmp,Z *dnp) |
|
| Line 1369 int inttorat(Z c,Z m,Z b,Z *nmp,Z *dnp) |
|
| |
|
| extern int f4_nocheck; |
extern int f4_nocheck; |
| |
|
| |
int mpz_gensolve_check(MAT mat,mpz_t **nm,mpz_t dn,int rank,int *rind,int *cind) |
| |
{ |
| |
int row,col,clen,i,j,k,l; |
| |
mpz_t t; |
| |
mpz_t *w; |
| |
Z *mati; |
| |
mpz_t *nmk; |
| |
|
| |
if ( f4_nocheck ) return 1; |
| |
row = mat->row; col = mat->col; clen = col-rank; |
| |
w = (mpz_t *)MALLOC(clen*sizeof(mpz_t)); |
| |
mpz_init(t); |
| |
for ( i = 0; i < clen; i++ ) mpz_init(w[i]); |
| |
for ( i = 0; i < row; i++ ) { |
| |
mati = (Z *)mat->body[i]; |
| |
for ( l = 0; l < clen; l++ ) mpz_set_ui(w[l],0); |
| |
for ( k = 0; k < rank; k++ ) |
| |
for ( l = 0, nmk = (mpz_t *)nm[k]; l < clen; l++ ) { |
| |
/* w[l] += mati[rind[k]]*nmk[k] */ |
| |
if ( mati[rind[k]] ) mpz_addmul(w[l],BDY(mati[rind[k]]),nmk[l]); |
| |
} |
| |
for ( j = 0; j < clen; j++ ) { |
| |
if ( mati[cind[j]] ) mpz_mul(t,dn,BDY(mati[cind[j]])); |
| |
else mpz_set_ui(t,0); |
| |
if ( mpz_cmp(w[j],t) ) break; |
| |
} |
| |
if ( j != clen ) break; |
| |
} |
| |
if ( i != row ) return 0; |
| |
else return 1; |
| |
} |
| |
|
| int gensolve_check(MAT mat,MAT nm,Z dn,int *rind,int *cind) |
int gensolve_check(MAT mat,MAT nm,Z dn,int *rind,int *cind) |
| { |
{ |
| int row,col,rank,clen,i,j,k,l; |
int row,col,rank,clen,i,j,k,l; |
| Line 1493 int generic_gauss_elim_hensel(MAT mat,MAT *nmmat,Z *dn |
|
| Line 1591 int generic_gauss_elim_hensel(MAT mat,MAT *nmmat,Z *dn |
|
| Z wn; |
Z wn; |
| Z wq; |
Z wq; |
| |
|
| |
#if SIZEOF_LONG == 8 |
| |
return generic_gauss_elim_hensel64(mat,nmmat,dn,rindp,cindp); |
| |
#endif |
| init_eg(&eg_mul1); init_eg(&eg_mul2); |
init_eg(&eg_mul1); init_eg(&eg_mul2); |
| a0 = (Z **)mat->body; |
a0 = (Z **)mat->body; |
| row = mat->row; col = mat->col; |
row = mat->row; col = mat->col; |
| Line 1791 mp_limb_t remqi64(Q a,mp_limb_t mod) |
|
| Line 1892 mp_limb_t remqi64(Q a,mp_limb_t mod) |
|
| int generic_gauss_elim_mod64(mp_limb_t **mat,int row,int col,mp_limb_t md,int *colstat); |
int generic_gauss_elim_mod64(mp_limb_t **mat,int row,int col,mp_limb_t md,int *colstat); |
| mp_limb_t get_lprime64(int ind); |
mp_limb_t get_lprime64(int ind); |
| |
|
| |
void mpz_print(mpz_t a) |
| |
{ |
| |
mpz_out_str(stdout,10,a); printf("\n"); |
| |
} |
| |
|
| |
void mpz_printmat(mpz_t **a,int row,int col) |
| |
{ |
| |
int i,j; |
| |
for ( i = 0; i < row; i++ ) { |
| |
for ( j = 0; j < col; j++ ) { |
| |
mpz_out_str(stdout,10,a[i][j]); printf(" "); |
| |
} |
| |
printf("\n"); |
| |
} |
| |
} |
| |
|
| |
mpz_t **mpz_allocmat(int row,int col) |
| |
{ |
| |
mpz_t **p; |
| |
int i,j; |
| |
|
| |
p = (mpz_t **)MALLOC(row*sizeof(mpz_t *)); |
| |
for ( i = 0; i < row; i++ ) { |
| |
p[i] = (mpz_t *)MALLOC(col*sizeof(mpz_t)); |
| |
for ( j = 0; j < col; j++ ) mpz_init(p[i][j]); |
| |
} |
| |
return p; |
| |
} |
| |
|
| |
#if 1 |
| int generic_gauss_elim64(MAT mat,MAT *nm,Z *dn,int **rindp,int **cindp) |
int generic_gauss_elim64(MAT mat,MAT *nm,Z *dn,int **rindp,int **cindp) |
| { |
{ |
| mp_limb_t **wmat; |
mp_limb_t **wmat; |
| mp_limb_t *wmi; |
mp_limb_t *wmi; |
| mp_limb_t md,inv,t,t1; |
mp_limb_t md,inv,t,t1; |
| |
Z z; |
| |
Z **bmat,*bmi; |
| |
mpz_t **tmat,**num; |
| |
mpz_t *tmi; |
| |
mpz_t den; |
| |
mpz_t q,m1,m3,s,u; |
| |
int *colstat,*wcolstat,*rind,*cind; |
| |
int row,col,ind,i,j,k,l,rank,rank0; |
| |
MAT r; |
| |
int ret; |
| |
|
| |
bmat = (Z **)mat->body; |
| |
row = mat->row; col = mat->col; |
| |
wmat = (mp_limb_t **)almat64(row,col); |
| |
colstat = (int *)MALLOC_ATOMIC(col*sizeof(int)); |
| |
wcolstat = (int *)MALLOC_ATOMIC(col*sizeof(int)); |
| |
mpz_init(m1); mpz_init(m3); mpz_init(den); |
| |
for ( ind = 0; ; ind++ ) { |
| |
if ( DP_Print ) { |
| |
fprintf(asir_out,"."); fflush(asir_out); |
| |
} |
| |
md = get_lprime64(ind); |
| |
for ( i = 0; i < row; i++ ) |
| |
for ( j = 0, bmi = bmat[i], wmi = wmat[i]; j < col; j++ ) |
| |
wmi[j] = bmi[j]==0?0:mpz_fdiv_ui(BDY(bmi[j]),md); |
| |
rank = generic_gauss_elim_mod64(wmat,row,col,md,wcolstat); |
| |
if ( !ind ) { |
| |
RESET: |
| |
mpz_set_ui(m1,md); |
| |
rank0 = rank; |
| |
bcopy(wcolstat,colstat,col*sizeof(int)); |
| |
// crmat |
| |
tmat = mpz_allocmat(rank,col-rank); |
| |
// |
| |
num = mpz_allocmat(rank,col-rank); |
| |
for ( i = 0; i < rank; i++ ) |
| |
for ( j = k = 0, tmi = tmat[i], wmi = wmat[i]; j < col; j++ ) |
| |
if ( !colstat[j] ) { mpz_set_ui(tmi[k],wmi[j]); k++; } |
| |
} else { |
| |
if ( rank < rank0 ) { |
| |
if ( DP_Print ) { |
| |
fprintf(asir_out,"lower rank matrix; continuing...\n"); |
| |
fflush(asir_out); |
| |
} |
| |
continue; |
| |
} else if ( rank > rank0 ) { |
| |
if ( DP_Print ) { |
| |
fprintf(asir_out,"higher rank matrix; resetting...\n"); |
| |
fflush(asir_out); |
| |
} |
| |
goto RESET; |
| |
} else { |
| |
for ( j = 0; (j<col) && (colstat[j]==wcolstat[j]); j++ ); |
| |
if ( j < col ) { |
| |
if ( DP_Print ) { |
| |
fprintf(asir_out,"inconsitent colstat; resetting...\n"); |
| |
fflush(asir_out); |
| |
} |
| |
goto RESET; |
| |
} |
| |
} |
| |
|
| |
inv = invmod64(mpz_fdiv_ui(m1,md),md); |
| |
mpz_mul_ui(m3,m1,md); |
| |
for ( i = 0; i < rank; i++ ) |
| |
for ( j = k = 0, tmi = tmat[i], wmi = wmat[i]; j < col; j++ ) |
| |
if ( !colstat[j] ) { |
| |
if ( mpz_sgn(tmi[k]) ) { |
| |
/* f3 = f1+m1*(m1 mod md)^(-1)*(f2 - f1 mod md) */ |
| |
t = mpz_fdiv_ui(tmi[k],md); |
| |
if ( wmi[j] >= t ) t = wmi[j]-t; |
| |
else t = md-(t-wmi[j]); |
| |
mpz_addmul_ui(tmi[k],m1,mulmod64(t,inv,md)); |
| |
} else if ( wmi[j] ) { |
| |
/* f3 = m1*(m1 mod m2)^(-1)*f2 */ |
| |
mpz_mul_ui(tmi[k],m1,mulmod64(wmi[j],inv,md)); |
| |
} |
| |
k++; |
| |
} |
| |
mpz_set(m1,m3); |
| |
if ( ind % F4_INTRAT_PERIOD ) |
| |
ret = 0; |
| |
else |
| |
ret = mpz_intmtoratm(tmat,rank,col-rank,m1,num,den); |
| |
if ( ret ) { |
| |
*rindp = rind = (int *)MALLOC_ATOMIC(rank*sizeof(int)); |
| |
*cindp = cind = (int *)MALLOC_ATOMIC((col-rank)*sizeof(int)); |
| |
for ( j = k = l = 0; j < col; j++ ) |
| |
if ( colstat[j] ) rind[k++] = j; |
| |
else cind[l++] = j; |
| |
if ( mpz_gensolve_check(mat,num,den,rank,rind,cind) ) { |
| |
MKMAT(r,rank,col-rank); *nm = r; |
| |
for ( i = 0; i < rank; i++ ) |
| |
for ( j = 0; j < col-rank; j++ ) { |
| |
MPZTOZ(num[i][j],z); BDY(r)[i][j] = z; |
| |
} |
| |
MPZTOZ(den,*dn); |
| |
return rank; |
| |
} |
| |
} |
| |
} |
| |
} |
| |
} |
| |
#else |
| |
int generic_gauss_elim64(MAT mat,MAT *nm,Z *dn,int **rindp,int **cindp) |
| |
{ |
| |
mp_limb_t **wmat; |
| |
mp_limb_t *wmi; |
| |
mp_limb_t md,inv,t,t1; |
| Z **bmat,**tmat,*bmi,*tmi; |
Z **bmat,**tmat,*bmi,*tmi; |
| Z q,m1,m2,m3,s,u; |
Z q,m1,m2,m3,s,u; |
| int *colstat,*wcolstat,*rind,*cind; |
int *colstat,*wcolstat,*rind,*cind; |
|
|
| } |
} |
| } |
} |
| } |
} |
| |
#endif |
| |
|
| |
int generic_gauss_elim_hensel64(MAT mat,MAT *nmmat,Z *dn,int **rindp,int **cindp) |
| |
{ |
| |
MAT r; |
| |
Z z; |
| |
Z **a0; |
| |
Z *ai; |
| |
mpz_t **a,**b,**x,**nm; |
| |
mpz_t *bi,*xi; |
| |
mpz_t q,u,den; |
| |
mp_limb_t **w; |
| |
mp_limb_t *wi; |
| |
mp_limb_t **wc; |
| |
mp_limb_t md; |
| |
int row,col; |
| |
int ind,i,j,k,l,li,ri,rank; |
| |
int *cinfo,*rinfo; |
| |
int *rind,*cind; |
| |
int count; |
| |
int ret; |
| |
int period; |
| |
|
| |
a0 = (Z **)mat->body; |
| |
row = mat->row; col = mat->col; |
| |
w = (mp_limb_t **)almat64(row,col); |
| |
for ( ind = 0; ; ind++ ) { |
| |
md = get_lprime64(ind); |
| |
for ( i = 0; i < row; i++ ) |
| |
for ( j = 0, ai = a0[i], wi = w[i]; j < col; j++ ) |
| |
wi[j] = remqi64((Q)ai[j],md); |
| |
|
| |
if ( DP_Print > 3 ) { |
| |
fprintf(asir_out,"LU decomposition.."); fflush(asir_out); |
| |
} |
| |
rank = find_lhs_and_lu_mod64(w,row,col,md,&rinfo,&cinfo); |
| |
if ( DP_Print > 3 ) { |
| |
fprintf(asir_out,"done.\n"); fflush(asir_out); |
| |
} |
| |
a = (mpz_t **)mpz_allocmat(rank,rank); /* lhs mat */ |
| |
b = (mpz_t **)mpz_allocmat(rank,col-rank); |
| |
for ( j = li = ri = 0; j < col; j++ ) |
| |
if ( cinfo[j] ) { |
| |
/* the column is in lhs */ |
| |
for ( i = 0; i < rank; i++ ) { |
| |
w[i][li] = w[i][j]; |
| |
if ( a0[rinfo[i]][j] ) |
| |
mpz_set(a[i][li],BDY(a0[rinfo[i]][j])); |
| |
else |
| |
mpz_set_ui(a[i][li],0); |
| |
} |
| |
li++; |
| |
} else { |
| |
/* the column is in rhs */ |
| |
for ( i = 0; i < rank; i++ ) { |
| |
if ( a0[rinfo[i]][j] ) |
| |
mpz_set(b[i][ri],BDY(a0[rinfo[i]][j])); |
| |
else |
| |
mpz_set_ui(b[i][ri],0); |
| |
} |
| |
ri++; |
| |
} |
| |
|
| |
/* solve Ax=B; A: rank x rank, B: rank x ri */ |
| |
/* algorithm |
| |
c <- B |
| |
x <- 0 |
| |
q <- 1 |
| |
do |
| |
t <- A^(-1)c mod p |
| |
x <- x+qt |
| |
c <- (c-At)/p |
| |
q <- qp |
| |
end do |
| |
then Ax-B=0 mod q and b=(B-Ax)/q hold after "do". |
| |
*/ |
| |
x = (mpz_t **)mpz_allocmat(rank,ri); |
| |
nm = (mpz_t **)mpz_allocmat(rank,ri); |
| |
wc = (mp_limb_t **)almat64(rank,ri); |
| |
*rindp = rind = (int *)MALLOC_ATOMIC(rank*sizeof(int)); |
| |
*cindp = cind = (int *)MALLOC_ATOMIC((ri)*sizeof(int)); |
| |
|
| |
period = F4_INTRAT_PERIOD; |
| |
mpz_init_set_ui(q,1); |
| |
mpz_init(u); |
| |
mpz_init(den); |
| |
for ( count = 0; ; ) { |
| |
/* check Ax=B mod q */ |
| |
if ( DP_Print > 3 ) |
| |
fprintf(stderr,"o"); |
| |
/* wc = b mod md */ |
| |
for ( i = 0; i < rank; i++ ) |
| |
for ( j = 0, bi = b[i], wi = wc[i]; j < ri; j++ ) |
| |
wi[j] = mpz_fdiv_ui(bi[j],md); |
| |
/* wc = A^(-1)wc; wc is not normalized */ |
| |
solve_by_lu_mod64(w,rank,md,wc,ri,0); |
| |
/* x += q*wc */ |
| |
for ( i = 0; i < rank; i++ ) |
| |
for ( j = 0, wi = wc[i]; j < ri; j++ ) |
| |
if ( wi[j] > 0 ) |
| |
mpz_addmul_ui(x[i][j],q,wi[j]); |
| |
else if ( wi[j] < 0 ) |
| |
mpz_submul_ui(x[i][j],q,-wi[j]); |
| |
/* b =(b-A*wc)/md */ |
| |
for ( i = 0; i < rank; i++ ) |
| |
for ( j = 0; j < ri; j++ ) { |
| |
mpz_set(u,b[i][j]); |
| |
for ( k = 0; k < rank; k++ ) { |
| |
if ( a[i][k] && wc[k][j] ) { |
| |
if ( wc[k][j] < 0 ) |
| |
mpz_addmul_ui(u,a[i][k],-wc[k][j]); |
| |
else |
| |
mpz_submul_ui(u,a[i][k],wc[k][j]); |
| |
} |
| |
} |
| |
mpz_divexact_ui(b[i][j],u,md); |
| |
} |
| |
count++; |
| |
/* q = q*md */ |
| |
mpz_mul_ui(q,q,md); |
| |
fprintf(stderr,"."); |
| |
if ( count == period ) { |
| |
ret = mpz_intmtoratm(x,rank,ri,q,nm,den); |
| |
if ( ret ) { |
| |
for ( j = k = l = 0; j < col; j++ ) |
| |
if ( cinfo[j] ) |
| |
rind[k++] = j; |
| |
else |
| |
cind[l++] = j; |
| |
ret = mpz_gensolve_check(mat,nm,den,rank,rind,cind); |
| |
if ( ret ) { |
| |
*rindp = rind; |
| |
*cindp = cind; |
| |
for ( j = k = 0; j < col; j++ ) |
| |
if ( !cinfo[j] ) |
| |
cind[k++] = j; |
| |
MKMAT(r,rank,ri); *nmmat = r; |
| |
for ( i = 0; i < rank; i++ ) |
| |
for ( j = 0; j < ri; j++ ) { |
| |
MPZTOZ(nm[i][j],z); BDY(r)[i][j] = z; |
| |
} |
| |
MPZTOZ(den,*dn); |
| |
return rank; |
| |
} |
| |
} else { |
| |
fprintf(stderr,"F"); |
| |
period = period*3/2; |
| |
count = 0; |
| |
} |
| |
} |
| |
} |
| |
} |
| |
} |
| |
|
| #endif |
#endif |