itsol-1.0.0/0000750000265600020320000000000011064041050011750 5ustar tilleaadminitsol-1.0.0/LIB/0000750000265600020320000000000011062576663012403 5ustar tilleaadminitsol-1.0.0/LIB/indsetC.c0000640000265600020320000001654611062577473014155 0ustar tilleaadmin#include #include #include #include #include "./globheads.h" #include "./protos.h" void *Malloc( int, char * ); int add2is(int *last, int nod, int *iord, int *riord) { /*---------------------------------------------------------------------- | adds element nod to independent set |---------------------------------------------------------------------*/ (*last)++; iord[nod] = *last; riord[*last] = nod; return 0; } /*--------------------------------------------------------------------- |---- end of add2is --------------------------------------------------- |--------------------------------------------------------------------*/ int add2com(int *nback, int nod, int *iord, int *riord) { /*---------------------------------------------------------------------- | adds element nod to independent set |---------------------------------------------------------------------*/ iord[nod] = *nback; riord[*nback] = nod; (*nback)--; return 0; } /*--------------------------------------------------------------------- |---- end of add2com -------------------------------------------------- |--------------------------------------------------------------------*/ int indsetC(csptr mat, int bsize, int *iord, int *nnod, double tol) { /*--------------------------------------------------------------------- | greedy algorithm for independent set ordering -- |---------------------------------------------------------------------- | Input parameters: | ----------------- | (mat) = matrix in SpaFmt format | | bsize = integer (input) the target size of each block. | each block is of size >= bsize. | | w = weight factors for the selection of the elements in the | independent set. If w(i) is small i will be left for the | vertex cover set. | | tol = a tolerance for excluding a row from independent set. | | Output parameters: | ------------------ | iord = permutation array corresponding to the independent set | ordering. Row number i will become row number iord[i] in | permuted matrix. | | nnod = (output) number of elements in the independent set. | |----------------------------------------------------------------------- | the algorithm searches nodes in lexicographic order and groups | the (BSIZE-1) nearest nodes of the current to form a block of | size BSIZE. The current algorithm does not use values of the matrix. |---------------------------------------------------------------------*/ /* local variables */ int nod, jcount, lastlev, begin, last0, last, nback, mid, j1, j2, jcol, inod, jnod, j, k, jcount0, begin0, *rowj; int prog, n=mat->n, *riord; double *w; csptr matT,gmat; int weightsC(csptr, double *); /*-----------------------------------------------------------------------*/ riord = (int *) Malloc(n*sizeof(int), "indsetC:1" ); w = (double *) Malloc(n*sizeof(double), "indsetC:2" ); matT = (csptr) Malloc(sizeof(SparMat), "indsetC:3" ); /* call weights to compute the weights for input matrix.. */ setupCS(matT, mat->n, 1); SparTran(mat, matT, 1, 0); SparTran(matT, mat, 1, 1); weightsC(mat, w); /*---------------------------------------------------------------------- | scan all nodes first to eliminate those not satisfying DD criterion +----------------------------------------------------------------------*/ nback = n-1; nod = 0; for(j=0; j= mat->n) goto label50; } /*-------------------- initialize level-set - contains nod (only)*/ add2is(&last, nod, iord, riord); begin = last; begin0 = begin; lastlev = begin; jcount = 1; /*---------------------------------------------------------------------- | put all the nearest neighbor nodes of the current node into | the block until the number is BSIZE. |---------------------------------------------------------------------*/ prog = 1; while (jcount < bsize && prog) { /*-------------------- traverse all the current level-set */ last0 = last; jcount0 = jcount; for (inod=begin; inod<=last0; inod++) { jnod = riord[inod]; /*-------------------- This assumes A is not symmetric. */ gmat = mat; for (k=0; k<2; k++) { rowj = gmat->ja[jnod]; for (j=0; jnzcount[jnod]; j++) { jcol = rowj[j]; if (iord[jcol] == -1 ) { add2is(&last, jcol, iord, riord); jcount++; } } gmat = matT; } } prog = jcount > jcount0 ? 1 : 0; lastlev = begin; begin = last0+1; } /*----------------------------------------------------------------------- | the neighbors of elements of last level go to the complement | gmat loop over original matrix and its transpose +-----------------------------------------------------------------------*/ gmat = mat; for (k=0; k<2; k++) { for (inod=lastlev; inod<=last; inod++) { jnod = riord[inod]; rowj = gmat->ja[jnod]; for (j=0; jnzcount[jnod]; j++){ jcol = rowj[j]; if (iord[jcol] == -1) add2com(&nback, jcol, iord, riord); } } gmat = matT; } /* reverse ordering for this level */ mid = (begin0+last) / 2; for (inod=begin0; inod<=mid; inod++) { j = last - inod + begin0; jnod = riord[inod]; riord[inod] = riord[j]; riord[j] = jnod; } } /*-------------------------------------------------- | end-main-loop |-------------------------------------------------*/ /*-------------------- relabel nodes of vertex cover */ label50: *nnod = last; j1 = *nnod; for (j2=*nnod+1; j2 -1) { if (++j1 != j2) { j = riord[j2]; riord[j2] = riord[j1]; riord[j1] = j; } } } /*-------------------- obtain reverse permutation array */ for (j=0; jn, *kj, kz; double tdia, wmax=0.0, tnorm, *kr; for (irow=0; irownzcount[irow]; kr = mat->ma[irow]; kj = mat->ja[irow]; tnorm = 0.0; tdia = 0.0; for (k=0; k 0.0) tnorm = tdia / tnorm; w[irow] = tnorm; if (tnorm > wmax) wmax = tnorm; } for (irow=0; irow #include #include #include #include #include "./globheads.h" #include "./protos.h" void errexit( char *f_str, ... ){ va_list argp; char out1[256], out2[256]; va_start(argp, f_str); vsprintf(out1, f_str, argp); va_end(argp); sprintf(out2, "Error! %s\n", out1); fprintf(stdout, out2); fflush(stdout); exit( -1 ); } void *Malloc( int nbytes, char *msg ) { void *ptr; if (nbytes == 0) return NULL; ptr = (void *)malloc(nbytes); if (ptr == NULL) errexit( "Not enough mem for %s. Requested size: %d bytes", msg, nbytes ); return ptr; } int setupCS(csptr amat, int len, int job) { /*---------------------------------------------------------------------- | Initialize SpaFmt structs. |---------------------------------------------------------------------- | on entry: |========== | ( amat ) = Pointer to a SpaFmt struct. | len = size of matrix | job = 0: pattern only | 1: data and pattern | | On return: |=========== | | amat->n | ->*nzcount | ->**ja | ->**ma | | integer value returned: | 0 --> successful return. | 1 --> memory allocation error. |--------------------------------------------------------------------*/ amat->n = len; amat->nzcount = (int *)Malloc( len*sizeof(int), "setupCS" ); amat->ja = (int **) Malloc( len*sizeof(int *), "setupCS" ); if( job == 1 ) amat->ma = (double **) Malloc( len*sizeof(double *), "setupCS" ); else amat->ma = NULL; return 0; } /*--------------------------------------------------------------------- | end of setupCS |--------------------------------------------------------------------*/ int cleanCS(csptr amat) { /*---------------------------------------------------------------------- | Free up memory allocated for SpaFmt structs. |---------------------------------------------------------------------- | on entry: |========== | ( amat ) = Pointer to a SpaFmt struct. |--------------------------------------------------------------------*/ /* */ int i; if (amat == NULL) return 0; if (amat->n < 1) return 0; for (i=0; in; i++) { if (amat->nzcount[i] > 0) { if( amat->ma ) free(amat->ma[i]); free(amat->ja[i]); } } if (amat->ma) free(amat->ma); free(amat->ja); free(amat->nzcount); free(amat); return 0; } /*--------------------------------------------------------------------- | end of cleanCS |--------------------------------------------------------------------*/ int nnzCS( csptr amat ) { int nnz = 0, i, n = amat->n; for( i = 0; i < n; i++ ) { nnz += amat->nzcount[i]; } return nnz; } int cscpy(csptr amat, csptr bmat){ /*---------------------------------------------------------------------- | Convert CSR matrix to SpaFmt struct |---------------------------------------------------------------------- | on entry: |========== | ( amat ) = Matrix stored in SpaFmt format | | | On return: |=========== | | ( bmat ) = Matrix stored as SpaFmt struct containing a copy | of amat | | integer value returned: | 0 --> successful return. | 1 --> memory allocation error. |--------------------------------------------------------------------*/ int j, len, size=amat->n; double *bma; int *bja; /*------------------------------------------------------------*/ for (j=0; jnzcount[j] = amat->nzcount[j]; if (len > 0) { bja = (int *) Malloc(len*sizeof(int), "cscpy:1" ); bma = (double *) Malloc(len*sizeof(double), "cscpy:2" ); memcpy(bja,amat->ja[j],len*sizeof(int)); memcpy(bma,amat->ma[j],len*sizeof(double)); bmat->ja[j] = bja; bmat->ma[j] = bma; } } return 0; } /*-----------------------------------------------------------------------*/ int setupILU( iluptr lu, int n ) { /*---------------------------------------------------------------------- | Initialize ILUSpar structs. |---------------------------------------------------------------------- | on entry: |========== | ( lu ) = Pointer to a ILUSpar struct. | n = size of matrix | | On return: |=========== | | lu->n | ->L L matrix, SpaFmt format | ->D Diagonals | ->U U matrix, SpaFmt format | ->work working buffer of length n | ->bf buffer | | integer value returned: | 0 --> successful return. | -1 --> memory allocation error. |--------------------------------------------------------------------*/ lu->n = n; lu->D = (double *)Malloc( sizeof(double) * n, "setupILU" ); lu->L = (csptr)Malloc( sizeof(SparMat), "setupILU" ); setupCS( lu->L, n, 1 ); lu->U = (csptr)Malloc( sizeof(SparMat), "setupILU" ); setupCS( lu->U, n, 1 ); lu->work = (int *)Malloc( sizeof(int) * n, "setupILU" ); return 0; } /*--------------------------------------------------------------------- | end of setupILU |--------------------------------------------------------------------*/ int cleanILU( iluptr lu ) { /*---------------------------------------------------------------------- | Free up memory allocated for ILUSpar structs. |---------------------------------------------------------------------- | on entry: |========== | ( lu ) = Pointer to a ILUSpar struct. |--------------------------------------------------------------------*/ if( NULL == lu ) return 0; if( lu->D ) { free( lu->D ); } cleanCS( lu->L ); cleanCS( lu->U ); if( lu->work ) free( lu->work ); free( lu ); return 0; } /*--------------------------------------------------------------------- | end of cleanILU |--------------------------------------------------------------------*/ int setupVBMat( vbsptr vbmat, int n, int *nB ) { /*---------------------------------------------------------------------- | Initialize VBSpaFmt structs. |---------------------------------------------------------------------- | on entry: |========== | ( vbmat ) = Pointer to a VBSpaFmt struct. | n = size of block matrix | nB = size of diagonal block, so the real size of the matrix | is nB[0] + nB[1] + ... + nB[n-1] | do nothing if nB is NULL | | On return: |=========== | | vbmat->n | ->*bsz | ->*nzcount | ->**ja | ->**ba | ->*D | | integer value returned: | 0 --> successful return. | -1 --> memory allocation error. |--------------------------------------------------------------------*/ int i; vbmat->n = n; if( nB ) { vbmat->bsz = (int *)Malloc( sizeof(int)*(n+1), "setupVBMat" ); vbmat->bsz[0] = 0; for( i = 1; i <= n; i++ ) { vbmat->bsz[i] = vbmat->bsz[i-1] + nB[i-1]; } } else vbmat->bsz = NULL; vbmat->nzcount = (int *)Malloc( sizeof(int)*n, "setupVBMat" ); vbmat->ja = (int **)Malloc( sizeof(int *)*n, "setupVBMat" ); vbmat->ba = (BData **)Malloc( sizeof(BData *) * n, "setupVBMat" ); vbmat->D = NULL; return 0; } /*--------------------------------------------------------------------- | end of setupVBMat |--------------------------------------------------------------------*/ int cleanVBMat( vbsptr vbmat ) { /*---------------------------------------------------------------------- | Free up memory allocated for VBSpaFmt structs. |---------------------------------------------------------------------- | on entry: |========== | ( vbmat ) = Pointer to a VBSpaFmt struct. |--------------------------------------------------------------------*/ int i, j; if( vbmat == NULL ) return 0; if( vbmat->n < 1 ) return 0; for( i = 0; i < vbmat->n; i++ ) { if( vbmat->nzcount[i] > 0 ) { free( vbmat->ja[i] ); if( vbmat->ba && vbmat->ba[i] ) { for( j = 0; j < vbmat->nzcount[i]; j++ ) { free( vbmat->ba[i][j] ); } free( vbmat->ba[i] ); } } if( vbmat->D && vbmat->D[i] ) free( vbmat->D[i] ); } if( vbmat->D ) free( vbmat->D ); free( vbmat->ja ); if( vbmat->ba ) free( vbmat->ba ); free( vbmat->nzcount ); if( vbmat->bsz ) free( vbmat->bsz ); free( vbmat ); return 0; } /*--------------------------------------------------------------------- | end of cleanVBMat |--------------------------------------------------------------------*/ int nnzVBMat( vbsptr vbmat ) { int nnz = 0, i, n = vbmat->n; for( i = 0; i < n; i++ ) { nnz += vbmat->nzcount[i]; } return nnz; } int memVBMat( vbsptr vbmat ) { int mem = 0, nnz, i, j, n = vbmat->n, *bsz = vbmat->bsz, dm; for( i = 0; i < n; i++ ) { nnz = vbmat->nzcount[i]; dm = 0; for( j = 0; j < nnz; j++ ) { dm += B_DIM(bsz,vbmat->ja[i][j]); } mem += dm * B_DIM(bsz,i); } return mem; } int setupVBILU( vbiluptr lu, int n, int *bsz ) { /*---------------------------------------------------------------------- | Initialize VBILUSpar structs. |---------------------------------------------------------------------- | on entry: |========== | ( lu ) = Pointer to a VBILUSpar struct. | n = size of block matrix | bsz = the row/col of the first element of each diagonal block | | On return: |=========== | | lu->n | ->bsz | ->L L matrix, VBSpaFmt format | ->D Diagonals | ->U U matrix, VBSpaFmt format | ->work working buffer of length n | ->bf buffer | | integer value returned: | 0 --> successful return. | -1 --> memory allocation error. |--------------------------------------------------------------------*/ int i; int max_block_size = sizeof(double)*MAX_BLOCK_SIZE*MAX_BLOCK_SIZE; lu->n = n; lu->bsz = (int *)Malloc( sizeof(int) * (n+1), "setupVBILU" ); for( i = 0; i <= n; i++ ) lu->bsz[i] = bsz[i]; lu->D = (BData *)Malloc( sizeof(BData) * n, "setupVBILU" ); lu->L = (vbsptr)Malloc( sizeof(VBSparMat), "setupVBILU" ); setupVBMat( lu->L, n, NULL ); lu->U = (vbsptr)Malloc( sizeof(VBSparMat), "setupVBILU" ); setupVBMat( lu->U, n, NULL ); lu->work = (int *)Malloc( sizeof(int) * n, "setupVBILU" ); lu->bf = (BData)Malloc( max_block_size, "setupVBILU" ); return 0; } /*--------------------------------------------------------------------- | end of setupVBILU |--------------------------------------------------------------------*/ int cleanVBILU( vbiluptr lu ){ /*---------------------------------------------------------------------- | Free up memory allocated for VBILUSpar structs. |---------------------------------------------------------------------- | on entry: |========== | ( lu ) = Pointer to a VBILUSpar struct. |--------------------------------------------------------------------*/ int n = lu->n, i; if( NULL == lu ) return 0; if( lu->D ) { for( i = 0; i < n; i++ ) { if( lu->D[i] ) free( lu->D[i] ); } free( lu->D ); } if( lu->bsz ) free( lu->bsz ); cleanVBMat( lu->L ); cleanVBMat( lu->U ); if( lu->work ) free( lu->work ); if( lu->bf ) free( lu->bf ); free( lu ); return 0; } /*--------------------------------------------------------------------- | end of cleanVBILU |--------------------------------------------------------------------*/ int mallocRow( iluptr lu, int nrow ) { /*---------------------------------------------------------------------- | Prepare space of a row according to the result of level structure |---------------------------------------------------------------------- | on entry: |========== | ( lu ) = Pointer to a ILUSpar struct. | nrow = the current row to deal with | | On return: |=========== | | lu->L->ma[nrow][...] | ->U->ma[nrow][...] | | integer value returned: | 0 --> successful return. | -1 --> memory allocation error. |--------------------------------------------------------------------*/ int nzcount = lu->L->nzcount[nrow]; lu->L->ma[nrow] = (double *)Malloc( sizeof(double)*nzcount, "mallocRow" ); nzcount = lu->U->nzcount[nrow]; lu->U->ma[nrow] = (double *)Malloc( sizeof(double)*nzcount, "mallocRow" ); return 0; } /*--------------------------------------------------------------------- | end of mallocVBRow |--------------------------------------------------------------------*/ int mallocVBRow( vbiluptr lu, int nrow ) { /*---------------------------------------------------------------------- | Prepare space of a row according to the result of level structure |---------------------------------------------------------------------- | on entry: |========== | ( lu ) = Pointer to a VBILUSpar struct. | nrow = the current row to deal with | | On return: |=========== | | lu->L->ba[nrow][...] | ->D[nrow] | ->U->ba[nrow][...] | | integer value returned: | 0 --> successful return. | -1 --> memory allocation error. |--------------------------------------------------------------------*/ int j, nzcount, ncol, szOfBlock; int *bsz = lu->bsz; nzcount = lu->L->nzcount[nrow]; lu->L->ba[nrow] = (BData *)Malloc( sizeof(BData)*nzcount, "mallocVBRow" ); for( j = 0; j < nzcount; j++ ) { ncol = lu->L->ja[nrow][j]; szOfBlock = B_DIM(bsz,nrow)*B_DIM(bsz,ncol)*sizeof(double); lu->L->ba[nrow][j] = (BData)Malloc( szOfBlock, "mallocVBRow" ); } szOfBlock = sizeof(double) * B_DIM(bsz,nrow) * B_DIM(bsz,nrow); lu->D[nrow] = (BData)Malloc( szOfBlock, "mallocVBRow" ); nzcount = lu->U->nzcount[nrow]; lu->U->ba[nrow] = (BData *)Malloc( sizeof(BData)*nzcount, "mallocVBRow" ); for( j = 0; j < nzcount; j++ ) { ncol = lu->U->ja[nrow][j]; szOfBlock = B_DIM(bsz,nrow)*B_DIM(bsz,ncol)*sizeof(double); lu->U->ba[nrow][j] = (BData)Malloc( szOfBlock, "mallocVBRow" ); } return 0; } /*--------------------------------------------------------------------- | end of mallocVBRow |--------------------------------------------------------------------*/ void zrmC( int m, int n, BData data ){ int mn = m * n, i; for( i = 0; i < mn; i++ ) data[i] = 0; } void copyBData( int m, int n, BData dst, BData src, int isig ){ int mm = m * n, i; if( isig == 0 ) for( i = 0; i < mm; i++ ) dst[i] = src[i]; else for( i = 0; i < mm; i++ ) dst[i] = -src[i]; } int setupP4 (p4ptr amat, int Bn, int Cn, csptr F, csptr E) { /*---------------------------------------------------------------------- | initialize PerMat4 struct given the F, E, blocks. |---------------------------------------------------------------------- | on entry: |========== | ( amat ) = Pointer to a PerMat4 struct. | Bn = size of B block | Cn = size of C block | F, E = the two blocks to be assigned to srtruct - without the | | On return: |=========== | | amat->L for each block: amat->M->n | ->U ->nzcount | ->E ->ja | ->F ->ma | ->perm | ->rperm (if meth[1] > 0) | ->D1 (if meth[2] > 0) | ->D2 (if meth[3] > 0) | | Scaling arrays are initialized to 1.0. | | integer value returned: | 0 --> successful return. | 1 --> memory allocation error. |--------------------------------------------------------------------*/ int n; /* size n */ n = amat->n = Bn + Cn; amat->nB = Bn; /* amat->perm = (int *) Malloc(n*sizeof(int), "setupP4:1" ); */ /* assign space for wk -- note that this is only done at 1st level at other levels, copy pointer of wk from previous level */ if (amat->prev == NULL) /* wk has 2 * n entries now */ amat->wk = (double *) Malloc(2*n*sizeof(double), "setupP4:2" ); else amat->wk = (amat->prev)->wk; /*-------------------- L and U */ amat->L = (csptr) Malloc(sizeof(SparMat), "setupP4:3" ); if (setupCS(amat->L, Bn,1)) return 1; /* fprintf(stdout," -- BN %d Cn %d \n", Bn,Cn); */ amat->U = (csptr) Malloc(sizeof(SparMat), "setupP4:4" ); if (setupCS(amat->U, Bn,1)) return 1; amat->F = F; amat->E = E; return 0; } /*--------------------------------------------------------------------- | end of setupP4 |--------------------------------------------------------------------*/ int cleanP4(p4ptr amat) { /*---------------------------------------------------------------------- | Free up memory allocated for Per4Mat structs. |---------------------------------------------------------------------- | on entry: |========== | ( amat ) = Pointer to a Per4Mat struct. |--------------------------------------------------------------------*/ /* -------------------------- */ if (amat == NULL) return 0; if (amat->n < 1) return 0; if (amat->perm) { if (amat->perm) free(amat->perm); amat->perm = NULL; } if (!amat->symperm) { if (amat->rperm) free(amat->rperm); amat->rperm = NULL; } if (amat->F) { cleanCS(amat->F); amat->F = NULL; } if (amat->E) { cleanCS(amat->E); amat->E = NULL; } if (amat->L) { cleanCS(amat->L); amat->L = NULL; } if (amat->U) { cleanCS(amat->U); amat->U = NULL; } if (amat->prev == NULL) if (amat->wk) free(amat->wk); if (amat->D1) free(amat->D1); if (amat->D2) free(amat->D2); return 0; } /*--------------------------------------------------------------------- | end of cleanP4 |--------------------------------------------------------------------*/ int setupILUT(ilutptr amat, int len) { /*---------------------------------------------------------------------- | Allocate pointers for ILUTfac structs. |---------------------------------------------------------------------- | on entry: |========== | ( amat ) = Pointer to a ILUTfac struct. | len = size of L U blocks | | On return: |=========== | | amat->L for each block: amat->M->n | ->U ->nzcount | ->ja | ->ma | ->rperm (if meth[0] > 0) | ->perm2 (if meth[1] > 0) | ->D1 (if meth[2] > 0) | ->D2 (if meth[3] > 0) | | Permutation arrays are initialized to the identity. | Scaling arrays are initialized to 1.0. | | integer value returned: | 0 --> successful return. | 1 --> memory allocation error. |--------------------------------------------------------------------*/ amat->n = len; amat->wk = (double *) Malloc(2*len*sizeof(double), "setupILUT:5" ); amat->L = (csptr) Malloc(sizeof(SparMat), "setupILUT:6" ); if (setupCS(amat->L, len,1)) return 1; amat->U = (csptr) Malloc(sizeof(SparMat), "setupILUT:7" ); if (setupCS(amat->U, len,1)) return 1; return 0; } /*--------------------------------------------------------------------- | end of setupILUT |--------------------------------------------------------------------*/ int cleanILUT(ilutptr amat, int indic) { /*---------------------------------------------------------------------- | Free up memory allocated for IluSpar structs. |---------------------------------------------------------------------- | on entry: |========== | ( amat ) = Pointer to a IluSpar struct. | indic = indicator for number of levels. indic=0 -> zero level. |--------------------------------------------------------------------*/ /*----------------*/ if (amat->wk) { free(amat->wk); amat->wk = NULL; } cleanCS(amat->L); cleanCS(amat->U); if (indic) cleanCS(amat->C); /*-------------------- nonsymmetric permutation */ if (amat->rperm) { free(amat->rperm); amat->rperm = NULL; } if (amat->perm) { free(amat->perm); amat->perm = NULL; } /*-------------------- ilutp permutation */ if (amat->perm2) free(amat->perm2); /*-------------------- diagonal scalings */ if (amat->D1) free(amat->D1); if (amat->D2) free(amat->D2); return 0; } /*--------------------------------------------------------------------- | end of cleanILUT |--------------------------------------------------------------------*/ void setup_arms (arms Levmat) { Levmat->ilus = (ilutptr) Malloc(sizeof(IluSpar), "setup_arms:ilus" ); Levmat->levmat = (p4ptr) Malloc(sizeof(Per4Mat), "setup_arms:levmat" ); } int cleanARMS(arms ArmsPre) { p4ptr amat = ArmsPre->levmat; ilutptr cmat = ArmsPre->ilus; /*---------------------------------------------------------------------- | Free up memory allocated for entire ARMS preconditioner. |---------------------------------------------------------------------- | on entry: |========== | ( amat ) = Pointer to a Per4Mat struct. | ( cmat ) = Pointer to a IluSpar struct. |--------------------------------------------------------------------*/ /* case when nlev == 0 */ int indic=(amat->nB != 0) ; /* && amat->next !=NULL) ; */ p4ptr levc, levn; levc = amat; if (indic) { while (levc) { if (cleanP4(levc)) return(1) ; levn = levc->next; free(levc); levc = levn; } } else if (amat) { free(amat) ; amat = NULL; } cleanILUT(cmat,indic); if (cmat) { free(cmat); cmat = NULL; } return 0; } /*--------------------------------------------------------------------- | end of cleanARMS |--------------------------------------------------------------------*/ int csSplit4(csptr amat, int bsize, int csize, csptr B, csptr F, csptr E, csptr C) { /*--------------------------------------------------------------------- | Convert permuted csrmat struct to PerMat4 struct | - matrix already permuted |---------------------------------------------------------------------- | on entry: |========== | ( amat ) = Matrix stored in SpaFmt format. | Internal pointers (and associated memory) destroyed before | return. | | On return: |=========== | | B, E, F, C = 4 blocks in | | | B F | | Amat = | | | | E C | | | | integer value returned: | 0 --> successful return. | 1 --> memory allocation error. |--------------------------------------------------------------------*/ int j, j1, numr, numl, ind, newj, rowz, *rowj, *new1j, *new2j; double *rowm, *new1m, *new2m; /*--------------------------------------------------------------------- | Sort the matrix and separate into | B F | | | | | | E C | |--------------------------------------------------------------------*/ if (setupCS(B,bsize,1)) goto label111; if (setupCS(F,bsize,1)) goto label111; if (setupCS(E,csize,1)) goto label111; if (setupCS(C,csize,1)) goto label111; new1j = (int *) Malloc(bsize*sizeof(int), "csSplit4:1" ); new2j = (int *) Malloc(csize*sizeof(int), "csSplit4:2" ); new1m = (double *) Malloc(bsize*sizeof(double), "csSplit4:3" ); new2m = (double *) Malloc(csize*sizeof(double), "csSplit4:4" ); /* B and F blocks */ for (j=0; jnzcount[j]; rowj = amat->ja[j]; rowm = amat->ma[j]; for (j1=0; j1nzcount[j] = numl; F->nzcount[j] = numr; if (numl>0) { B->ja[j] = (int *) Malloc(numl*sizeof(int), "csSplit4:5" ); B->ma[j] = (double *) Malloc(numl*sizeof(double), "csSplit4:6" ); } if (numr>0) { F->ja[j] = (int *) Malloc(numr*sizeof(int), "csSplit4:7" ); F->ma[j] = (double *) Malloc(numr*sizeof(double), "csSplit4:8" ); } numl = numr = 0; for (j1=0; j1ja[j], new1j, numl*sizeof(int)); memcpy(B->ma[j], new1m, numl*sizeof(double)); memcpy(F->ja[j], new2j, numr*sizeof(int)); memcpy(F->ma[j], new2m, numr*sizeof(double)); } /* E and C blocks */ for (j=0; jnzcount[ind]; rowj = amat->ja[ind]; rowm = amat->ma[ind]; for (j1=0; j1nzcount[j] = numl; C->nzcount[j] = numr; if (numl>0) { E->ja[j] = (int *) Malloc(numl*sizeof(int), "csSplit4:9" ); E->ma[j] = (double *) Malloc(numl*sizeof(double), "csSplit4:10" ); } if (numr>0) { C->ja[j] = (int *) Malloc(numr*sizeof(int), "csSplit4:11" ); C->ma[j] = (double *) Malloc(numr*sizeof(double), "csSplit4:12" ); } numl = numr = 0; for (j1=0; j1ja[j], new1j, numl*sizeof(int)); memcpy(E->ma[j], new1m, numl*sizeof(double)); memcpy(C->ja[j], new2j, numr*sizeof(int)); memcpy(C->ma[j], new2m, numr*sizeof(double)); } if (new1j) free(new1j); if (new2j) free(new2j); if (new1m) free(new1m); if (new2m) free(new2m); return 0; label111: return 1; } /*--------------------------------------------------------------------- | end of csSplit4 |--------------------------------------------------------------------*/ int CSRcs( int n, double *a, int *ja, int *ia, csptr mat, int rsa ) { /*---------------------------------------------------------------------- | Convert CSR matrix to SpaFmt struct |---------------------------------------------------------------------- | on entry: |========== | a, ja, ia = Matrix stored in CSR format (with FORTRAN indexing). | rsa = source file is symmetric HB matrix | | On return: |=========== | | ( mat ) = Matrix stored as SpaFmt struct. | | integer value returned: | 0 --> successful return. | 1 --> memory allocation error. |--------------------------------------------------------------------*/ int i, j, j1, len, col, nnz; double *bra; int *bja; /* setup data structure for mat (csptr) struct */ setupCS( mat, n, 1 ); if( rsa ) { /* RSA HB matrix */ for( j = 0; j < n; j++ ) { len = ia[j+1] - ia[j]; mat->nzcount[j] = len; } for( j = 0; j < n; j++ ) { for( j1 = ia[j]-1; j1 < ia[j+1]-1; j1++ ) { col = ja[j1] - 1; if( col != j ) mat->nzcount[col]++; } } for( j = 0; j < n; j++ ) { nnz = mat->nzcount[j]; mat->ja[j] = (int *)Malloc( nnz * sizeof(int), "CSRcs" ); mat->ma[j] = (double *)Malloc( nnz * sizeof(double), "CSRcs" ); mat->nzcount[j] = 0; } for( j = 0; j < n; j++ ) { for( j1 = ia[j]-1; j1 < ia[j+1]-1; j1++ ) { col = ja[j1] - 1; mat->ja[j][mat->nzcount[j]] = col; mat->ma[j][mat->nzcount[j]] = a[j1]; mat->nzcount[j]++; if( col != j ) { mat->ja[col][mat->nzcount[col]] = j; mat->ma[col][mat->nzcount[col]] = a[j1]; mat->nzcount[col]++; } } } return 0; } for (j=0; jnzcount[j] = len; if (len > 0) { bja = (int *) Malloc( len*sizeof(int), "CSRcs" ); bra = (double *) Malloc( len*sizeof(double), "CSRcs" ); i = 0; for (j1=ia[j]-1; j1ja[j] = bja; mat->ma[j] = bra; } } return 0; } /*--------------------------------------------------------------------- | end of CSRcs |--------------------------------------------------------------------*/ int COOcs(int n, int nnz, double *a, int *ja, int *ia, csptr bmat) { /*---------------------------------------------------------------------- | Convert COO matrix to SpaFmt struct |---------------------------------------------------------------------- | on entry: |========== | a, ja, ia = Matrix stored in COO format -- a = entries | ja = column indices | ia = row indices | On return: |=========== | | ( bmat ) = Matrix stored as SpaFmt struct. | | integer value returned: | 0 --> successful return. | 1 --> memory allocation error. |--------------------------------------------------------------------*/ int i, k, k1, l, job = 1; int *len; int setupCS(csptr, int, int); /*-------------------- setup data structure for bmat (csptr) struct */ if (setupCS(bmat, n, job)) { printf(" ERROR SETTING UP bmat IN SETUPCS \n") ; exit(0); } /* */ /*-------------------- determine lengths */ len = (int*) Malloc(n*sizeof(int), "COOcs:0" ); for (k=0; knzcount[k] = l; if (l > 0) { bmat->ja[k] = (int *) Malloc(l*sizeof(int), "COOcs:1" ); bmat->ma[k] = ( double *) Malloc(l*sizeof( double),"COOcs:2" ); } len[k] = 0; } /*-------------------- Fill actual entries */ for (k=0; kja[i])[k1] = ja[k] ; (bmat->ma[i])[k1] = a[k] ; len[i]++; } free(len); return 0; } /*--------------------------------------------------------------------- | end of COOcs |--------------------------------------------------------------------*/ int csrvbsrC( int job, int nBlk, int *nB, csptr csmat, vbsptr vbmat ) { /*---------------------------------------------------------------------- * Compressed C-style Sparse Row to C-style Various Block Sparse Row *---------------------------------------------------------------------- * * This subroutine converts a matrix stored in a C-style SpaFmt format * into a C-style various block SpaFmt format * * NOTE: the initial matrix does not have to have a block structure. * zero padding is done for general sparse matrices. * *---------------------------------------------------------------------- * on entry: *---------- * job = if job == 0 on entry, pattern only is generated. * * nBlk = integer equal to the dimension of block matrix. * * nB = integer array of diagonals' block size * * csmat = Sparse Row format Matrix * * on return: *----------- * * vbmat = Various Block Sparse Row format Matrix * * ierr = integer, error code. * 0 -- normal termination * -1 -- error occur * *---------------------------------------------------------------------*/ int n, i, j, k; int nnz, szofBlock, ipos, b_row, b_col, br, bc; int *iw = NULL; n = csmat->n; /* size of the original matrix */ setupVBMat( vbmat, nBlk, nB ); iw = (int *)Malloc( sizeof(int)*nBlk, "csrvbsrC_1" ); for( i = 0; i < nBlk; i++ ) iw[i] = 0; b_row = -1; for( i = 0; i < n; i += nB[b_row] ) { vbmat->nzcount[++b_row] = 0; /* calculate nzcount of the (b_row)-th row of the block matrix */ for( j = i; j < i+nB[b_row]; j++ ) { int nnz_j = csmat->nzcount[j]; for( k = 0; k < nnz_j; k++ ) { /* get the column ID of block matrix by giving the column ID of the original matrix */ b_col = col2vbcol( csmat->ja[j][k], vbmat ); if( iw[b_col] == 0 ) { iw[b_col] = 1; vbmat->nzcount[b_row]++; } } } if( 0 == ( nnz = vbmat->nzcount[b_row] ) ) continue; vbmat->ja[b_row] = (int *)Malloc( sizeof(int)*nnz, "csrvbsrC_2" ); /* calculate the pattern of the (b_row)-th row of the block matrix */ for( j = 0, ipos = 0; j < nBlk; j++ ) { if( iw[j] != 0 ) { vbmat->ja[b_row][ipos] = j; iw[j] = ipos; ipos++; } } if( job == 0 ) goto NEXT_ROW; /* stop here if patterns only */ /* copy data to the (b_row)-th row of the block matrix from the original matrix */ vbmat->ba[b_row] = (BData *)Malloc( sizeof(BData)*nnz, "csrvbsrC_3" ); for( j = 0; j < nnz; j++ ) { szofBlock = sizeof(double)*nB[b_row]*nB[vbmat->ja[b_row][j]]; vbmat->ba[b_row][j] = (BData)Malloc( szofBlock, "csrvbsrC_4" ); memset( vbmat->ba[b_row][j], 0, szofBlock ); } for( j = i; j < i+nB[b_row]; j++ ) { for( k = 0; k < csmat->nzcount[j]; k++ ) { /* get the column ID of block matrix by giving the column ID of the original matrix */ b_col = col2vbcol( csmat->ja[j][k], vbmat ); ipos = iw[b_col]; br = j - i; bc = csmat->ja[j][k] - vbmat->bsz[b_col]; DATA(vbmat->ba[b_row][ipos],nB[b_row],br,bc) = csmat->ma[j][k]; } } NEXT_ROW: /* reset iw */ for( j = 0; j < nnz; j++ ) iw[vbmat->ja[b_row][j]] = 0; } free( iw ); return 0; } int col2vbcol( int col, vbsptr vbmat ) { /*--------------------------------------------------------------------- * get the column ID of block matrix by giving the column ID of the original * matrix *--------------------------------------------------------------------*/ int *bsz = vbmat->bsz, n = vbmat->n; int begin = 0, mid, end = n-1; while( end - begin > 1 ) { mid = (begin+end)/2; if( col < bsz[mid] ) { end = mid; } else if( col >= bsz[mid+1] ) { begin = mid; } else { return mid; } } if( col >= bsz[end] ) { return end; } return begin; } int nnz_vbilu(vbiluptr lu ) { /*-------------------- counts number of nonzero entries in preconditioner */ int *bsz = lu->bsz; int nzcount, nnz = 0, i, j, col; for( i = 0; i < lu->n; i++ ) { nzcount = 0; for( j = 0; j < lu->L->nzcount[i]; j++ ) { col = lu->L->ja[i][j]; nzcount += B_DIM(bsz,col); } for( j = 0; j < lu->U->nzcount[i]; j++ ) { col = lu->U->ja[i][j]; nzcount += B_DIM(bsz,col); } nzcount += B_DIM(bsz,i); /* diagonal */ nzcount *= B_DIM(bsz,i); nnz += nzcount; } return nnz; } int nnz_ilu( iluptr lu ) { int nnz = 0, i; for( i = 0; i < lu->n; i++ ) { nnz += lu->L->nzcount[i]; nnz += lu->U->nzcount[i]; nnz++; } return nnz; } int lev4_nnz(p4ptr levmat, int *lev, FILE *ft) { /* counts all nonzero elements in levmat struct -- recursive */ int nnzT, nnzL, nnzU, nnzF, nnzE, nnzDown=0; p4ptr nextmat; nnzL = cs_nnz(levmat->L); nnzU = cs_nnz(levmat->U); nnzF = cs_nnz(levmat->F); nnzE = cs_nnz(levmat->E); nnzT = nnzL+nnzU+nnzF+nnzE; /* print */ if (*lev == 0) fprintf(ft, "\nnnz/lev used: L U F E subtot\n"); fprintf(ft," Level %2d %8d %8d %8d %8d %8d\n", *lev, nnzL, nnzU, nnzF, nnzE, nnzT); (*lev)++; nextmat = levmat->next; if (nextmat != NULL) nnzDown = lev4_nnz(nextmat, lev, ft); return (nnzT+nnzDown); } int cs_nnz (csptr A) { /* counts the number of nonzero elements in CSR matrix A */ int i, n, nnz=0; n = A->n; for (i=0; inzcount[i]; return nnz; } int nnz_arms (arms PreSt, FILE *ft) { /*------------------------------------------------------- | computes and prints out total number of nonzero elements | used in ARMS factorization +--------------------------------------------------------*/ p4ptr levmat = PreSt->levmat; ilutptr ilschu = PreSt->ilus; int nlev = PreSt->nlev; int ilev=0,nnz_lev,nnz_sch,nnz_tot; nnz_lev = 0; if (nlev) nnz_lev+= lev4_nnz(levmat, &ilev, ft); nnz_sch = cs_nnz(ilschu->L)+cs_nnz(ilschu->U); if (nlev) nnz_sch += cs_nnz(ilschu->C); nnz_tot = nnz_lev+nnz_sch; fprintf(ft,"\n"); fprintf(ft,"Total nonzeros for interm. blocks.... = %10d\n",nnz_lev); fprintf(ft,"Total nonzeros for last level ....... = %10d\n",nnz_sch); fprintf(ft,"Grand total.......................... = %10d\n",nnz_tot); return nnz_tot; } int outputLU( iluptr lu, char *filename ){ /*---------------------------------------------------------------------- | Output the pattern of L\U, which can be loaded by matlab ----------------------------------------------------------------------*/ FILE *fmatlab = fopen( filename, "w" ); int n = lu->n, i, j, nzcount; csptr L = lu->L, U = lu->U; if( !fmatlab ) return -1; fprintf( fmatlab, "%d %d 0\n", n, n ); for( i = 0; i < n; i++ ) { nzcount = L->nzcount[i]; for( j = 0; j < nzcount; j++ ) fprintf( fmatlab, "%d %d 1\n", i+1, L->ja[i][j]+1 ); } for( i = 0; i < n; i++ ) { nzcount = U->nzcount[i]; for( j = 0; j < nzcount; j++ ) fprintf( fmatlab, "%d %d 1\n", i+1, U->ja[i][j]+1 ); } for( i = 0; i < n; i++ ) fprintf( fmatlab, "%d %d 1\n", i+1, i+1 ); fclose( fmatlab ); return 0; } /*-------------------- ilduc -- */ itsol-1.0.0/LIB/piluNEW.c0000640000265600020320000005237111062577473014103 0ustar tilleaadmin#include #include #include #include #include "globheads.h" #include "protos.h" int pilu(p4ptr amat, csptr B, csptr C, double *droptol, int *lfil, csptr schur) { /*---------------------------------------------------------------------- | PARTIAL ILUT - | Converted to C so that dynamic memory allocation may be implememted | in order to have no dropping in block LU factors. |---------------------------------------------------------------------- | Partial block ILU factorization with dual truncation. | | | B F | | L 0 | | U L^{-1} F | | | | = | | * | | | | E C | | E U^{-1} I | | 0 S | | | where B is a sub-matrix of dimension B->n. | |---------------------------------------------------------------------- | | on entry: |========== | ( amat ) = Permuted matrix stored in a PerMat4 struct on entry -- | Individual matrices stored in SpaFmt structs. | On entry matrices have C (0) indexing. | on return contains also L and U factors. | Individual matrices stored in SpaFmt structs. | On return matrices have C (0) indexing. | | lfil[0] = number nonzeros in L-part | lfil[1] = number nonzeros in U-part | lfil[2] = number nonzeros in L^{-1} F | lfil[3] = not used | lfil[4] = number nonzeros in Schur complement | | droptol[0] = threshold for dropping small terms in L during | factorization. | droptol[1] = threshold for dropping small terms in U. | droptol[2] = threshold for dropping small terms in L^{-1} F during | factorization. | droptol[3] = threshold for dropping small terms in E U^{-1} during | factorization. | droptol[4] = threshold for dropping small terms in Schur complement | after factorization is completed. | | On return: |=========== | | (schur) = contains the Schur complement matrix (S in above diagram) | stored in SpaFmt struct with C (0) indexing. | | | integer value returned: | | 0 --> successful return. | 1 --> Error. Input matrix may be wrong. (The | elimination process has generated a | row in L or U whose length is > n.) | 2 --> Memory allocation error. | 5 --> Illegal value for lfil or last. | 6 --> zero row in B block encountered. | 7 --> zero row in [E C] encountered. | 8 --> zero row in new Schur complement |----------------------------------------------------------------------- | work arrays: |============= | jw, jwrev = integer work arrays of length B->n. | w = real work array of length B->n. | jw2, jwrev2 = integer work arrays of length C->n. | w2 = real work array of length C->n. |----------------------------------------------------------------------- | All processing is done using C indexing. |--------------------------------------------------------------------*/ int i, ii, j, jj, jcol, jpos, jrow, k, *jw, *jwrev; int **lfja, *lflen, len, len2, lenu, lenl, rmax; int *jw2, *jwrev2, lsize, rsize; int fil0=lfil[0],fil1=lfil[1],fil2=lfil[2],fil4=lfil[4]; double tnorm, tabs, tmax, t, s, fact, *w, *w2, **lfma; double drop0=droptol[0], drop1=droptol[1], drop2=droptol[2]; double drop3=droptol[3], drop4=droptol[4]; int lrowz, *lrowj, rrowz, *rrowj; double *lrowm, *rrowm; /*-----------------------------------------------------------------------*/ lsize = amat->nB; rsize = C->n; rmax = lsize > rsize ? lsize : rsize; jw = (int *) Malloc(rmax*sizeof(int), "pilu:1" ); w = (double *) Malloc(rmax*sizeof(double), "pilu:2" ); jwrev = (int *) Malloc(rmax*sizeof(int), "pilu:3" ); jw2 = (int *) Malloc(rmax*sizeof(int), "pilu:4" ); w2 = (double *) Malloc(rmax*sizeof(double), "pilu:5" ); jwrev2 = (int *) Malloc(rmax*sizeof(int), "pilu:6" ); if (fil0 < 0 || fil1<0 || amat->L->n<=0) goto label9995; lfma = (double **) Malloc(lsize*sizeof(double *), "pilu:7" ); lfja = (int **) Malloc(lsize*sizeof(int *), "pilu:8" ); lflen = (int *) Malloc(lsize*sizeof(int), "pilu:9" ); /*--------------------------------------------------------------------- | beginning of first main loop - L, U, L^{-1}F calculations |--------------------------------------------------------------------*/ for (j=0; jja[ii]; lrowm = B->ma[ii]; lrowz = B->nzcount[ii]; rrowj = amat->F->ja[ii]; rrowm = amat->F->ma[ii]; rrowz = amat->F->nzcount[ii]; /*--------------------------------------------------------------------- | check for zero row in B block |--------------------------------------------------------------------*/ for (k=0; kU->ma[jrow]; fact = w[jj] * lrowm[0]; if (fabs(fact) > drop0 ) { /* DROPPING IN L */ lrowj = amat->U->ja[jrow]; lrowz = amat->U->nzcount[jrow]; rrowj = lfja[jrow]; rrowm = lfma[jrow]; rrowz = lflen[jrow]; /*--------------------------------------------------------------------- | combine current row and row jrow |--------------------------------------------------------------------*/ for (k=1; k= ii) { /*--------------------------------------------------------------------- | this is a fill-in element |--------------------------------------------------------------------*/ if (jpos == -1) { if (lenu > lsize) {printf("U row = %d\n",ii); goto label9991;} i = ii + lenu; jw[i] = j; jwrev[j] = i; w[i] = - s; lenu++; } /*--------------------------------------------------------------------- | this is not a fill-in element |--------------------------------------------------------------------*/ else w[jpos] -= s; } /*--------------------------------------------------------------------- | dealing with L |--------------------------------------------------------------------*/ else { /*--------------------------------------------------------------------- | this is a fill-in element |--------------------------------------------------------------------*/ if (jpos == -1) { if (lenl > lsize) {printf("L row = %d\n",ii); goto label9991;} jw[lenl] = j; jwrev[j] = lenl; w[lenl] = - s; lenl++; } /*--------------------------------------------------------------------- | this is not a fill-in element |--------------------------------------------------------------------*/ else w[jpos] -= s; } } /*--------------------------------------------------------------------- | dealing with L^{-1} F |--------------------------------------------------------------------*/ for (k=0; k fil0 ? fil0 : len; amat->L->nzcount[ii] = lenl; if (lenl < len) qsplitC(w, jw, len, lenl); if (len > 0) { amat->L->ja[ii] = (int *) Malloc(lenl*sizeof(int), "pilu:10" ); amat->L->ma[ii] = (double *) Malloc(lenl*sizeof(double), "pilu:11" ); memcpy(amat->L->ja[ii], jw, lenl*sizeof(int)); memcpy(amat->L->ma[ii], w, lenl*sizeof(double)); } /*--------------------------------------------------------------------- | store the diagonal element of U | dropping in U if size is less than drop1 * diagonal entry |--------------------------------------------------------------------*/ t = w[ii]; tnorm = fabs(t); len = 0; for (j=1; j drop1*tnorm ) { w[len] = w[ii+j]; jw[len] = jw[ii+j]; len++; } } lenu = len+1 > fil1 ? fil1 : len+1; amat->U->nzcount[ii] = lenu; jpos = lenu-1; if (jpos < len) qsplitC(w, jw, len, jpos); amat->U->ma[ii] = (double *) Malloc(lenu*sizeof(double), "pilu:12" ); amat->U->ja[ii] = (int *) Malloc(lenu*sizeof(int), "pilu:13" ); if (t == 0.0) t=(0.0001+drop1); amat->U->ma[ii][0] = 1.0 / t; amat->U->ja[ii][0] = ii; /*--------------------------------------------------------------------- | copy the rest of U |--------------------------------------------------------------------*/ memcpy(&amat->U->ja[ii][1], jw, jpos*sizeof(int)); memcpy(&amat->U->ma[ii][1], w, jpos*sizeof(double)); /*--------------------------------------------------------------------- | copy L^{-1} F |--------------------------------------------------------------------*/ len = 0; for (j=0; j drop2*tnorm ) { w[len] = w2[j]; jw[len] = jw2[j]; len++; } } lenu = len > fil2 ? fil2 : len; if (lenu < len) qsplitC(w, jw, len, lenu); lflen[ii] = lenu; if (lenu > 0) { lfja[ii] = (int *) Malloc(lenu*sizeof(int), "pilu:14" ); lfma[ii] = (double *) Malloc(lenu*sizeof(double), "pilu:15" ); memcpy(lfma[ii], w, lenu*sizeof(double)); memcpy(lfja[ii], jw, lenu*sizeof(int)); } } /*--------------------------------------------------------------------- | beginning of second main loop E U^{-1} and Schur complement |--------------------------------------------------------------------*/ for (ii=0; iiE->ja[ii]; lrowm = amat->E->ma[ii]; lrowz = amat->E->nzcount[ii]; rrowj = C->ja[ii]; rrowm = C->ma[ii]; rrowz = C->nzcount[ii]; /*--------------------------------------------------------------------- | determine if there is a zero row in [ E C ] |-------------------------------------------------------------------- for (k=0; kU->ma[jrow]; fact = w[jj] * lrowm[0]; if ( fabs(fact) > drop3 ) { /* DROPPING IN E U^{-1} */ lrowj = amat->U->ja[jrow]; lrowz = amat->U->nzcount[jrow]; rrowj = lfja[jrow]; rrowm = lfma[jrow]; rrowz = lflen[jrow]; /*--------------------------------------------------------------------- | combine current row and row jrow - first E U^{-1} |--------------------------------------------------------------------*/ for (k=1; k lsize) {printf(" E U^{-1} row = %d\n",ii); goto label9991;} jw[lenl] = j; jwrev[j] = lenl; w[lenl] = - s; lenl++; } /*--------------------------------------------------------------------- | this is not a fill-in element |--------------------------------------------------------------------*/ else w[jpos] -= s; } /*--------------------------------------------------------------------- | incorporate into Schur complement C - (E U^{-1}) (L^{-1} F) |--------------------------------------------------------------------*/ for (k=0; k tnorm) tnorm = fabs(w2[j]); */ if (tnorm == 0.0) { len = 1; w[0] = 1.0; jw[0] = ii; } else { len = 0; /* tabs = drop4*tmax*(tmax/tnorm); */ tabs = drop4*tmax*tmax/( tnorm * (double) lenu); for (j=0; j tabs) { w[len] = w2[j]; jw[len] = jw2[j]; len++; } } } lenu = len > fil4 ? fil4 : len; schur->nzcount[ii] = lenu; jpos = lenu; if (jpos < len) qsplitC(w, jw, len, jpos); schur->ma[ii] = (double *) Malloc(lenu*sizeof(double), "pilu:16" ); schur->ja[ii] = (int *) Malloc(lenu*sizeof(int), "pilu:17" ); /*--------------------------------------------------------------------- | copy --- |--------------------------------------------------------------------*/ memcpy(&schur->ja[ii][0], jw, jpos*sizeof(int)); memcpy(&schur->ma[ii][0], w, jpos*sizeof(double)); } /*--------------------------------------------------------------------- | end main loop - now do cleanup |--------------------------------------------------------------------*/ free(jw); free(w); free(jwrev); free(jw2); free(w2); free(jwrev2); for (i=0; i 0) { free(lfma[i]); free(lfja[i]); } } free(lfma); free(lfja); free(lflen); /*--------------------------------------------------------------------- | done -- correct return |--------------------------------------------------------------------*/ return 0; label9991: /* Incomprehensible error. Matrix must be wrong. */ return 1; /* label9992: Memory allocation error. return 2; */ label9995: /* illegal value for lfil or last entered */ return 5; label9996: /* zero row encountered */ /* printf("row = %d\n",ii+1); */ return 6; } /*--------------------------------------------------------------------- | end of pilut |--------------------------------------------------------------------*/ itsol-1.0.0/LIB/tools.f0000640000265600020320000007772611062577473013736 0ustar tilleaadminc----------------------------------------------------------------------- c some routines extracted/ modified from SPARSKIT2 + one from blas c----------------------------------------------------------------------- subroutine readmtc (nmax,nzmax,job,fname,a,ja,ia,rhs,nrhs, * guesol,nrow,ncol,nnz,title,key,type,ierr) c----------------------------------------------------------------------- c this subroutine reads a boeing/harwell matrix, given the c corresponding file. handles right hand sides in full format c only (no sparse right hand sides). Also the matrix must be c in assembled forms. c It differs from readmt, in that the name of the file needs c to be passed, and then the file is opened and closed within c this routine. c Author: Youcef Saad - Date: Oct 31, 1989 c updated Jul 20, 1998 by Irene Moulitsas c----------------------------------------------------------------------- c on entry: c--------- c nmax = max column dimension allowed for matrix. The array ia should c be of length at least ncol+1 (see below) if job.gt.0 c nzmax = max number of nonzeros elements allowed. the arrays a, c and ja should be of length equal to nnz (see below) if these c arrays are to be read (see job). c c job = integer to indicate what is to be read. (note: job is an c input and output parameter, it can be modified on return) c job = 0 read the values of ncol, nrow, nnz, title, key, c type and return. matrix is not read and arrays c a, ja, ia, rhs are not touched. c job = 1 read srtucture only, i.e., the arrays ja and ia. c job = 2 read matrix including values, i.e., a, ja, ia c job = 3 read matrix and right hand sides: a,ja,ia,rhs. c rhs may contain initial guesses and exact c solutions appended to the actual right hand sides. c this will be indicated by the output parameter c guesol [see below]. c c fname = name of the file where to read the matrix from. c c nrhs = integer. nrhs is an input as well as ouput parameter. c at input nrhs contains the total length of the array rhs. c See also ierr and nrhs in output parameters. c c on return: c---------- c job = on return job may be modified to the highest job it could c do: if job=2 on entry but no matrix values are available it c is reset to job=1 on return. Similarly of job=3 but no rhs c is provided then it is rest to job=2 or job=1 depending on c whether or not matrix values are provided. c Note that no error message is triggered (i.e. ierr = 0 c on return in these cases. It is therefore important to c compare the values of job on entry and return ). c c a = the a matrix in the a, ia, ja (column) storage format c ja = column number of element a(i,j) in array a. c ia = pointer array. ia(i) points to the beginning of column i. c c rhs = real array of size nrow + 1 if available (see job) c c nrhs = integer containing the number of right-hand sides found c each right hand side may be accompanied with an intial guess c and also the exact solution. c c guesol = a 2-character string indicating whether an initial guess c (1-st character) and / or the exact solution (2-nd c character) is provided with the right hand side. c if the first character of guesol is 'G' it means that an c an intial guess is provided for each right-hand side. c These are appended to the right hand-sides in the array rhs. c if the second character of guesol is 'X' it means that an c exact solution is provided for each right-hand side. c These are appended to the right hand-sides c and the initial guesses (if any) in the array rhs. c c nrow = number of rows in matrix c ncol = number of columns in matrix c nnz = number of nonzero elements in A. This info is returned c even if there is not enough space in a, ja, ia, in order c to determine the minimum storage needed. c c title = character*72 = title of matrix test ( character a*72). c key = character*8 = key of matrix c type = charatcer*3 = type of matrix. c for meaning of title, key and type refer to documentation c Harwell/Boeing matrices. c c ierr = integer used for error messages c * ierr = 0 means that the matrix has been read normally. c * ierr = 1 means that the array matrix could not be read c because ncol+1 .gt. nmax c * ierr = 2 means that the array matrix could not be read c because nnz .gt. nzmax c * ierr = 3 means that the array matrix could not be read c because both (ncol+1 .gt. nmax) and (nnz .gt. nzmax ) c * ierr = 4 means that the right hand side (s) initial c guesse (s) and exact solution (s) could not be c read because they are stored in sparse format (not handled c by this routine ...) c * ierr = 5 means that the right-hand-sides, initial guesses c and exact solutions could not be read because the length of c rhs as specified by the input value of nrhs is not c sufficient to store them. The rest of the matrix may have c been read normally. c c Notes: c------- c 1) This routine can be interfaced with the C language, since only c the name of the file needs to be passed and no iounti number. c c 2) Refer to the documentation on the Harwell-Boeing formats for c details on the format assumed by readmt. c We summarize the format here for convenience. c c a) all lines in inout are assumed to be 80 character long. c b) the file consists of a header followed by the block of the c column start pointers followed by the block of the row c indices, followed by the block of the real values and c finally the numerical values of the right-hand-side if a c right hand side is supplied. c c) the file starts by a header which contains four lines if no c right hand side is supplied and five lines otherwise. c * first line contains the title (72 characters long) c followed by the 8-character identifier (name of the c matrix, called key) [ A72,A8 ] c * second line contains the number of lines for each of the c following data blocks (4 of them) and the total number of c lines excluding the header. [5i4] c * the third line contains a three character string c identifying the type of matrices as they are referenced c in the Harwell Boeing documentation [e.g., rua, rsa,..] c and the number of rows, columns, nonzero entries. c [A3,11X,4I14] c * The fourth line contains the variable fortran format for c the following data blocks. [2A16,2A20] c * The fifth line is only present if right-hand-sides are c supplied. It consists of three one character-strings c containing the storage format for the right-hand-sides c ('F'= full,'M'=sparse=same as matrix), an initial guess c indicator ('G' for yes), an exact solution indicator c ('X' for yes), followed by the number of right-hand-sides c and then the number of row indices. [A3,11X,2I14] c d) The three following blocks follow the header as described c above. c e) In case the right hand-side are in sparse formats then the c fourth block uses the same storage format as for the c matrix to describe the NRHS right hand sides provided, c with a column being replaced by a right hand side. c----------------------------------------------------------------------- character title*72, key*8, type*3, ptrfmt*16, indfmt*16, & valfmt*20, rhsfmt*20, rhstyp*3, guesol*2 integer totcrd, ptrcrd, indcrd, valcrd, rhscrd, nrow, ncol, & nnz, neltvl, nrhs, nmax, nzmax, nrwindx integer ia (nmax+1), ja (nzmax) real*8 a(nzmax), rhs(*) character fname*100 c----------------------------------------------------------------------- ierr = 0 lenrhs = nrhs c iounit=15 open(iounit,file = fname) read (iounit,10) title, key, totcrd, ptrcrd, indcrd, valcrd, & rhscrd, type, nrow, ncol, nnz, neltvl, ptrfmt, indfmt, & valfmt, rhsfmt 10 format (a72, a8 / 5i14 / a3, 11x, 4i14 / 2a16, 2a20) c if (rhscrd .gt. 0) read (iounit,11) rhstyp, nrhs, nrwindx 11 format (a3,11x,i14,i14) c c anything else to read ? c if (job .le. 0) goto 12 c ---- check whether matrix is readable ------ n = ncol if (ncol .gt. nmax) ierr = 1 if (nnz .gt. nzmax) ierr = ierr + 2 if (ierr .ne. 0) goto 12 c ---- read pointer and row numbers ---------- read (iounit,ptrfmt) (ia (i), i = 1, n+1) read (iounit,indfmt) (ja (i), i = 1, nnz) c --- reading values of matrix if required.... if (job .le. 1) goto 12 c --- and if available ----------------------- if (valcrd .le. 0) then job = 1 goto 12 endif read (iounit,valfmt) (a(i), i = 1, nnz) c --- reading rhs if required ---------------- if (job .le. 2) goto 12 c --- and if available ----------------------- if ( rhscrd .le. 0) then job = 2 goto 12 endif c c --- read right-hand-side.-------------------- c if (rhstyp(1:1) .eq. 'M') then ierr = 4 goto 12 endif c guesol = rhstyp(2:3) c nvec = 1 if (guesol(1:1) .eq. 'G' .or. guesol(1:1) .eq. 'g') nvec=nvec+1 if (guesol(2:2) .eq. 'X' .or. guesol(2:2) .eq. 'x') nvec=nvec+1 c len = nrhs*nrow c if (len*nvec .gt. lenrhs) then ierr = 5 goto 12 endif c c read right-hand-sides c next = 1 iend = len read(iounit,rhsfmt) (rhs(i), i = next, iend) c c read initial guesses if available c if (guesol(1:1) .eq. 'G' .or. guesol(1:1) .eq. 'g') then next = next+len iend = iend+ len read(iounit,valfmt) (rhs(i), i = next, iend) endif c c read exact solutions if available c if (guesol(2:2) .eq. 'X' .or. guesol(2:2) .eq. 'x') then next = next+len iend = iend+ len read(iounit,valfmt) (rhs(i), i = next, iend) endif c 12 close(iounit) return c---------end-of-readmt_c----------------------------------------------- c----------------------------------------------------------------------- end c----------------------------------------------------------------------- subroutine csrcsc (n,job,ipos,a,ja,ia,ao,jao,iao) integer ia(n+1),iao(n+1),ja(*),jao(*) real*8 a(*),ao(*) c----------------------------------------------------------------------- c Compressed Sparse Row to Compressed Sparse Column c c (transposition operation) Not in place. c----------------------------------------------------------------------- c -- not in place -- c this subroutine transposes a matrix stored in a, ja, ia format. c --------------- c on entry: c---------- c n = dimension of A. c job = integer to indicate whether to fill the values (job.eq.1) of the c matrix ao or only the pattern., i.e.,ia, and ja (job .ne.1) c c ipos = starting position in ao, jao of the transposed matrix. c the iao array takes this into account (thus iao(1) is set to ipos.) c Note: this may be useful if one needs to append the data structure c of the transpose to that of A. In this case use for example c call csrcsc (n,1,ia(n+1),a,ja,ia,a,ja,ia(n+2)) c for any other normal usage, enter ipos=1. c a = real array of length nnz (nnz=number of nonzero elements in input c matrix) containing the nonzero elements. c ja = integer array of length nnz containing the column positions c of the corresponding elements in a. c ia = integer of size n+1. ia(k) contains the position in a, ja of c the beginning of the k-th row. c c on return: c ---------- c output arguments: c ao = real array of size nzz containing the "a" part of the transpose c jao = integer array of size nnz containing the column indices. c iao = integer array of size n+1 containing the "ia" index array of c the transpose. c c----------------------------------------------------------------------- call csrcsc2 (n,n,job,ipos,a,ja,ia,ao,jao,iao) end c----------------------------------------------------------------------- subroutine csrcsc2 (n,n2,job,ipos,a,ja,ia,ao,jao,iao) integer ia(n+1),iao(n2+1),ja(*),jao(*) real*8 a(*),ao(*) c----------------------------------------------------------------------- c Compressed Sparse Row to Compressed Sparse Column c c (transposition operation) Not in place. c----------------------------------------------------------------------- c Rectangular version. n is number of rows of CSR matrix, c n2 (input) is number of columns of CSC matrix. c----------------------------------------------------------------------- c -- not in place -- c this subroutine transposes a matrix stored in a, ja, ia format. c --------------- c on entry: c---------- c n = number of rows of CSR matrix. c n2 = number of columns of CSC matrix. c job = integer to indicate whether to fill the values (job.eq.1) of the c matrix ao or only the pattern., i.e.,ia, and ja (job .ne.1) c c ipos = starting position in ao, jao of the transposed matrix. c the iao array takes this into account (thus iao(1) is set to ipos.) c Note: this may be useful if one needs to append the data structure c of the transpose to that of A. In this case use for example c call csrcsc2 (n,n,1,ia(n+1),a,ja,ia,a,ja,ia(n+2)) c for any other normal usage, enter ipos=1. c a = real array of length nnz (nnz=number of nonzero elements in input c matrix) containing the nonzero elements. c ja = integer array of length nnz containing the column positions c of the corresponding elements in a. c ia = integer of size n+1. ia(k) contains the position in a, ja of c the beginning of the k-th row. c c on return: c ---------- c output arguments: c ao = real array of size nzz containing the "a" part of the transpose c jao = integer array of size nnz containing the column indices. c iao = integer array of size n+1 containing the "ia" index array of c the transpose. c c----------------------------------------------------------------------- c----------------- compute lengths of rows of transp(A) ---------------- do 1 i=1,n2+1 iao(i) = 0 1 continue do 3 i=1, n do 2 k=ia(i), ia(i+1)-1 j = ja(k)+1 iao(j) = iao(j)+1 2 continue 3 continue c---------- compute pointers from lengths ------------------------------ iao(1) = ipos do 4 i=1,n2 iao(i+1) = iao(i) + iao(i+1) 4 continue c--------------- now do the actual copying ----------------------------- do 6 i=1,n do 62 k=ia(i),ia(i+1)-1 j = ja(k) next = iao(j) if (job .eq. 1) ao(next) = a(k) jao(next) = i iao(j) = next+1 62 continue 6 continue c-------------------------- reshift iao and leave ---------------------- do 7 i=n2,1,-1 iao(i+1) = iao(i) 7 continue iao(1) = ipos c--------------- end of csrcsc2 ---------------------------------------- c----------------------------------------------------------------------- end c----------------------------------------------------------------------- subroutine gauss (n,a,ierr) c----------------------------------------------------------------------- implicit none integer n, ierr real*8 a(n,n) c c does the Gaussian factorization a := LU c integer i, j, k real*8 piv c----------------------------------------------------------------------- ierr = 0 do k=1, n if (a(k,k) .eq. 0.0) then ierr = 1 return endif c a(k,k) = 1.0/a(k,k) do i=k+1, n piv = a(i,k) * a(k,k) do j=k+1, n a(i,j) = a(i,j) - piv*a(k,j) enddo a(i,k) = piv enddo enddo return end c----------------------------------------------------------------------- subroutine bxinv (m, n, a, b, c) implicit none integer m, n real*8 a(n,n), b(m,n), c(m,n) c c does the operation c := - b * inv(a) c where a has already been factored by Gauss. c integer i, j, k real*8 sum c c c = b (LU)**(-1) = b U\inv x L \inv c get c := b U \inv c do i=1, m c c U solve -- solve for row number k : c(k,*) U = b(k,*) c c(i,1) = - b(i,1) * a(1,1) do j=2, n sum = - b(i,j) do k=1, j-1 sum = sum - c(i,k) * a(k,j) enddo c(i,j) = sum*a(j,j) enddo enddo c do i=1, m c c L- solve -- solve for row number i : c(i,*) U = b(i,*) c do j=n-1, 1, -1 sum = c(i,j) do k=j+1, n sum = sum - c(i,k) * a(k,j) enddo c(i,j) = sum enddo enddo c end c----------------------------------------------------------------------- subroutine qsplit(a,ind,n,ncut) real*8 a(n) integer ind(n), n, ncut c----------------------------------------------------------------------- c does a quick-sort split of a real array. c on input a(1:n). is a real array c on output a(1:n) is permuted such that its elements satisfy: c c abs(a(i)) .ge. abs(a(ncut)) for i .lt. ncut and c abs(a(i)) .le. abs(a(ncut)) for i .gt. ncut c c ind(1:n) is an integer array which permuted in the same way as a(*). c----------------------------------------------------------------------- real*8 tmp, abskey integer itmp, first, last c----- first = 1 last = n if (ncut .lt. first .or. ncut .gt. last) return c c outer loop -- while mid .ne. ncut do c 1 mid = first abskey = abs(a(mid)) do 2 j=first+1, last if (abs(a(j)) .gt. abskey) then mid = mid+1 c interchange tmp = a(mid) itmp = ind(mid) a(mid) = a(j) ind(mid) = ind(j) a(j) = tmp ind(j) = itmp endif 2 continue c c interchange c tmp = a(mid) a(mid) = a(first) a(first) = tmp c itmp = ind(mid) ind(mid) = ind(first) ind(first) = itmp c c test for while loop c if (mid .eq. ncut) return if (mid .gt. ncut) then last = mid-1 else first = mid+1 endif goto 1 c----------------end-of-qsplit------------------------------------------ c----------------------------------------------------------------------- end c subroutine rnrms (nrow, nrm, a, ia, diag) real*8 a(*), diag(nrow), scal integer ia(nrow+1) c----------------------------------------------------------------------- c gets the norms of each row of A. (choice of three norms) c----------------------------------------------------------------------- c on entry: c --------- c nrow = integer. The row dimension of A c c nrm = integer. norm indicator. nrm = 1, means 1-norm, nrm =2 c means the 2-nrm, nrm = 0 means max norm c c a, c ja, c ia = Matrix A in compressed sparse row format. c c on return: c---------- c c diag = real vector of length nrow containing the norms c c----------------------------------------------------------------- do 1 ii=1,nrow c c compute the norm if each element. c scal = 0.0d0 k1 = ia(ii) k2 = ia(ii+1)-1 if (nrm .eq. 0) then do 2 k=k1, k2 scal = max(scal,abs(a(k) ) ) 2 continue elseif (nrm .eq. 1) then do 3 k=k1, k2 scal = scal + abs(a(k) ) 3 continue else do 4 k=k1, k2 scal = scal+a(k)**2 4 continue endif if (nrm .eq. 2) scal = sqrt(scal) diag(ii) = scal 1 continue return c----------------------------------------------------------------------- c-------------end-of-rnrms---------------------------------------------- end c----------------------------------------------------------------------- subroutine cnrms (nrow, nrm, a, ja, ia, diag) real*8 a(*), diag(nrow) integer ja(*), ia(nrow+1) c----------------------------------------------------------------------- c gets the norms of each column of A. (choice of three norms) c----------------------------------------------------------------------- c on entry: c --------- c nrow = integer. The row dimension of A c c nrm = integer. norm indicator. nrm = 1, means 1-norm, nrm =2 c means the 2-nrm, nrm = 0 means max norm c c a, c ja, c ia = Matrix A in compressed sparse row format. c c on return: c---------- c c diag = real vector of length nrow containing the norms c c----------------------------------------------------------------- do 10 k=1, nrow diag(k) = 0.0d0 10 continue do 1 ii=1,nrow k1 = ia(ii) k2 = ia(ii+1)-1 do 2 k=k1, k2 j = ja(k) c update the norm of each column if (nrm .eq. 0) then diag(j) = max(diag(j),abs(a(k) ) ) elseif (nrm .eq. 1) then diag(j) = diag(j) + abs(a(k) ) else diag(j) = diag(j)+a(k)**2 endif 2 continue 1 continue if (nrm .ne. 2) return do 3 k=1, nrow diag(k) = sqrt(diag(k)) 3 continue return c----------------------------------------------------------------------- c------------end-of-cnrms----------------------------------------------- end c----------------------------------------------------------------------- subroutine roscal(nrow,job,nrm,a,ja,ia,diag,b,jb,ib,ierr) real*8 a(*), b(*), diag(nrow) integer nrow,job,nrm,ja(*),jb(*),ia(nrow+1),ib(nrow+1),ierr c----------------------------------------------------------------------- c scales the rows of A such that their norms are one on return c 3 choices of norms: 1-norm, 2-norm, max-norm. c----------------------------------------------------------------------- c on entry: c --------- c nrow = integer. The row dimension of A c c job = integer. job indicator. Job=0 means get array b only c job = 1 means get b, and the integer arrays ib, jb. c c nrm = integer. norm indicator. nrm = 1, means 1-norm, nrm =2 c means the 2-nrm, nrm = 0 means max norm c c a, c ja, c ia = Matrix A in compressed sparse row format. c c on return: c---------- c c diag = diagonal matrix stored as a vector containing the matrix c by which the rows have been scaled, i.e., on return c we have B = Diag*A. c c b, c jb, c ib = resulting matrix B in compressed sparse row sparse format. c c ierr = error message. ierr=0 : Normal return c ierr=i > 0 : Row number i is a zero row. c Notes: c------- c 1) The column dimension of A is not needed. c 2) algorithm in place (B can take the place of A). c----------------------------------------------------------------- call rnrms (nrow,nrm,a,ia,diag) ierr = 0 do 1 j=1, nrow if (diag(j) .eq. 0.0d0) then ierr = j return else diag(j) = 1.0d0/diag(j) endif 1 continue call diamua(nrow,job,a,ja,ia,diag,b,jb,ib) return c-------end-of-roscal--------------------------------------------------- c----------------------------------------------------------------------- end c----------------------------------------------------------------------- subroutine coscal(nrow,job,nrm,a,ja,ia,diag,b,jb,ib,ierr) c----------------------------------------------------------------------- real*8 a(*),b(*),diag(nrow) integer nrow,job,ja(*),jb(*),ia(nrow+1),ib(nrow+1),ierr c----------------------------------------------------------------------- c scales the columns of A such that their norms are one on return c result matrix written on b, or overwritten on A. c 3 choices of norms: 1-norm, 2-norm, max-norm. in place. c----------------------------------------------------------------------- c on entry: c --------- c nrow = integer. The row dimension of A c c job = integer. job indicator. Job=0 means get array b only c job = 1 means get b, and the integer arrays ib, jb. c c nrm = integer. norm indicator. nrm = 1, means 1-norm, nrm =2 c means the 2-nrm, nrm = 0 means max norm c c a, c ja, c ia = Matrix A in compressed sparse row format. c c on return: c---------- c c diag = diagonal matrix stored as a vector containing the matrix c by which the columns have been scaled, i.e., on return c we have B = A * Diag c c b, c jb, c ib = resulting matrix B in compressed sparse row sparse format. c c ierr = error message. ierr=0 : Normal return c ierr=i > 0 : Column number i is a zero row. c Notes: c------- c 1) The column dimension of A is not needed. c 2) algorithm in place (B can take the place of A). c----------------------------------------------------------------- call cnrms (nrow,nrm,a,ja,ia,diag) ierr = 0 do 1 j=1, nrow if (diag(j) .eq. 0.0) then ierr = j return else diag(j) = 1.0d0/diag(j) endif 1 continue call amudia (nrow,job,a,ja,ia,diag,b,jb,ib) return c--------end-of-coscal-------------------------------------------------- c----------------------------------------------------------------------- end c----------------------------------------------------------------------- subroutine diamua (nrow,job, a, ja, ia, diag, b, jb, ib) real*8 a(*), b(*), diag(nrow), scal integer ja(*),jb(*), ia(nrow+1),ib(nrow+1) c----------------------------------------------------------------------- c performs the matrix by matrix product B = Diag * A (in place) c----------------------------------------------------------------------- c on entry: c --------- c nrow = integer. The row dimension of A c c job = integer. job indicator. Job=0 means get array b only c job = 1 means get b, and the integer arrays ib, jb. c c a, c ja, c ia = Matrix A in compressed sparse row format. c c diag = diagonal matrix stored as a vector dig(1:n) c c on return: c---------- c c b, c jb, c ib = resulting matrix B in compressed sparse row sparse format. c c Notes: c------- c 1) The column dimension of A is not needed. c 2) algorithm in place (B can take the place of A). c in this case use job=0. c----------------------------------------------------------------- do 1 ii=1,nrow c c normalize each row c k1 = ia(ii) k2 = ia(ii+1)-1 scal = diag(ii) do 2 k=k1, k2 b(k) = a(k)*scal 2 continue 1 continue c if (job .eq. 0) return c do 3 ii=1, nrow+1 ib(ii) = ia(ii) 3 continue do 31 k=ia(1), ia(nrow+1) -1 jb(k) = ja(k) 31 continue return c----------end-of-diamua------------------------------------------------ c----------------------------------------------------------------------- end c----------------------------------------------------------------------- subroutine amudia (nrow,job, a, ja, ia, diag, b, jb, ib) real*8 a(*), b(*), diag(nrow) integer ja(*),jb(*), ia(nrow+1),ib(nrow+1) c----------------------------------------------------------------------- c performs the matrix by matrix product B = A * Diag (in place) c----------------------------------------------------------------------- c on entry: c --------- c nrow = integer. The row dimension of A c c job = integer. job indicator. Job=0 means get array b only c job = 1 means get b, and the integer arrays ib, jb. c c a, c ja, c ia = Matrix A in compressed sparse row format. c c diag = diagonal matrix stored as a vector dig(1:n) c c on return: c---------- c c b, c jb, c ib = resulting matrix B in compressed sparse row sparse format. c c Notes: c------- c 1) The column dimension of A is not needed. c 2) algorithm in place (B can take the place of A). c----------------------------------------------------------------- do 1 ii=1,nrow c c scale each element c k1 = ia(ii) k2 = ia(ii+1)-1 do 2 k=k1, k2 b(k) = a(k)*diag(ja(k)) 2 continue 1 continue c if (job .eq. 0) return c do 3 ii=1, nrow+1 ib(ii) = ia(ii) 3 continue do 31 k=ia(1), ia(nrow+1) -1 jb(k) = ja(k) 31 continue return c----------------------------------------------------------------------- c-----------end-of-amudiag---------------------------------------------- end c----------------------------------------------------------------------- subroutine csrcoo(nrow,job,nzmax,a,ja,ia,nnz,ao,ir,jc,ierr) c******************************************************************** c c CSRCOO converts Compressed Sparse Row to Coordinate format. c c Discussion: c c This routine converts a matrix that is stored in row general sparse c A, JA, IA format into coordinate format AO, IR, JC. c c Modified: c c 07 January 2004 c c Author: c c Youcef Saad c c Parameters: c c Input, integer NROW, the row dimension of the matrix. c job = integer serving as a job indicator. c if job = 1 fill in only the array ir, ignore jc, and ao. c if job = 2 fill in ir, and jc but not ao c if job = 3 fill in everything. c The reason why these options are provided is that on return c ao and jc are the same as a, ja. So when job = 3, a and ja are c simply copied into ao, jc. When job=2, only jc and ir are c returned. With job=1 only the array ir is returned. Moreover, c the algorithm is in place: c call csrcoo (nrow,1,nzmax,a,ja,ia,nnz,a,ia,ja,ierr) c will write the output matrix in coordinate format on a, ja,ia. c (Important: note the order in the output arrays a, ja, ia. ) c i.e., ao can be the same as a, ir can be the same as ia c and jc can be the same as ja. c c Input, complex A(*), integer JA(*), IA(NROW+1), the matrix in CSR c Compressed Sparse Row format. c c nzmax = length of space available in ao, ir, jc. c the code will stop immediatly if the number of c nonzero elements found in input matrix exceeds nzmax. c c on return: c - c ao, ir, jc = matrix in coordinate format. c c nnz = number of nonzero elements in matrix. c c ierr = integer error indicator. c ierr == 0 means normal retur c ierr == 1 means that the the code stopped c because there was no space in ao, ir, jc c (according to the value of nzmax). c implicit none integer nrow real*8 a(*) real*8 ao(*) c double complex a(*), ao(*) integer i integer ia(nrow+1) integer ierr integer ir(*) integer ja(*) integer jc(*) integer job integer k integer k1 integer k2 integer nnz integer nzmax ierr = 0 nnz = ia(nrow+1)-1 if ( nzmax < nnz ) then ierr = 1 return endif if ( 3 <= job ) then c ao(1:nnz) = a(1:nnz) do i = 1, nnz ao(i) = a(i) enddo endif if ( 2 <= job ) then c jc(1:nnz) = ja(1:nnz) do i = 1, nnz jc(i) = ja(i) enddo endif c c Copy backward. c do i = nrow, 1, -1 k1 = ia(i+1) - 1 k2 = ia(i) do k = k1, k2, -1 ir(k) = i enddo enddo return end c------ End of csrcoo ------------- itsol-1.0.0/LIB/ilutpC.c0000640000265600020320000005651711062577473014026 0ustar tilleaadmin#include #include #include #include #include "globheads.h" #include "protos.h" #ifdef ILUTIME void msg_timer_clear(int *); void msg_timer_start(int *); void msg_timer_stop(int *); double msg_timer(int *); #endif int ilutpC(csptr amat, double *droptol, int *lfil, double permtol, int mband, ilutptr ilusch) { /*---------------------------------------------------------------------- | ILUTP -- ILUT with column pivoting -- adapted from ILUTP [Sparskit] | Converted to C so that dynamic memory allocation may be implememted. | All indexing is in C format. |---------------------------------------------------------------------- | ILUT factorization with dual truncation. |---------------------------------------------------------------------- | | on entry: |========== | ( amat ) = Matrix stored in SpaFmt struct. | | lfil[5] = number nonzeros in L-part | lfil[6] = number nonzeros in U-part ( lfil >= 0 ) | | droptol[5] = threshold for dropping small terms in L during | factorization. | droptol[6] = threshold for dropping small terms in U. | | permtol = tolerance ratio used to determine whether or not to permute | two columns. At step i columns i and j are permuted when | | abs(a(i,j))*permtol > abs(a(i,i)) | | [0 --> never permute; good values 0.1 to 0.01] | | mband = permuting is done within a band extending to mband | diagonals only. | mband = 0 --> no pivoting. | mband = n --> pivot is searched in whole column | | | On return: |=========== | | (ilusch) = Contains L and U factors in an LUfact struct. | Individual matrices stored in SpaFmt structs. | On return matrices have C (0) indexing. | | iperm = reverse permutation array. | | integer value returned: | | 0 --> successful return. | 1 --> Error. Input matrix may be wrong. (The | elimination process has generated a | row in L or U whose length is > n.) | 2 --> Memory allocation error. | 5 --> Illegal value for lfil. | 6 --> zero row encountered. |----------------------------------------------------------------------- | work arrays: |============= | jw, jwrev = integer work arrays of length n | w = real work array of length n. |----------------------------------------------------------------------- | All processing is done using C indexing. |--------------------------------------------------------------------*/ int i, ii, j, jj, jcol, jpos, jrow, k, *jw=NULL, *jwrev=NULL; int len, lenu, lenl, rmax, *iprev=NULL, fil5=lfil[5], fil6=lfil[6]; double tnorm, t, s, fact, *w=NULL, drop5=droptol[5], drop6=droptol[6]; int rowz, *rowj, imax, icut, *iperm=ilusch->perm2; double *rowm, xmax, xmax0, tmp; int dec, decnt=0; #ifdef ILUTIME int tt, t22=22, t23=23, t24=24, t25=25, t26=26, t27=27, t28=28, t29=29, t30=30, t31=31, t32=32, t33=33, t34=34, t35=35; for (tt=22; tt<36; tt++) msg_timer_clear(&tt); #endif ilusch->n = rmax = amat->n; if (rmax == 0) return(0); if (rmax > 0) { jw = (int *) Malloc(rmax*sizeof(int), "ilutpC:1" ); w = (double *) Malloc(rmax*sizeof(double), "ilutpC:2" ); jwrev = (int *) Malloc(rmax*sizeof(int), "ilutpC:3" ); iprev = (int *) Malloc(rmax*sizeof(int), "ilutpC:4" ); } if (fil5<0 || fil6<0 || rmax<=0) goto label998; /*--------------------------------------------------------------------- | beginning of main loop - L, U calculations |--------------------------------------------------------------------*/ for (j=0; jja[ii]; rowm = amat->ma[ii]; rowz = amat->nzcount[ii]; tnorm = 0.0; for (k=0; kU->ma[jrow]; fact = w[jj] * rowm[0]; if ( fabs(fact) > drop5 ) { /* DROPPING IN L */ #ifdef ILUTIME msg_timer_start(&t25); #endif rowj = ilusch->U->ja[jrow]; rowz = ilusch->U->nzcount[jrow]; /*--------------------------------------------------------------------- | combine current row and row jrow |--------------------------------------------------------------------*/ for (k=1; k= ii) { /*--------------------------------------------------------------------- | this is a fill-in element |--------------------------------------------------------------------*/ if (jpos == -1) { if (lenu > rmax) goto label994; i = ii + lenu; jw[i] = j; jwrev[j] = i; w[i] = - s; lenu++; } /*--------------------------------------------------------------------- | this is not a fill-in element |--------------------------------------------------------------------*/ else w[jpos] -= s; } /*--------------------------------------------------------------------- | dealing with L |--------------------------------------------------------------------*/ else { /*--------------------------------------------------------------------- | this is a fill-in element |--------------------------------------------------------------------*/ if (jpos == -1) { if (lenl > rmax) goto label994; jw[lenl] = j; jwrev[j] = lenl; w[lenl] = - s; lenl++; } /*--------------------------------------------------------------------- | this is not a fill-in element |--------------------------------------------------------------------*/ else w[jpos] -= s; } } /*--------------------------------------------------------------------- | store this pivot element |--------------------------------------------------------------------*/ #ifdef ILUTIME msg_timer_stop(&t25); #endif w[len] = fact; jw[len] = jrow; len++; } } /*--------------------------------------------------------------------- | reset nonzero indicators |--------------------------------------------------------------------*/ #ifdef ILUTIME msg_timer_start(&t26); #endif for (j=0; j fil5 ? fil5 : lenl; ilusch->L->nzcount[ii] = len; if (lenl > len) qsplitC(w, jw, lenl, len); /* printf(" row %d length of L = %d",ii,len); */ if (len > 0) { ilusch->L->ja[ii] = (int *) Malloc(len*sizeof(int), "ilutpC:5" ); ilusch->L->ma[ii] = (double *) Malloc(len*sizeof(double), "ilutpC:6"); memcpy(ilusch->L->ma[ii], w, len*sizeof(double)); for (j=0; jL->ja[ii][j] = iperm[jw[j]]; } /*--------------------------------------------------------------------- | apply dropping strategy to U (entries after diagonal) |--------------------------------------------------------------------*/ #ifdef ILUTIME msg_timer_stop(&t27); msg_timer_start(&t28); #endif len = 0; for (j=1; j drop6*tnorm ) { len++; w[ii+len] = w[ii+j]; jw[ii+len] = jw[ii+j]; } } lenu = len+1; len = lenu > fil6 ? fil6 : lenu; ilusch->U->nzcount[ii] = len; if (lenu > len+1) qsplitC(&w[ii+1], &jw[ii+1], lenu-1, len); ilusch->U->ma[ii] = (double *) Malloc(len*sizeof(double), "ilutpC:7" ); ilusch->U->ja[ii] = (int *) Malloc(len*sizeof(int), "ilutpC:8" ); /*--------------------------------------------------------------------- | determine next pivot |--------------------------------------------------------------------*/ /* HERE - all lines with dec included for counting pivots */ imax = ii; xmax = fabs(w[imax]); xmax0 = xmax; /* icut = ii - 1 + mband - ii % mband; */ icut = ii-1 + mband; dec = 0; for (k=ii+1; k xmax) && (t*permtol > xmax0) && (jw[k] <= icut) ) { imax = k; xmax = t; dec = 1; } } if (dec == 1) decnt++; /*--------------------------------------------------------------------- | exchange w's |--------------------------------------------------------------------*/ tmp = w[ii]; w[ii] = w[imax]; w[imax] = tmp; /*--------------------------------------------------------------------- | update iperm and reverse iperm |--------------------------------------------------------------------*/ j = jw[imax]; i = iperm[ii]; iperm[ii] = iperm[j]; iperm[j] = i; iprev[iperm[ii]] = ii; iprev[iperm[j]] = j; /*--------------------------------------------------------------------- | now store U in original coordinates |--------------------------------------------------------------------*/ /* printf(" length of U = %d ",len); */ if (w[ii] == 0.0) w[ii] = (0.0001+drop6)*tnorm; ilusch->U->ma[ii][0] = 1.0 / w[ii]; ilusch->U->ja[ii][0] = ii; memcpy(&ilusch->U->ma[ii][1], &w[ii+1], (len-1)*sizeof(double)); lenu = 0; for (k=ii+1; kU->ja[ii][++lenu] = iperm[jw[k]]; #ifdef ILUTIME msg_timer_stop(&t28); #endif } cpermC(ilusch->U, iprev); cpermC(ilusch->L, iprev); /* DO NOT PERMUTE ORIGINAL MATRIX cpermC(amat, iprev); */ #ifdef ILUTIME tnorm = 0; for (tt=22; tt<29; tt++) { printf(" loop %d %e \n",tt,msg_timer(&tt)); tnorm += msg_timer(&tt); } printf(" total %e \n",tnorm); #endif /*--------------------------------------------------------------------- | end main loop - now do clean up |--------------------------------------------------------------------*/ if (rmax > 0) { free(jw); free(w); free(jwrev); free(iprev); } printf("There were %d pivots\n",decnt); /*--------------------------------------------------------------------- | done -- correct return |--------------------------------------------------------------------*/ return(0); label994: /* Incomprehensible error. Matrix must be wrong. */ return(1); /* label997: Memory allocation error. return(2); */ label998: /* illegal value for lfil or last entered */ return(5); label9991: /* zero row encountered */ return(6); } /*--------------------------------------------------------------------- | end of ilutpC |--------------------------------------------------------------------*/ int ilutD(csptr amat, double *droptol, int *lfil, ilutptr ilusch) { /*---------------------------------------------------------------------- | ILUT - | Converted to C so that dynamic memory allocation may be implememted. | All indexing is in C format. |---------------------------------------------------------------------- | ILUT factorization with dual truncation. | | March 1, 2000 - dropping in U: keep entries > tau * diagonal entry |---------------------------------------------------------------------- | | on entry: |========== | ( amat ) = Matrix stored in SpaFmt struct. | (ilusch) = Pointer to ILUTfac struct | | lfil[5] = number nonzeros in L-part | lfil[6] = number nonzeros in U-part ( lfil >= 0 ) | | droptol[5] = threshold for dropping small terms in L during | factorization. | droptol[6] = threshold for dropping small terms in U. | | On return: |=========== | | (ilusch) = Contains L and U factors in an LUfact struct. | Individual matrices stored in SpaFmt structs. | On return matrices have C (0) indexing. | | integer value returned: | | 0 --> successful return. | 1 --> Error. Input matrix may be wrong. (The | elimination process has generated a | row in L or U whose length is > n.) | 2 --> Memory allocation error. | 5 --> Illegal value for lfil or last. | 6 --> zero row encountered. |----------------------------------------------------------------------- | work arrays: |============= | jw, jwrev = integer work arrays of length n | w = real work array of length n. |----------------------------------------------------------------------- | All processing is done using C indexing. |--------------------------------------------------------------------*/ int i, ii, j,jj, jcol, jpos, jrow, k, *jw=NULL, *jwrev=NULL; int len, lenu, lenl, rmax, fil5=lfil[5], fil6=lfil[6]; double tnorm, t, s, fact, *w=NULL, drop5=droptol[5], drop6=droptol[6]; int rowz, *rowj; double *rowm; ilusch->n = rmax = amat->n; if (rmax == 0) return(0); if (rmax > 0) { jw = (int *) Malloc(rmax*sizeof(int), "ilutD:1" ); w = (double *) Malloc(rmax*sizeof(double), "ilutD:2" ); jwrev = (int *) Malloc(rmax*sizeof(int), "ilutD:3" ); } if (fil5<0 || fil6<0 || rmax<=0) goto label9995; /*--------------------------------------------------------------------- | beginning of first main loop - L, U, L^{-1}F calculations |--------------------------------------------------------------------*/ for (j=0; jja[ii]; rowm = amat->ma[ii]; rowz = amat->nzcount[ii]; for (k=0; kU->ma[jrow]; fact = w[jj] * rowm[0]; if ( fabs(fact) > drop5 ) { /* DROPPING IN L */ rowj = ilusch->U->ja[jrow]; rowz = ilusch->U->nzcount[jrow]; /*--------------------------------------------------------------------- | combine current row and row jrow |--------------------------------------------------------------------*/ for (k=1; k= ii) { /*--------------------------------------------------------------------- | this is a fill-in element |--------------------------------------------------------------------*/ if (jpos == -1) { if (lenu > rmax) goto label9991; i = ii + lenu; jw[i] = j; jwrev[j] = i; w[i] = - s; lenu++; } /*--------------------------------------------------------------------- | this is not a fill-in element |--------------------------------------------------------------------*/ else w[jpos] -= s; } /*--------------------------------------------------------------------- | dealing with L |--------------------------------------------------------------------*/ else { /*--------------------------------------------------------------------- | this is a fill-in element |--------------------------------------------------------------------*/ if (jpos == -1) { if (lenl > rmax) goto label9991; jw[lenl] = j; jwrev[j] = lenl; w[lenl] = - s; lenl++; } /*--------------------------------------------------------------------- | this is not a fill-in element |--------------------------------------------------------------------*/ else w[jpos] -= s; } } /*--------------------------------------------------------------------- | store this pivot element |--------------------------------------------------------------------*/ w[len] = fact; jw[len] = jrow; len++; } } /*--------------------------------------------------------------------- | reset nonzero indicators |--------------------------------------------------------------------*/ for (j=0; j fil5 ? fil5 : len; ilusch->L->nzcount[ii] = lenl; if (len > lenl) qsplitC(w, jw, len, lenl); if (len > 0) { ilusch->L->ja[ii] = (int *) Malloc(lenl*sizeof(int), "ilutD:4" ); ilusch->L->ma[ii] = (double *) Malloc(lenl*sizeof(double), "ilutD:5"); memcpy(ilusch->L->ja[ii], jw, lenl*sizeof(int)); memcpy(ilusch->L->ma[ii], w, lenl*sizeof(double)); } /*--------------------------------------------------------------------- | store the diagonal element of U | | dropping in U if size is less than drop1 * diagonal entry |--------------------------------------------------------------------*/ t = w[ii]; tnorm = fabs(t); len = 0; for (j=1; j drop6*tnorm ) { w[len] = w[ii+j]; jw[len] = jw[ii+j]; len++; } } lenu = len+1 > fil6 ? fil6 : len+1; ilusch->U->nzcount[ii] = lenu; jpos = lenu-1; if (len > jpos) qsplitC(w, jw, len, jpos); ilusch->U->ma[ii] = (double *) Malloc(lenu*sizeof(double), "ilutD:6" ); ilusch->U->ja[ii] = (int *) Malloc(lenu*sizeof(int), "ilutD:7" ); if (t == 0.0) t=(0.0001+drop6)*tnorm; ilusch->U->ma[ii][0] = 1.0 / t; ilusch->U->ja[ii][0] = ii; /*--------------------------------------------------------------------- | copy the rest of U |--------------------------------------------------------------------*/ memcpy(&ilusch->U->ja[ii][1], jw, jpos*sizeof(int)); memcpy(&ilusch->U->ma[ii][1], w, jpos*sizeof(double)); } /*--------------------------------------------------------------------- | end main loop - now do clean up |--------------------------------------------------------------------*/ if (rmax > 0) { free(jw); free(w); free(jwrev); } /*--------------------------------------------------------------------- | done -- correct return |--------------------------------------------------------------------*/ return(0); label9991: /* Incomprehensible error. Matrix must be wrong. */ return(1); /* label9992: Memory allocation error. return(2); */ label9995: /* illegal value for lfil or last entered */ return(5); label9996: /* zero row encountered */ return(6); } /*--------------------------------------------------------------------- | end of ilutNEW |--------------------------------------------------------------------*/ itsol-1.0.0/LIB/protos.h0000640000265600020320000003026211062577473014106 0ustar tilleaadmin#ifndef __ITSOL_INCLUDED_PROTOS_H__ #define __ITSOL_INCLUDED_PROTOS_H__ #include #include "globheads.h" #if defined(_SGI) || defined(_LINUX) #define dnrm2 dnrm2_ #define ddot ddot_ #define daxpy daxpy_ #define qsplit qsplit_ #define dscal dscal_ #define dgemv dgemv_ #define dgemm dgemm_ #define dgetrf dgetrf_ #define dgetri dgetri_ #define dgesvd dgesvd_ #define readmtc readmtc_ #define csrcsc csrcsc_ #define roscal roscal_ #define coscal coscal_ #define qsplit qsplit_ #elif defined(_IBM) #include #define dnrm2 dnrm2 #define ddot ddot #define daxpy daxpy #define qsplit qsplit #define dscal dscal #define dgemv dgemv #define dgemm dgemm #define dgetrf dgetrf #define dgetri dgetri #define dgesvd dgesvd #define readmtc readmtc #define csrcsc csrcsc #define roscal roscal #define coscal coscal #define qsplit qsplit #else #define dnrm2 dnrm2_ #define ddot ddot_ #define daxpy daxpy_ #define qsplit qsplit_ #define dscal dscal_ #define dgemv dgemv_ #define dgemm dgemm_ #define dgetrf dgetrf_ #define dgetri dgetri_ #define dgesvd dgesvd_ #define readmtc readmtc_ #define csrcsc csrcsc_ #define roscal roscal_ #define coscal coscal_ #define qsplit qsplit_ #endif #ifndef min #define min(a,b) (((a)>(b))?(b):(a)) #endif #ifndef max #define max(a,b) (((a)>(b))?(a):(b)) #endif #define MAX_LINE 256 #define MAX_HBNAME 64 #define MAX_MAT 100 /* FORTRAN routines */ extern void readmtc(int*, int*, int*, char*, double*, int*, int*, double*, int*, char*, int*, int*, int*, char*, char*, char*, int*) ; extern void csrcsc (int*, int*, int*, double*, int*, int*, double*, int*, int*) ; extern void qsplit(double *a, int *ind, int *n, int *ncut); extern void dgesvd(char*, char*, int*, int*, double*, int*, double*, double *, int*, double*, int*, double*, int*, int*); extern void csrcoo ( int *, int *, int *, double *, int *, int *, int *, double *, int *, int *, int *); #if defined(_IBM) #define DDOT(n,x,incx,y,incy) ddot((n), (x), (incx), (y), (incy)) #define DCOPY(n,x,incx,y,incy) dcopy((n), (x), (incx), (y), \ (incy)) #define DSCAL(n,alpha,x,incx) dscal((n), (alpha), (x), (incx)) #define DAXPY(n,alpha,x,incx,y,incy) daxpy((n), (alpha), (x), (incx), \ (y), (incy)) #define DNRM2(n,x,incx) dnrm2((n), (x), (incx)) #define IDMIN(n,sx,incx) idmin((n), (sx), (incx)) #define DGEMV(transa,m,n,alpha,a,lda,x,incx,beta,y,incy) \ dgemv((transa), (m), (n), \ (alpha), (a), (lda), (x), (incx), \ (beta), (y), (incy)) #define DGEMM(transa,transb,l,n,m,alpha,a,lda,b,ldb,beta,c,ldc) \ dgemm((transa),(transb), \ (l),(n),(m),(alpha),(a), \ (lda),(b),(ldb),(beta),(c),(ldc)) #define DGETRF(m, n, a, lda, ipvt, info) \ dgetrf((m), (n), (a), (lda), (ipvt), (info)) #define DGETRI(n, a, lda, ipvt, work, lwork, info) \ dgetri((n), (a), (lda), (ipvt), (work), (lwork), (info)) #else #define DDOT(n,x,incx,y,incy) ddot(&(n),(x),&(incx),(y),&(incy)) #define DCOPY(n,x,incx,y,incy) dcopy(&(n),(x),&(incx),(y),&(incy)) #define DSCAL(n,alpha,x,incx) dscal(&(n),&(alpha),(x), &(incx)) #define DAXPY(n,alpha,x,incx,y,incy) daxpy(&(n), &(alpha), (x), \ &(incx), y, &(incy)) #define DNRM2(n, x, incx) dnrm2(&(n), (x), &(incx)) #define IDMIN(n, sx, incx) idmin((&(n), (sx), &(incx)) #define DGEMV(transa, m, n, alpha, a, lda, x, incx, beta, y, incy) \ dgemv((transa), &(m), &(n), &(alpha), (a), &(lda), (x), &(incx), \ &(beta), (y), &(incy)) #define DGEMM(transa,transb,l,n,m,alpha,a,lda,b,ldb,beta,c,ldc) \ dgemm((transa), (transb), &(l), &(n), &(m), &(alpha), (a), \ &(lda), b, &(ldb), &(beta), (c), &(ldc)) #define DGETRF(m, n, a, lda, ipvt, info) \ dgetrf(&(m), &(n), (a), &(lda), (ipvt), (info)) #define DGETRI(n, a, lda, ipvt, work, lwork, info) \ dgetri(&(n), (a), &(lda), (ipvt), (work), &(lwork), (info)) extern double ddot(int *n, double *x, int *incx, double *y, int *incy); extern void dcopy(int *n, double *x, int *incx, double *y, int *incy); extern void dscal(int *n, double *alpha, double *x, int *incx); extern void daxpy(int *n, double *alpha, double *x, int *incx, double *y, int *incy); extern double dnrm2(int *n, double *x, int *incx); extern void idmin(int *n, double *sx, int *incx); extern void dgemv(char *transa, int *m, int *n, double *alpha, double *a, int *lda, double *x, int *incx, double *beta, double *y, int *incy); extern void dgemm(char *transa, char *transb, int *l, int *m, int *n, double *alpha, double *a, int *lda, double *b, int *ldb, double *beta, double *c, int *ldc); extern void dgetrf(int *m, int *n, double *a, int *lda, int *ipvt, int *info); extern void dgetri(int *n, double *a, int *lda, int *ipvt, double *work, int *lwork, int *info); #endif /* sets.c */ extern int nnz_arms (arms PreSt, FILE *ft); extern void errexit(char *f_str, ...); extern void *Malloc(int nbytes, char *msg); extern int setupCS(csptr amat, int len, int job); extern int cleanCS(csptr amat); extern int nnzCS(csptr amat); extern int cs_nnz (csptr A) ; extern int cscpy(csptr amat, csptr bmat); extern int setupP4 (p4ptr amat, int Bn, int Cn, csptr F, csptr E); extern int setupVBMat(vbsptr vbmat, int n, int *nB); extern int setupILUT(ilutptr amat, int len); extern int cleanVBMat(vbsptr vbmat); extern int nnzVBMat(vbsptr vbmat) ; extern int memVBMat(vbsptr vbmat); extern int setupVBILU(vbiluptr lu, int n, int *bsz); extern int cleanVBILU(vbiluptr lu); extern int cleanILU( iluptr lu ); extern int cleanILUT(ilutptr amat, int indic); extern int cleanP4(p4ptr amat); extern int mallocVBRow(vbiluptr lu, int nrow); extern int mallocRow( iluptr lu, int nrow ); extern void zrmC(int m, int n, BData data); extern void copyBData(int m, int n, BData dst, BData src, int isig); extern int CSRcs(int n, double *a, int *ja, int *ia, csptr mat, int rsa); extern int csrvbsrC(int job, int nBlk, int *nB, csptr csmat, vbsptr vbmat); extern int col2vbcol( int col, vbsptr vbmat ); extern int nnz_vbilu(vbiluptr lu); extern int lev4_nnz(p4ptr levmat, int *lev, FILE *ft); extern int setupILU( iluptr lu, int n ); extern int CS2lum( int n, csptr Amat, iluptr mat, int typ); extern int COOcs(int n, int nnz, double *a, int *ja, int *ia, csptr bmat); /* MatOps.c */ extern int diag_scal(vbsptr vbmat); extern int diagvec(vbsptr vbmat, BData x, BData y); extern void matvec(csptr mata, double *x, double *y); extern void matvecCSR(SMatptr mat, double *x, double *y); extern void matvecz(csptr mata, double *x, double *y, double *z); extern void vbmatvec(vbsptr vbmat, double *x, double *y); extern void luinv(int n, double *a, double *x, double *y); extern int vblusolC(double *y, double *x, vbiluptr lu); extern int lusolC( double *y, double *x, iluptr lu ); extern int rpermC(csptr mat, int *perm); extern int cpermC(csptr mat, int *perm) ; extern int dpermC(csptr mat, int *perm) ; extern int CSparTran(csptr amat, csptr bmat, CompressType *compress); extern double vbnorm2(int sz, double *a); extern void Lsol(csptr mata, double *b, double *x); extern void Usol(csptr mata, double *b, double *x); extern int ascend (p4ptr levmat, double *x, double *wk); extern int descend(p4ptr levmat, double *x, double *wk); extern int armsol2(double *x, arms Prec); extern int condestArms(arms armspre, double *y, FILE *fp ); extern int VBcondestC( vbiluptr lu, double *y, double *x, FILE *fp ); extern int CondestLUM(iluptr lu, double *y, double *x, FILE *fp ); extern void matvecVBR(SMatptr mat, double *x, double *y); extern void matvecLDU(SMatptr mat, double *x, double *y); extern int preconILU(double *x, double *y, SPreptr mat); extern int preconVBR(double *x, double *y, SPreptr mat); extern int preconLDU(double *x, double *y, SPreptr mat); extern int preconARMS(double *x, double *y, SPreptr mat); extern p4ptr Lvsol2(double *x, int nlev, p4ptr levmat, ilutptr ilusch) ; extern int Uvsol2(double *x, int nlev, int n, p4ptr levmat, ilutptr ilusch); extern void SchLsol(ilutptr ilusch, double *y) ; extern void SchUsol(ilutptr ilusch, double *y) ; #ifndef _IBM extern void dgemv(char*, int *, int*, double*, double *, int*, double*, int*, double*, double*, int*); extern void dgemm(char*, char*, int*, int*, int*, double*, double*, int*, double*, int*, double*, double*, int*) ; extern void dgetrf(int*, int*, double*, int*, int*, int*); extern void dgetri(int*, double*, int*, int*, double*, int*, int* ); extern double dnrm2( int *, double *, int * ); extern void dscal(int*, double*, double*, int*); #endif extern int invGauss(int nn, double *A); extern int invSVD(int nn, double *A) ; /* setblks.c */ extern int KeyComp(const void *vfst, const void *vsnd); extern int init_blocks(csptr, int *, int **, int **, double, double *, double *); /* upper directory */ extern int vbilukC( int lofM, vbsptr vbmat, vbiluptr lu, FILE *fp ); extern int vbilutC( vbsptr vbmat, vbiluptr lu, int lfil, double tol, BData *w, FILE *fp ); extern int ilutc(iluptr mt, iluptr lu, int lfil, double tol, int drop, FILE *fp ); extern int ilukC( int lofM, csptr csmat, iluptr lu, FILE *fp ); extern int ilut( csptr csmat, iluptr lu, int lfil, double tol, FILE *fp ); extern int fgmr(SMatptr Amat, SPreptr lu, double *rhs, double *sol, double tol, int im, int *itmax, FILE *fits ); extern int arms2(csptr Amat, int *ipar, double *droptol, int *lfil, double tolind, arms PreMat, FILE *ft) ; extern int condestLU( iluptr lu, double *y, double *x, FILE *fp ); extern int nnz_ilu( iluptr lu ); extern void roscal (int* nrow, int* job, int* nrm, double *a, int *ja, int *ia, double *diag, double *b, int *jb, int *ib, int *ierr) ; extern void coscal (int* nrow, int* job, int* nrm, double *a, int *ja, int *ia, double *diag, double *b, int *jb, int *ib, int *ierr) ; extern int outputLU( iluptr lu, char *filename ); extern int lumsolC(double *y, double *x, iluptr lu ); extern void lumatvec(iluptr mat, double *x, double *y); extern int CSClum( int n, double *a, int *ja, int *ia, iluptr mat, int rsa ); extern void setup_arms (arms Levmat); extern int cleanARMS(arms ArmsPre); extern int csSplit4(csptr amat, int bsize, int csize, csptr B, csptr F, csptr E, csptr C); /* misc.c */ extern int SparTran(csptr amat, csptr bmat, int job, int flag); extern int coscalC(csptr mata, double *diag, int nrm); extern void dscale(int n, double *dd, double *x, double * y); extern void hilosort(csptr mat, int abval, int hilo); extern void printmat(FILE *ft, csptr A, int i0, int i1); extern void qqsort(int *ja, double *ma, int left, int right); extern void qsort2C(int *ja, double *ma, int left, int right, int abval); extern void qsort3i(int *wa, int *cor1, int *cor2, int left, int right); extern void qsortC(int *ja, double *ma, int left, int right, int abval); extern void qsortR2I(double *wa, int *cor1, int *cor2, int left, int right); extern int qsplitC(double *a, int *ind, int n, int ncut); extern int roscalC(csptr mata, double *diag, int nrm); extern void swapj(int v[], int i, int j); extern void swapm(double v[], int i, int j); /* piluNEW.c */ extern int pilu(p4ptr amat, csptr B, csptr C, double *droptol, int *lfil, csptr schur); /* ilutpC.c */ extern int ilutD(csptr amat, double *droptol, int *lfil, ilutptr ilusch); extern int ilutpC(csptr amat, double *droptol, int *lfil, double permtol, int mband, ilutptr ilusch); /* PQ.c */ extern int PQperm(csptr mat, int bsize, int *Pord, int *Qord, int *nnod, double tol); extern int add2com(int *nback, int nod, int *iord, int *riord); extern int add2is(int *last, int nod, int *iord, int *riord); extern int indsetC(csptr mat, int bsize, int *iord, int *nnod, double tol); extern int preSel(csptr mat, int *icor, int *jcor, int job, double tol, int *count); /* indsetC.c */ extern int weightsC(csptr mat, double *w); /* setblks.c */ extern int KeyComp( const void *vfst, const void *vsnd ); extern int init_blocks( csptr csmat, int *pnBlock, int **pnB, int **pperm, double eps, double *t_hash, double *t_angle ); /* systimer.c */ extern double sys_timer(void); /*auxill.c */ extern void randvec (double *v, int n); #endif itsol-1.0.0/LIB/PQ.c0000640000265600020320000003333211062577473013074 0ustar tilleaadmin#include #include #include #include #include "./globheads.h" #include "./protos.h" #define ALPHA 0.00001 /*--------------------end protos */ int PQperm(csptr mat, int bsize, int *Pord, int *Qord, int *nnod, double tol) { /*--------------------------------------------------------------------- | algorithm for nonsymmetric block selection - |---------------------------------------------------------------------- | Input parameters: | ----------------- | (mat) = matrix in SpaFmt format | | tol = a tolerance for excluding a row from B block | | bsize not used here - it is used in arms2.. | | Output parameters: | ------------------ | Pord = row permutation array. Row number i will become row number | Pord[i] in permuted matrix. (Old to new labels) | Qord = column permutation array. Column number j will become | row number Qord[j] in permuted matrix. | [destination lists] - i.e., old to new arrays= | | nnod = number of elements in the B-block | |---------------------------------------------------------------------*/ /*-------------------- local variables */ int *icor, *jcor, *row; int i, j, ii, k, col, jj, rnz, nzi, n=mat->n, count, numnode; double aij, rn, *mrow; /*-----------------------------------------------------------------------*/ for (j=0; jja[ii]; mrow = mat->ma[ii]; nzi = mat->nzcount[ii] ; /*-------------------- rnz = already assigned cols (either in L or F) */ rn = fabs(mrow[0]); rnz = (nzi-1) ; for (k=0; k < nzi; k++) { aij = fabs(mrow[k]); col = row[k]; if (Qord[col] >=0 ) { rn -= aij; rnz-- ; } else if (Qord[col] == -2) { rnz--; } } if (rn < 0.0) continue; Pord[ii] = numnode; Qord[jj] = numnode; numnode++; /*-------------------- acceptance test among others */ for (k=0; k < nzi; k++) { col = row[k]; if (Qord[col] != -1) continue; aij = fabs(mrow[k]); if (rnz*aij > rn) Qord[col] = -2; else rn -= aij; rnz--; } } /*-------------------- number of B nodes */ *nnod = numnode; /* printf(" nnod found = %d \n",*nnod); */ /*-------------------------------------------------- | end-main-loop - complete permutation arrays |-------------------------------------------------*/ for (i=0; i \n") ; check_perm(n, Pord) ; check_perm(n, Qord) ; */ /*-------------------------------------------------- | clean up before returning |-------------------------------------------------*/ free(icor); free(jcor); return 0; } /*--------------------------------------------------------------------- |-----end-of-indsetPQ-------------------------------------------------- |--------------------------------------------------------------------*/ int add2is(int *last, int nod, int *iord, int *riord) { /*---------------------------------------------------------------------- | adds element nod to independent set |---------------------------------------------------------------------*/ (*last)++; iord[nod] = *last; riord[*last] = nod; return 0; } /*--------------------------------------------------------------------- |---- end of add2is --------------------------------------------------- |--------------------------------------------------------------------*/ int add2com(int *nback, int nod, int *iord, int *riord) { /*---------------------------------------------------------------------- | adds element nod to independent set |---------------------------------------------------------------------*/ iord[nod] = *nback; riord[*nback] = nod; (*nback)--; return 0; } /*--------------------------------------------------------------------- |---- end of add2com -------------------------------------------------- |--------------------------------------------------------------------*/ int indsetC(csptr mat, int bsize, int *iord, int *nnod, double tol) { /*--------------------------------------------------------------------- | greedy algorithm for independent set ordering -- |---------------------------------------------------------------------- | Input parameters: | ----------------- | (mat) = matrix in SpaFmt format | | bsize = integer (input) the target size of each block. | each block is of size >= bsize. | | w = weight factors for the selection of the elements in the | independent set. If w(i) is small i will be left for the | vertex cover set. | | tol = a tolerance for excluding a row from independent set. | | Output parameters: | ------------------ | iord = permutation array corresponding to the independent set | ordering. Row number i will become row number iord[i] in | permuted matrix. | | nnod = (output) number of elements in the independent set. | |----------------------------------------------------------------------- | the algorithm searches nodes in lexicographic order and groups | the (BSIZE-1) nearest nodes of the current to form a block of | size BSIZE. The current algorithm does not use values of the matrix. |---------------------------------------------------------------------*/ /* local variables */ int nod, jcount, lastlev, begin, last0, last, nback, mid, j1, j2, jcol, inod, jnod, j, k, jcount0, begin0, *rowj; int prog, n=mat->n, *riord; double *w; csptr matT,gmat; /*-----------------------------------------------------------------------*/ riord = (int *) Malloc(n*sizeof(int), "indsetC:1" ); w = (double *) Malloc(n*sizeof(double), "indsetC:2" ); matT = (csptr) Malloc(sizeof(SparMat), "indsetC:3" ); /* call weights to compute the weights for input matrix.. */ setupCS(matT, mat->n,1); SparTran(mat, matT, 1, 0); SparTran(matT, mat, 1, 1); weightsC(mat, w); /*---------------------------------------------------------------------- | scan all nodes first to eliminate those not satisfying DD criterion +----------------------------------------------------------------------*/ nback = n-1; nod = 0; for(j=0; j= mat->n) goto label50; } /*-------------------- initialize level-set - contains nod (only)*/ add2is(&last, nod, iord, riord); begin = last; begin0 = begin; lastlev = begin; jcount = 1; /*---------------------------------------------------------------------- | put all the nearest neighbor nodes of the current node into | the block until the number is BSIZE. |---------------------------------------------------------------------*/ prog = 1; while (jcount < bsize && prog) { /*-------------------- traverse all the current level-set */ last0 = last; jcount0 = jcount; for (inod=begin; inod<=last0; inod++) { jnod = riord[inod]; /*-------------------- This assumes A is not symmetric. */ gmat = mat; for (k=0; k<2; k++) { rowj = gmat->ja[jnod]; for (j=0; jnzcount[jnod]; j++) { jcol = rowj[j]; if (iord[jcol] == -1 ) { add2is(&last, jcol, iord, riord); jcount++; } } gmat = matT; } } prog = jcount > jcount0 ? 1 : 0; lastlev = begin; begin = last0+1; } /*----------------------------------------------------------------------- | the neighbors of elements of last level go to the complement | gmat loop over original matrix and its transpose +-----------------------------------------------------------------------*/ gmat = mat; for (k=0; k<2; k++) { for (inod=lastlev; inod<=last; inod++) { jnod = riord[inod]; rowj = gmat->ja[jnod]; for (j=0; jnzcount[jnod]; j++){ jcol = rowj[j]; if (iord[jcol] == -1) add2com(&nback, jcol, iord, riord); } } gmat = matT; } /* reverse ordering for this level */ mid = (begin0+last) / 2; for (inod=begin0; inod<=mid; inod++) { j = last - inod + begin0; jnod = riord[inod]; riord[inod] = riord[j]; riord[j] = jnod; } } /*-------------------------------------------------- | end-main-loop |-------------------------------------------------*/ /*-------------------- relabel nodes of vertex cover */ label50: *nnod = last; j1 = *nnod; for (j2=*nnod+1; j2 -1) { if (++j1 != j2) { j = riord[j2]; riord[j2] = riord[j1]; riord[j1] = j; } } } /*-------------------- obtain reverse permutation array */ for (j=0; jn, *kj, kz; double tdia, wmax=0.0, tnorm, *kr; for (irow=0; irownzcount[irow]; kr = mat->ma[irow]; kj = mat->ja[irow]; tnorm = 0.0; tdia = 0.0; for (k=0; k 0.0) tnorm = tdia / tnorm; w[irow] = tnorm; if (tnorm > wmax) wmax = tnorm; } for (irow=0; irown, col, jmax, countL; int *nz, *jcol; double *mrow, rownorm, *weight, t, tmax, wmax; /*--------------------begin */ /*-----------------------------------------------------------------------*/ nz =mat->nzcount; weight = (double *) malloc(n*sizeof(double)); if ( weight==NULL) return 1; /*-------------------- compute max entry for each row */ wmax = 0.0; for (i=0; ija[i]; mrow = mat->ma[i]; tmax = 0.0; kmax = 0; rownorm = 0.0; for (k = 0; k #include #include #include "globheads.h" #include "protos.h" #define TOL 1.e-17 #define max(a,b) (((a)>(b))?(a):(b)) int invGauss(int nn, double *A) { /* *-------------------- inversion by svd This calls lapack routines for inverting a dense matrix. dgetrf and dgetri ON ENTRY ** A = square matrix of size n x n -- dimensioned with ** leading dimension = n ON RETURN A contains the inverse of the input matrix. */ int lWk, info; double *Wk; int *ipiv; lWk = 10*nn; /*-------------------- trivial case nn = 1 */ if (nn == 1) { if (A[0] == 0.0) return 1; else { A[0] = 1.0 / A[0]; return 0; } } /*-------------------- general case */ Wk = (double *) malloc(lWk*sizeof(double)); ipiv = (int *) malloc(nn*sizeof(int)); if (Wk == NULL || ipiv == NULL) return -1; /*-------------------- get LU factorization with pivoting */ DGETRF (nn, nn, A, nn, ipiv, &info); if (info !=0 ) return info; /*-------------------- compute inverse */ DGETRI (nn, A, nn, ipiv, Wk, lWk, &info); free(Wk); free(ipiv); return info; } int invSVD(int nn, double *A) { /* *-------------------- inversion by svd This calls lapack routine dgesvd -- ON ENTRY ** A = square matrix of size n x n -- dimensioned with ** leading dimension = n ON RETURN A contains the truncated SVD inverse of input matrix. ** tolerance set for truncation is TOL and can be changed in ** above define statement **-------------------- */ int lWk, i, info; double *U, *VT, *S, *Wk; double tmp, nrm, one=1.0, zero=0.0; double tol=TOL; lWk = 5*nn; U = (double *) malloc(nn*nn*sizeof(double)); VT = (double *) malloc(nn*nn*sizeof(double)); S = (double *) malloc(nn*sizeof(double)); Wk = (double *) malloc(lWk*sizeof(double)); if (U == NULL || VT == NULL || S == NULL || Wk == NULL) return -1; /*-------------------- trivial case nn = 1 */ if (nn == 1) { if (A[0] == 0.0) return 1; else { A[0] = one / A[0]; return 0; } } /*-------------------- general case */ dgesvd ("A","A", &nn, &nn, A, &nn, S, U, &nn, VT, &nn, Wk, &lWk, &info) ; if (S[0] == 0.0) return 1; nrm = S[0]*tol; /*-------------------- compute S\inv * VT */ for (i=0; i #include #include "globheads.h" #include "protos.h" typedef struct __KeyType { int var; /* row number */ int key; /* hash value */ } KeyType; int KeyComp( const void *vfst, const void *vsnd ) { KeyType *fst = (KeyType *)vfst, *snd = (KeyType *)vsnd; if( fst->key == snd->key ) { if( fst->var < snd->var ) return -1; return 1; } if( fst->key < snd->key ) return -1; return 1; } int init_blocks( csptr csmat, int *pnBlock, int **pnB, int **pperm, double eps, double *t_hash, double *t_angle ) { /*---------------------------------------------------------------------------- * Setup Blocks ( rows and columns might be permuted to get better results ) *---------------------------------------------------------------------------- * Na Li, Aug 2001 *---------------------------------------------------------------------------- * on entry: * ========= * csmat = a matrix stored in SpaFmt format * eps = parameter for deciding when to do a union of two rows * into the same group. Two rows u and v are merged into a * block when cos() == (u,v)/(|u|*|v|), is > eps. * eps should be <= 1. *---------------------------------------------------------------------------- * on return: * ========== * csmat = matrix stored in SpaFmt format after permutation * pnBlock = dimension of the block matrix * pnB = dimension of each block * *---------------------------------------------------------------------------- * Combination of hash method and angle method: *---------------------------------------------------------------------------- * Designed for the matrices with symmetric patterns * (1) Hash method * a. Calculate hash values * b. qsort rows according to their hash values * c. Get compressed graph as the following format: * (2) Angle method * a. Calculate A^T * b. for i-th row, calculate dot product (row_i, row_j) using A*A^T * algorithm where j = i+1, ..., n-1 and group[j] == -1 * if cos( ) = (row_i,row_j)/|row_i||row_j| is > eps, * we merge row_i and row_j by resetting * group[j] = i and size[i] = size[i]+size[j] *--------------------------------------------------------------------------*/ int n = csmat->n, nBlock = 0, i, j, k; csptr at = NULL; KeyType *group = NULL; CompressType *compress = NULL; int *perm = NULL, *nB = NULL; int nzcount0, nzcount, key0, key, *ja0, *ja, row0, row, newblock; int *iw = NULL, *jbuf = NULL; int cnt, pos, nnz_i, row_j, col, bkcnt; int nextBlockID, nextBlockPos, belongTo, grp; double eps_2 = eps * eps, t1, t2; t1 = sys_timer(); /* begin Hash method timer */ group = (KeyType *)Malloc( n*sizeof(KeyType), "init_blocks" ); compress = (CompressType *)Malloc( n*sizeof(CompressType), "init_blocks" ); perm = (int *)Malloc( n * sizeof(int), "init_blocks" ); iw = perm; /* iw and perm array can share memory here because they will * never be used at the same time */ for( i = 0; i < n; i++ ) { iw[i] = 0; compress[i].grp = -1; } /*-------------------- compress matrix based on hash algorithm */ /*-------------------- get hash value of each row */ for( i = 0; i < n; i++ ) { nzcount = csmat->nzcount[i]; key = 0; ja = csmat->ja[i]; for( j = 0; j < nzcount; j++ ) key += ja[j]+1; group[i].key = key; group[i].var = i; } /*-------------------- sort rows -- uses function KeyComp */ qsort( group, n, sizeof(KeyType), KeyComp ); /*-------------------- compress matrix */ for( i = 0; i < n; i++ ) { row0 = group[i].var; if( compress[row0].grp != -1 ) continue; /* already assigned */ key0 = group[i].key; nzcount0 = csmat->nzcount[row0]; ja0 = csmat->ja[row0]; /*-------------------- beginning of new block. set .grp and .count */ compress[row0].grp = -1; compress[row0].count = 1; /*-------------------- loop over all rows having same check-sum keys */ for( j = i + 1; j < n; j++ ) { key = group[j].key; if( key != key0 ) break; row = group[j].var; if( compress[row].grp != -1 ) continue; /* already assigned */ nzcount = csmat->nzcount[row]; if( nzcount != nzcount0 ) continue; ja = csmat->ja[row]; newblock = 0; /*-------------------- compare patterns of the rows */ for( k = 0; k < nzcount; k++ ) iw[ ja0[k] ] = 1; for( k = 0; k < nzcount; k++ ) { if( iw[ ja[k] ] == 0 ) { newblock = 1; break; } } for( k = 0; k < nzcount; k++ ) iw[ ja0[k] ] = 0; /* reset iw */ /*-------------------- row belongs to group row0 */ if( !newblock ) { compress[row].grp = row0; compress[row0].count++; } } } t2 = sys_timer(); /* end Hash method timer */ *t_hash = t2 - t1; t1 = sys_timer(); /* begin angle method timer */ nB = (int *)Malloc( n * sizeof(int), "init_blocks" ); jbuf = (int *)Malloc( n * sizeof(int), "init_blocks" ); /*-------------------- compress matrix based on angle algorithm */ /*-------------------- calculate compressed A^T */ at = (csptr)Malloc( sizeof(SparMat), "init_blocks" ); setupCS( at, n, 0 ); if( CSparTran( csmat, at, compress ) != 0 ) return -1; /*---------------------------------------------------------------------------- * only the row representing beginning of block satisfies: * compress[row].grp = -1, so far. * how many such rows is up to the compression rate of hash compression * algorithm we did above *--------------------------------------------------------------------------*/ /*--------------------------------------------------------------- * use group to backup original compressed matrix by Hash method. * It is very important because the array 'compress' will be changed * during Angle method. Or, we'll get incorrect inner product. *--------------------------------------------------------------*/ for( i = 0; i < n; i++ ) { group[i].var = compress[i].grp; group[i].key = compress[i].count; } for( i = 0; i < n; i++ ) { if( compress[i].grp != -1 ) continue; nB[nBlock] = compress[i].count; /* !!! not 1 here */ cnt = 0; /*-------------------- calculate (u,v_j ), j = i+1,...,n, using product *-------------------- algorithm of A * A_T */ nnz_i = csmat->nzcount[i]; for( j = 0; j < nnz_i; j++ ) { row_j = csmat->ja[i][j]; if( group[row_j].var != -1 ) /* i.e. original compress[row_j].grp */ continue; bkcnt = group[row_j].key; /* i.e. original compress[row_j].count */ for( k = at->nzcount[row_j] - 1; k >= 0; k-- ) { col = at->ja[row_j][k]; if( col <= i ) break; if( compress[col].grp != -1 ) continue; /* needed because compress array is dynamically updated */ if( iw[col] == 0 ) { /* new nonzero of (u,v_j) */ jbuf[cnt] = col; cnt++; } iw[col] += bkcnt; /* correct for matrix with symmetric pattern */ } } /*-------------------- set group for row i and reset iw */ for( j = 0; j < cnt; j++ ) { pos = jbuf[j]; if( iw[pos] * iw[pos] >= eps_2 * nnz_i * csmat->nzcount[pos] ) { compress[pos].grp = i; nB[nBlock] += compress[pos].count; /* !!! not 1 here */ } iw[pos] = 0; /* reset iw */ } nBlock++; /* begin new block, add block count by 1 */ } /* end loop i */ /*-------------------- free group */ if( group ) { /* no need group array any more */ free( group ); group = NULL; } *pnBlock = nBlock; *pnB = (int *)Malloc( nBlock * sizeof(int), "init_blocks" ); for( i = 0; i < nBlock; i++ ) { if( nB[i] > MAX_BLOCK_SIZE ) { fprintf( stderr, "Block of size = %d exceeds MAX_BLOCK_SIZE\n", nB[i] ); return -1; } (*pnB)[i] = nB[i]; } /*-------------------- calculate permutation array - Array nB will * be used to store next available position in each block */ nextBlockID = 0; nextBlockPos = 0; for( i = 0; i < n; i++ ) { if( compress[i].grp == -1 ) { perm[i] = nextBlockPos; nextBlockPos += (*pnB)[nextBlockID++]; nB[i] = 1; } else { belongTo = compress[i].grp; grp = compress[belongTo].grp; if( grp != -1 ) /* should find the final beginning of block */ belongTo = grp; perm[i] = perm[belongTo] + nB[belongTo]; nB[belongTo]++; } } t2 = sys_timer(); /* end angle method timer */ *t_angle = t2 - t1; *pperm = perm; cleanCS( at ); free( nB ); free( jbuf ); free( compress ); return 0; } itsol-1.0.0/LIB/MatOps.c0000640000265600020320000006702011062577473013760 0ustar tilleaadmin#include #include #include #include #include "globheads.h" #include "protos.h" int diag_scal( vbsptr vbmat ){ /*---------------------------------------------------------------------------- * Diagonal scaling: * For the matrix with block diagonals D1, D2, ..., Dp : * D1 x x x * x D2 x x * A = x x ... x * x x x Dp * simply take the block diagonal matrix * D1 0 0 0 * 0 D2 0 0 * D = 0 0 ... 0 * 0 0 0 Dp * invert D and do A := inv(D)*A * then the diagonal blocks of A are now identities. *---------------------------------------------------------------------------- * Parameters *---------------------------------------------------------------------------- * on entry: * ========= * vbmat = block matrix stored in VBSpaFmt format -- see globheads.h for * details on format, the block sizes might be different * on return: * ========== * vbmat = inv(D)*vbmat *--------------------------------------------------------------------------*/ int i, j, k, dim, sz, size, ierr = 0, col; double one=1.0, zero=0.0; int nzcount, n = vbmat->n, *bsz = vbmat->bsz, *ja; int bufsz = sizeof(double)*MAX_BLOCK_SIZE*MAX_BLOCK_SIZE; BData *ba, *D, buf; D = (BData *)Malloc( sizeof(BData)*n, "diag_scal" ); buf = (BData)Malloc( bufsz, "diag_scal" ); for( i = 0; i < n; i++ ) { nzcount = vbmat->nzcount[i]; ja = vbmat->ja[i]; for( j = 0; j < nzcount; j++ ) { if( ja[j] != i ) continue; dim = B_DIM( bsz, i ); size = sizeof(double)*dim*dim; D[i] = (BData)Malloc( size, "diag_scal" ); memcpy(D[i], vbmat->ba[i][j], size ); ierr = invSVD( dim, D[i] ); if( ierr != 0 ) { for( k = 0; k < i; k++ ) free( D[k] ); free( D ); fprintf( stderr, "error: Singular diagonal block...\n" ); return -2; } } } for( i = 0; i < n; i++ ) { dim = B_DIM( bsz, i ); nzcount = vbmat->nzcount[i]; ja = vbmat->ja[i]; ba = vbmat->ba[i]; for( j = 0; j < nzcount; j++ ) { col = ja[j]; sz = B_DIM( bsz, col ); DGEMM ("n","n", dim, sz, dim, one,D[i], dim, ba[j], dim, zero, buf,dim) ; copyBData( dim, sz, ba[j], buf, 0 ); } } vbmat->D = D; free( buf ); return 0; } int diagvec( vbsptr vbmat, BData x, BData y ) { /*--------------------------------------------------------------------- | This function does y = inv(D) x, where D is diagonals of A. |---------------------------------------------------------------------- | on entry: | vbmat = the matrix (in BSpaFmt form) | x = a vector | | on return | y = the product inv(D) * x |--------------------------------------------------------------------*/ int i, n = vbmat->n, *bsz = vbmat->bsz, dim, sz = 1; double zero=0.0, one = 1.0; BData *D = vbmat->D; for (i = 0; i < n; i++ ) { dim = B_DIM( bsz, i ); DGEMM ("n","n", dim,sz,dim,one,D[i],dim,x+bsz[i],dim,zero, y+bsz[i],dim) ; } return 0; } void matvec( csptr mata, double *x, double *y ) { /*--------------------------------------------------------------------- | This function does the matrix vector product y = A x. |---------------------------------------------------------------------- | on entry: | mata = the matrix (in SpaFmt form) | x = a vector | | on return | y = the product A * x |--------------------------------------------------------------------*/ /* local variables */ int i, k, *ki; double *kr; for (i=0; in; i++) { y[i] = 0.0; kr = mata->ma[i]; ki = mata->ja[i]; for (k=0; knzcount[i]; k++) y[i] += kr[k] * x[ki[k]]; } return; } void vbmatvec(vbsptr vbmat, double *x, double *y ) { /*-------------------- matrix -- vector product in VB format */ int i, j, nzcount, col, inc = 1, dim, sz, nBs, nBsj; int n = vbmat->n, *ja, *bsz = vbmat->bsz; double one=1.0; BData *ba; for( i = 0; i < n; i++ ) { nBs = bsz[i]; dim = B_DIM(bsz,i); for( j = 0; j < dim; j++ ) y[nBs+j] = 0; nzcount = vbmat->nzcount[i]; ja = vbmat->ja[i]; ba = vbmat->ba[i]; for( j = 0; j < nzcount; j++ ) { col = ja[j]; nBsj = bsz[col]; sz = B_DIM(bsz,col); /*-------------------- operation: y = Block*x + y */ DGEMV ("n", dim, sz,one, ba[j],dim,&x[nBsj],inc,one,&y[nBs],inc); } } } void Lsol(csptr mata, double *b, double *x) { /*--------------------------------------------------------------------- | This function does the forward solve L x = b. | Can be done in place. |---------------------------------------------------------------------- | on entry: | mata = the matrix (in SpaFmt form) | b = a vector | | on return | x = the solution of L x = b |--------------------------------------------------------------------*/ /* local variables */ int i, k; double *kr; int *ki; for (i=0; in; i++) { x[i] = b[i]; if ( mata->nzcount[i] > 0 ) { kr = mata->ma[i]; ki = mata->ja[i]; for (k=0; knzcount[i]; k++) x[i] -= kr[k]*x[ki[k]]; } } return; } /*---------------end of Lsol----------------------------------------- ----------------------------------------------------------------------*/ void Usol(csptr mata, double *b, double *x) { /*--------------------------------------------------------------------- | This function does the backward solve U x = b. | Can be done in place. |---------------------------------------------------------------------- | on entry: | mata = the matrix (in SpaFmt form) | b = a vector | | on return | x = the solution of U * x = b | |---------------------------------------------------------------------*/ /* local variables */ int i, k, *ki; double *kr; for (i=mata->n-1; i>=0; i--) { kr = mata->ma[i]; ki = mata->ja[i]; x[i] = b[i] ; for (k=1; knzcount[i]; k++) x[i] -= kr[k] * x[ki[k]]; x[i] *= kr[0]; } return; } /*----------------end of Usol---------------------------------------- ----------------------------------------------------------------------*/ int descend(p4ptr levmat, double *x, double *wk) { /*--------------------------------------------------------------------- | This function does the (block) forward elimination in ARMS | new old | | | | | | | | | L 0 | | wx1 | | x1 | | | | | | = | | | | EU^{-1} I | | wx2 | | x2 | | | | | | | | | x used and not touched -- or can be the same as wk. |--------------------------------------------------------------------*/ /* local variables */ int j, len=levmat->n, lenB=levmat->nB, *iperm=levmat->rperm; double *work = levmat->wk; /*------------------------------------------------------ | apply permutation P to rhs |-----------------------------------------------------*/ for (j=0; jL, work, wk); /* sol: L x = x */ Usol(levmat->U, wk, work); /* sol: U work(2) = work */ /*-------------------- compute x[lenb:.] = x [lenb:.] - E * work(1) */ matvecz (levmat->E, work, &work[lenB], &wk[lenB]) ; return 0; } /*----end-of-descend--------------------------------------------------- |---------------------------------------------------------------------- |--------------------------------------------------------------------*/ int ascend (p4ptr levmat, double *x, double *wk) { /*--------------------------------------------------------------------- | This function does the (block) backward substitution: | | | | | | | | | | U L^{-1}F | | wk1 | | x1 | | | | | | = | | | | 0 S | | wk2 | | x2 | <<-- x2 already computed. | | | | | | | and we need x1 | | with x2 = S^{-1} wk2 [assumed to have been computed ] |--------------------------------------------------------------------*/ /*-------------------- local variables */ int j, len=levmat->n, lenB=levmat->nB, *qperm=levmat->perm; double *work = levmat->wk; /*-------------------- copy x onto wk */ matvec(levmat->F, &x[lenB], work); /* work = F * x_2 */ Lsol(levmat->L, work, work); /* work = L \ work */ for (j=0; jU, work, work); /* wk1 = U \ wk1 */ memcpy(&work[lenB],&x[lenB],(len-lenB)*sizeof(double)); /*--------------------------------------- | apply reverse permutation |--------------------------------------*/ for (j=0; jn; i++) { kr = mata->ma[i]; ki = mata->ja[i]; t = y[i] ; for (k=0; knzcount[i]; k++) t -= kr[k] * x[ki[k]]; z[i] = t; } return; } /*---------------end of matvecz---------------------------------------- *--------------------------------------------------------------------*/ p4ptr Lvsol2(double *x, int nlev, p4ptr levmat, ilutptr ilusch) { /* Macro L-solve -- corresponds to left (L) part of arms | preconditioning operation -- | on entry : | x = right- hand side to be operated on by the preconditioner | on return : x is overwritten | x = output result of operation | | Note : in-place operation -- b and x can occupy the same space.. | --------------------------------------------------------------------*/ /*-------------------- local variables */ int nloc=levmat->n, first, lenB; p4ptr last=levmat; /*-------------------- take care of special cases : nlev==0 --> lusol */ if (nlev == 0) { SchLsol(ilusch,x); return (last); } first = 0; /*-------------------- descend */ while (levmat) { nloc=levmat->n; lenB =levmat->nB; /*-------------------- left scaling */ if (levmat->D1 != NULL) dscale(nloc,levmat->D1, &x[first], &x[first]); /*-------------------- RESTRICTION/ DESCENT OPERATION */ if (lenB) descend (levmat, &x[first], &x[first]); first += lenB; last = levmat; levmat = levmat->next; /*--------------------------------------------------------------------- | next level +--------------------------------------------------------------------*/ } SchLsol(ilusch,&x[first]); return last; } int Uvsol2(double *x, int nlev, int n, p4ptr levmat, ilutptr ilusch) { /* Macro U-solve -- corresponds to right (U) part of arms | preconditioning operation -- | on entry : | b = right- hand side to be operated on by the preconditioner | on return = x has been overwritten = | x = output result of operation | | Note : in-place operation -- b and x can occupy the same space.. | --------------------------------------------------------------------*/ /*-------------------- local variables */ int nloc, lenB, first; /*-------------------- work array */ /*-------------------- take care of special cases : nlev==0 --> lusol */ /*-------------------- case of zero levels */ if (nlev == 0) { SchUsol(ilusch, x); return(0); } /*-------------------- general case */ nloc=levmat->n; lenB=levmat->nB; first = n - nloc; /*-------------------- last level */ first += lenB; SchUsol(ilusch, &x[first]); /*-------------------- other levels */ while (levmat) { nloc = levmat->n; first -= levmat->nB; if (levmat->n) ascend(levmat, &x[first],&x[first]); /*-------------------- right scaling */ if (levmat->D2 != NULL) dscale(nloc, levmat->D2, &x[first], &x[first]) ; levmat = levmat->prev; } return 0; /*-------------------- PROLONGATION/ ASCENT OPERATION */ } int armsol2(double *x, arms Prec) { /* combined preconditioning operation -- combines the | left and right actions. | | on entry : | x = right- hand side to be operated on by the preconditioner | on return : x is overwritten - | x = output result of operation | | Note : in-place operation -- b and x can occupy the same space.. | --------------------------------------------------------------------*/ /*-------------------- local variables */ p4ptr levmat = Prec->levmat; ilutptr ilusch = Prec->ilus; int nlev = Prec->nlev; int n = levmat->n; p4ptr last; if (nlev == 0) { n = ilusch->n; SchLsol(ilusch, x); SchUsol(ilusch, x); return 0; } last = Lvsol2(x, nlev, levmat, ilusch) ; Uvsol2(x, nlev, n, last, ilusch) ; return 0; } void SchLsol(ilutptr ilusch, double *y) { /*--------------------------------------------------------------------- | Forward solve for Schur complement part = |---------------------------------------------------------------------- | on entry: | ilusch = the LU matrix as provided from the ILU functions. | y = the right-hand-side vector | | on return | y = solution of LU x = y. [overwritten] |---------------------------------------------------------------------*/ /*-------------------- local variables */ int n = ilusch->n, j, *perm = ilusch->rperm; double *work = ilusch->wk; /*-------------------- begin: right scaling */ if (ilusch->D1 != NULL) dscale(n, ilusch->D1, y, y); /*-------------------- ONE SIDED ROW PERMS */ if (perm != NULL) { for (j=0; jL, work, y); } else Lsol(ilusch->L, y, y); /*---------------end of SchLsol--------------------------------------- ----------------------------------------------------------------------*/ } void SchUsol(ilutptr ilusch, double *y) { /*--------------------------------------------------------------------- | U-solve for Schur complement - |---------------------------------------------------------------------- | on entry: | ilusch = the LU matrix as provided from the ILU functions. | y = the right-hand-side vector | | on return | y = solution of U x = y. [overwritten on y] |----------------------------------------------------------------------*/ int n = ilusch->n, j, *perm = ilusch->perm, *cperm; double *work = ilusch->wk; /* -------------------- begin by U-solving */ /*-------------------- CASE: column pivoting used (as in ILUTP) */ if (ilusch->perm2 != NULL) { Usol(ilusch->U, y, y); cperm = ilusch->perm2; for (j=0; jU, y, work); /*-------------------- generic permutation */ if (perm != NULL) { for (j=0; jD2 !=NULL) dscale(n, ilusch->D2, y, y); } /*---------------end of SchUsol--------------------------------------- ----------------------------------------------------------------------*/ void luinv( int n, double *a, double *x, double *y ) { /*-------------------------------------------------------- * does the operation y = inv(a) * x * where a has already been factored by Gauss. * LUy = x *------------------------------------------------------*/ int i, j, bsA, bsB; double sum; /* Ly0 = x -- use Lsol ? */ for( i = 0; i < n; i++ ) { sum = x[i]; bsA = i - n; for( j = 0; j < i; j++ ) { bsA += n; sum -= a[bsA] * y[j]; /* a(i,j) * y(j) */ } y[i] = sum; } /* Uy = y0 */ bsB = i * n; for( i = n-1; i >= 0; i-- ) { sum = y[i]; bsB -= n; bsA = i+bsB; for( j = i+1; j < n; j++ ) { bsA += n; sum -= a[bsA] * y[j]; /* a(i,j) * y(j) */ } y[i] = sum * a[bsB+i]; /* a(i,i) */ } } int lusolC( double *y, double *x, iluptr lu ) { /*---------------------------------------------------------------------- * performs a forward followed by a backward solve * for LU matrix as produced by iluk * y = right-hand-side * x = solution on return * lu = LU matrix as produced by iluk. *--------------------------------------------------------------------*/ int n = lu->n, i, j, nzcount, *ja; double *D; csptr L, U; L = lu->L; U = lu->U; D = lu->D; /* Block L solve */ for( i = 0; i < n; i++ ) { x[i] = y[i]; nzcount = L->nzcount[i]; ja = L->ja[i]; for( j = 0; j < nzcount; j++ ) { x[i] -= x[ja[j]] * L->ma[i][j]; } } /* Block -- U solve */ for( i = n-1; i >= 0; i-- ) { nzcount = U->nzcount[i]; ja = U->ja[i]; for( j = 0; j < nzcount; j++ ) { x[i] -= x[ja[j]] * U->ma[i][j]; } x[i] *= D[i]; } return (0); } int vblusolC( double *y, double *x, vbiluptr lu) { /*---------------------------------------------------------------------- * performs a forward followed by a backward block solve * for LU matrix as produced by VBILUT * y = right-hand-side * x = solution on return * lu = LU matrix as produced by VBILUT * * note: lu->bf is used to store vector *--------------------------------------------------------------------*/ int n = lu->n, *bsz = lu->bsz, i, j, bi, icol, dim, sz; int nzcount, nBs, nID, *ja, inc = 1, OPT; double *data, alpha = -1.0, beta = 1.0, alpha2 = 1.0, beta2 = 0.0; vbsptr L, U; BData *D, *ba; L = lu->L; U = lu->U; D = lu->D; OPT = lu->DiagOpt; /* Block L solve */ for( i = 0; i < n; i++ ) { dim = B_DIM(bsz,i); nBs = bsz[i]; for( j = 0; j < dim; j++ ) { nID = nBs + j; x[nID] = y[nID]; } nzcount = L->nzcount[i]; ja = L->ja[i]; ba = L->ba[i]; for( j = 0; j < nzcount; j++ ) { icol = ja[j]; sz = B_DIM(bsz,icol); data = ba[j]; DGEMV( "n", dim, sz, alpha, data, dim, x+bsz[icol], inc, beta, x+nBs, inc ); } } /* Block -- U solve */ for( i = n-1; i >= 0; i-- ) { dim = B_DIM(bsz,i); nzcount = U->nzcount[i]; nBs = bsz[i]; ja = U->ja[i]; ba = U->ba[i]; for( j = 0; j < nzcount; j++ ) { icol = ja[j]; sz = B_DIM(bsz,icol); data = ba[j]; DGEMV( "n", dim, sz, alpha, data, dim, x+bsz[icol], inc, beta, x+nBs, inc ); } data = D[i]; if (OPT == 1) luinv( dim, data, x+nBs, lu->bf ); else DGEMV( "n", dim, dim, alpha2, data, dim, x+nBs, inc, beta2, lu->bf, inc ); for( bi = 0; bi < dim; bi++ ) { x[nBs+bi] = lu->bf[bi]; } } return 0; } int rpermC(csptr mat, int *perm) { /*---------------------------------------------------------------------- | | This subroutine permutes the rows of a matrix in SpaFmt format. | rperm computes B = P A where P is a permutation matrix. | The permutation P is defined through the array perm: for each j, | perm[j] represents the destination row number of row number j. | |----------------------------------------------------------------------- | on entry: |---------- | (amat) = a matrix stored in SpaFmt format. | | | on return: | ---------- | (amat) = P A stored in SpaFmt format. | | integer value returned: | 0 --> successful return. | 1 --> memory allocation error. |---------------------------------------------------------------------*/ int **addj, *nnz, i, size=mat->n; double **addm; addj = (int **)Malloc( size*sizeof(int *), "rpermC" ); addm = (double **) Malloc( size*sizeof(double *), "rpermC" ); nnz = (int *) Malloc( size*sizeof(int), "rpermC" ); for (i=0; ija[i]; addm[perm[i]] = mat->ma[i]; nnz[perm[i]] = mat->nzcount[i]; } for (i=0; ija[i] = addj[i]; mat->ma[i] = addm[i]; mat->nzcount[i] = nnz[i]; } free(addj); free(addm); free(nnz); return 0; } int cpermC(csptr mat, int *perm) { /*---------------------------------------------------------------------- | | This subroutine permutes the columns of a matrix in SpaFmt format. | cperm computes B = A P, where P is a permutation matrix. | that maps column j into column perm(j), i.e., on return | The permutation P is defined through the array perm: for each j, | perm[j] represents the destination column number of column number j. | |----------------------------------------------------------------------- | on entry: |---------- | (mat) = a matrix stored in SpaFmt format. | | | on return: | ---------- | (mat) = A P stored in SpaFmt format. | | integer value returned: | 0 --> successful return. | 1 --> memory allocation error. |---------------------------------------------------------------------*/ int i, j, *newj, size=mat->n, *aja; newj = (int *) Malloc( size*sizeof(int), "cpermC" ); for (i=0; ija[i]; for (j=0; jnzcount[i]; j++) newj[j] = perm[aja[j]]; for (j=0; jnzcount[i]; j++) aja[j] = newj[j]; mat->ja[i] = aja; } free(newj); return 0; } int dpermC(csptr mat, int *perm) { /*---------------------------------------------------------------------- | | This subroutine permutes the rows and columns of a matrix in | SpaFmt format. dperm computes B = P^T A P, where P is a permutation | matrix. | |----------------------------------------------------------------------- | on entry: |---------- | (amat) = a matrix stored in SpaFmt format. | | | on return: | ---------- | (amat) = P^T A P stored in SpaFmt format. | | integer value returned: | 0 --> successful return. | 1 --> memory allocation error. |---------------------------------------------------------------------*/ if (rpermC(mat, perm)) return 1; if (cpermC(mat, perm)) return 1; return 0; } int CSparTran( csptr amat, csptr bmat, CompressType *compress ) { /*---------------------------------------------------------------------- | Finds the compressed transpose of a matrix stored in SpaFmt format. | Patterns only. |----------------------------------------------------------------------- | on entry: |---------- | (amat) = a matrix stored in SpaFmt format. | (compress) = quotient graph of matrix amat | | on return: | ---------- | (bmat) = the compressed transpose of (mata) stored in SpaFmt | format. | | integer value returned: | 0 --> successful return. | 1 --> memory allocation error. |---------------------------------------------------------------------*/ int i, j, *ind, nzcount, pos, size=amat->n, *aja; ind = bmat->nzcount; for (i=0; ija[i]; nzcount = amat->nzcount[i]; for (j=0; j < nzcount; j++) { pos = aja[j]; if( compress[pos].grp == -1 ) { ind[pos]++; } } } /*-------------------- allocate space */ for (i=0; ija[i] = NULL; continue; } bmat->ja[i] = (int *)Malloc( ind[i]*sizeof(int), "CSparTran" ); ind[i] = 0; /* indicate next available position of each row */ } /*-------------------- now do the actual copying */ for (i=0; ija[i]; nzcount = amat->nzcount[i]; for (j = 0; j < nzcount; j++) { pos = aja[j]; if( compress[pos].grp == -1 ) { bmat->ja[pos][ind[pos]] = i; ind[pos]++; } } } return 0; } double vbnorm2( int sz, double *a ) { /*-------------------- return average norm among a[sz] */ int tmp = 1; return DNRM2( sz, a, tmp ) / (double)sz; } int condestLU( iluptr lu, double *y, double *x, FILE *fp ) { int n = lu->n, i; double norm = 0.0; for( i = 0; i < n; i++ ) { y[i] = 1.0; } lusolC( y, x, lu ); for( i = 0; i < n; i++ ) { norm = max( norm, fabs(x[i]) ); } fprintf( fp, "ILU inf-norm lower bound : %16.2f\n", norm ); if( norm > 1e30 ) { return -1; } return 0; } /*-----------------------------------------------------------------------*/ int condestArms(arms armspre, double *y, FILE *fp ) { /*-------------------- simple estimate of cond. number of precon */ int n = armspre->n, i; double norm = 0.0; for( i = 0; i < n; i++ ) y[i] = 1.0; armsol2(y, armspre) ; for( i = 0; i < n; i++ ) { norm = max( norm, fabs(y[i]) ); } fprintf( fp, "ARMS inf-norm lower bound = : %16.2f\n", norm ); if( norm > 1e30 ) { return -1; } return 0; } int VBcondestC( vbiluptr lu, double *y, double *x, FILE *fp ) { int n = lu->n, i; double norm = 0.0; for( i = 0; i < lu->bsz[n]; i++ ) { y[i] = 1.0; } vblusolC( y, x, lu ); for( i = 0; i < lu->bsz[n]; i++ ) { norm = max( norm, fabs(x[i]) ); } fprintf( fp, "VBILU inf-norm lower bound : %16.2f\n", norm ); if( norm > 1e30 ) { return -1; } return 0; } void matvecCSR(SMatptr mat, double *x, double *y) { /*-------------------- matvec for csr format using the SMatptr struct*/ matvec(mat->CSR, x, y ) ; } void matvecVBR(SMatptr mat, double *x, double *y) { /*-------------------- matvec for vbr format using the SMat struct*/ vbmatvec(mat->VBCSR, x, y ) ; } /* for iluc -- now removed. void matvecLDU(SMatptr mat, double *x, double *y) { -------------------- matvec for ldu format using the Smatrix struct lumatvec(mat->LDU, x, y ); } */ /*-------------------- preconditioning operations */ int preconILU(double *x, double *y, SPreptr mat) { /*-------------------- precon for csr format using the SPre struct*/ return lusolC(x, y, mat->ILU) ; } int preconVBR(double *x, double *y, SPreptr mat) { /*-------------------- precon for ldu format using the SPre struct*/ return vblusolC(x, y, mat->VBILU) ; } /* removed -- ILUC related int preconLDU(double *x, double *y, SPreptr mat) { -------------------- precon for vbr format using the SPre struct return lumsolC(x, y, mat->ILU) ; } */ int preconARMS(double *x, double *y, SPreptr mat) { /*-------------------- precon for ldu format using the SPre struct*/ int n = (mat->ARMS)->n ; memcpy(y, x, n*sizeof(double)); return armsol2(y, mat->ARMS) ; } itsol-1.0.0/LIB/misc.c0000640000265600020320000003246711062577473013517 0ustar tilleaadmin#include #include #include #include #include "globheads.h" #include "protos.h" int qsplitC(double *a, int *ind, int n, int Ncut) { /*---------------------------------------------------------------------- | does a quick-sort split of a real array. | on input a[0 : (n-1)] is a real array | on output is permuted such that its elements satisfy: | | abs(a[i]) >= abs(a[Ncut-1]) for i < Ncut-1 and | abs(a[i]) <= abs(a[Ncut-1]) for i > Ncut-1 | | ind[0 : (n-1)] is an integer array permuted in the same way as a. |---------------------------------------------------------------------*/ double tmp, abskey; int j, itmp, first, mid, last, ncut; ncut = Ncut - 1; first = 0; last = n-1; if (ncutlast) return 0; /* outer loop -- while mid != ncut */ do{ mid = first; abskey = fabs(a[mid]); for (j=first+1; j<=last; j++) { if (fabs(a[j]) > abskey) { mid = mid+1; tmp = a[mid]; itmp = ind[mid]; a[mid] = a[j]; ind[mid] = ind[j]; a[j] = tmp; ind[j] = itmp; } } /*-------------------- interchange */ tmp = a[mid]; a[mid] = a[first]; a[first] = tmp; itmp = ind[mid]; ind[mid] = ind[first]; ind[first] = itmp; /*-------------------- test for while loop */ if (mid == ncut) break; if (mid > ncut) last = mid-1; else first = mid+1; }while(mid != ncut); return 0; } /*--------------- end of qsplitC ---------------------------------------- |---------------------------------------------------------------------*/ int SparTran(csptr amat, csptr bmat, int job, int flag) { /*---------------------------------------------------------------------- | Finds the transpose of a matrix stored in SpaFmt format. | |----------------------------------------------------------------------- | on entry: |---------- | (amat) = a matrix stored in SpaFmt format. | | job = integer to indicate whether to fill the values (job.eq.1) | of the matrix (bmat) or only the pattern. | | flag = integer to indicate whether the matrix has been filled | 0 - no filled | 1 - filled | | on return: | ---------- | (bmat) = the transpose of (mata) stored in SpaFmt format. | | integer value returned: | 0 --> successful return. | 1 --> memory allocation error. |---------------------------------------------------------------------*/ int i, j, *ind, pos, size=amat->n, *aja; double *ama=NULL; ind = (int *) Malloc(size*sizeof(int), "SparTran:1" ); for (i=0; ija[i]; for (j=0; jnzcount[i]; j++) ind[aja[j]]++; } /*-------------------- allocate space */ for (i=0; ija[i] = (int *) Malloc(ind[i]*sizeof(int), "SparTran:2" ); bmat->nzcount[i] = ind[i]; if (job == 1) { bmat->ma[i] = (double *) Malloc(ind[i]*sizeof(double), "SparTran:3" ); } ind[i] = 0; } } /*-------------------- now do the actual copying */ for (i=0; ija[i]; if (job == 1) ama = amat->ma[i]; for (j=0; jnzcount[i]; j++) { pos = aja[j]; bmat->ja[pos][ind[pos]] = i; if (job == 1) bmat->ma[pos][ind[pos]] = ama[j]; ind[pos]++; } } free(ind); return 0; } /*-------------- end of SparTran --------------------------------------- |---------------------------------------------------------------------*/ void swapj(int v[], int i, int j){ int temp; temp = v[i]; v[i] = v[j]; v[j] = temp; } void swapm(double v[], int i, int j) { double temp; temp = v[i]; v[i] = v[j]; v[j] = temp; } int roscalC(csptr mata, double *diag, int nrm) { /*--------------------------------------------------------------------- | | This routine scales each row of mata so that the norm is 1. | |---------------------------------------------------------------------- | on entry: | mata = the matrix (in SpaFmt form) | nrm = type of norm | 0 (\infty), 1 or 2 | | on return | diag = diag[j] = 1/norm(row[j]) | | 0 --> normal return | j --> row j is a zero row |--------------------------------------------------------------------*/ /* local variables */ int i, k; double *kr, scal; for (i=0; in; i++) { scal = 0.0; kr = mata->ma[i]; if (nrm == 0) { for (k=0; knzcount[i]; k++) if (fabs(kr[k]) > scal) scal = fabs(kr[k]); } else if (nrm == 1) { for (k=0; knzcount[i]; k++) scal += fabs(kr[k]); } else { /* nrm = 2 */ for (k=0; knzcount[i]; k++) scal += kr[k]*kr[k]; } if (nrm == 2) scal = sqrt(scal); if (scal == 0.0) { scal = 1.0; /* YS. return i+1; */ } else scal = 1.0 / scal; diag[i] = scal; for (k=0; knzcount[i]; k++) kr[k] = kr[k] * scal; } return 0; } /*---------------end of roscalC----------------------------------------- ----------------------------------------------------------------------*/ int coscalC(csptr mata, double *diag, int nrm) { /*--------------------------------------------------------------------- | | This routine scales each column of mata so that the norm is 1. | |---------------------------------------------------------------------- | on entry: | mata = the matrix (in SpaFmt form) | nrm = type of norm | 0 (\infty), 1 or 2 | | on return | diag = diag[j] = 1/norm(row[j]) | | 0 --> normal return | j --> column j is a zero column |--------------------------------------------------------------------*/ /* local variables */ int i, j, k; double *kr; int *ki; for (i=0; in; i++) diag[i] = 0.0; /*--------------------------------------- | compute the norm of each column |--------------------------------------*/ for (i=0; in; i++) { kr = mata->ma[i]; ki = mata->ja[i]; if (nrm == 0) { for (k=0; knzcount[i]; k++) { j = ki[k]; if (fabs(kr[k]) > diag[j]) diag[j] = fabs(kr[k]); } } else if (nrm == 1) { for (k=0; knzcount[i]; k++) diag[ki[k]] += fabs(kr[k]); } else { /* nrm = 2 */ for (k=0; knzcount[i]; k++) diag[ki[k]] += kr[k]*kr[k]; } } if (nrm == 2) { for (i=0; in; i++) diag[i] = sqrt(diag[i]); } /*--------------------------------------- | invert |--------------------------------------*/ for (i=0; in; i++) { if (diag[i] == 0.0) /* return i+1;*/ diag[i] = 1.0; else diag[i] = 1.0 / diag[i]; } /*--------------------------------------- | C = A * D |--------------------------------------*/ for (i=0; in; i++) { kr = mata->ma[i]; ki = mata->ja[i]; for (k=0; knzcount[i]; k++) kr[k] = kr[k] * diag[ki[k]]; } return 0; } /*---------------end of coscalC----------------------------------------- ----------------------------------------------------------------------*/ void dscale(int n, double *dd, double *x, double * y) { /* Computes y == DD * x */ /* scales the vector x by the diagonal dd - output in y */ int k; for (k=0; k= right) return; if (abval) { swapj(ja, left, (left+right)/2); swapm(ma, left, (left+right)/2); last = left; for (i=left+1; i<=right; i++) { if (fabs(ma[i]) > fabs(ma[left])) { swapj(ja, ++last, i); swapm(ma, last, i); } } swapj(ja, left, last); swapm(ma, left, last); qsortC(ja, ma, left, last-1, abval); qsortC(ja, ma, last+1, right, abval); } else { swapj(ja, left, (left+right)/2); swapm(ma, left, (left+right)/2); last = left; for (i=left+1; i<=right; i++) { if (ma[i] > ma[left]) { swapj(ja, ++last, i); swapm(ma, last, i); } } swapj(ja, left, last); swapm(ma, left, last); qsortC(ja, ma, left, last-1, abval); qsortC(ja, ma, last+1, right, abval); } } void printmat(FILE *ft, csptr A, int i0, int i1){ /*-------------------------------------------------------------+ | to dump rows i0 to i1 of matrix for debugging purposes | |--------------------------------------------------------------*/ int i, k, nzi; int *row; double *rowm; for (i=i0; inzcount[i]; row = A->ja[i]; rowm = A->ma[i]; for (k=0; k< nzi; k++){ fprintf(ft," row %d a %e ja %d \n", i+1, rowm[k], row[k]+1); } } } void qsortR2I(double *wa, int *cor1, int *cor2, int left, int right){ /*---------------------------------------------------------------------- | | qqsort: sort wa[left]...wa[right] into decreasing order | from Kernighan & Ritchie | |---------------------------------------------------------------------*/ int i, last; if (left >= right) return; swapm(wa, left, (left+right)/2); swapj(cor1, left, (left+right)/2); swapj(cor2, left, (left+right)/2); last = left; for (i=left+1; i<=right; i++) { if (wa[i] > wa[left]) { swapm(wa, ++last, i); swapj(cor1, last, i); swapj(cor2, last, i); } } swapm(wa, left, last); swapj(cor1, left, last); swapj(cor2, left, last); qsortR2I(wa, cor1, cor2, left, last-1); qsortR2I(wa, cor1, cor2, last+1, right); } void qsort2C(int *ja, double *ma, int left, int right, int abval){ /*---------------------------------------------------------------------- | | qqsort: sort ma[left]...ma[right] into increasing order | from Kernighan & Ritchie | | ja holds the column indices | abval = 1: consider absolute values | 0: values | |---------------------------------------------------------------------*/ int i, last; if (left >= right) return; if (abval) { swapj(ja, left, (left+right)/2); swapm(ma, left, (left+right)/2); last = left; for (i=left+1; i<=right; i++) { if (fabs(ma[i]) < fabs(ma[left])) { swapj(ja, ++last, i); swapm(ma, last, i); } } swapj(ja, left, last); swapm(ma, left, last); qsort2C(ja, ma, left, last-1, abval); qsort2C(ja, ma, last+1, right, abval); } else { swapj(ja, left, (left+right)/2); swapm(ma, left, (left+right)/2); last = left; for (i=left+1; i<=right; i++) { if (ma[i] < ma[left]) { swapj(ja, ++last, i); swapm(ma, last, i); } } swapj(ja, left, last); swapm(ma, left, last); qsort2C(ja, ma, left, last-1, abval); qsort2C(ja, ma, last+1, right, abval); } } void qqsort(int *ja, double *ma, int left, int right){ /*---------------------------------------------------------------------- | | qqsort: sort ja[left]...ja[right] into increasing order | from Kernighan & Ritchie | | ma holds the real values | |---------------------------------------------------------------------*/ int i, last; if (left >= right) return; swapj(ja, left, (left+right)/2); swapm(ma, left, (left+right)/2); last = left; for (i=left+1; i<=right; i++) { if (ja[i] < ja[left]) { swapj(ja, ++last, i); swapm(ma, last, i); } } swapj(ja, left, last); swapm(ma, left, last); qqsort(ja, ma, left, last-1); qqsort(ja, ma, last+1, right); } void hilosort(csptr mat, int abval, int hilo){ /*---------------------------------------------------------------------- | | This routine sorts the entries in each row of a matrix from hi to low. | |----------------------------------------------------------------------- | on entry: |---------- | (mat) = a matrix stored in SpaFmt format. | | abval = 1: use absolute values of entries | 0: use values | | hilo = 1: sort in decreasing order | 0: sort in increasing order | | | on return: | ---------- | (mat) = (mat) where each row is sorted. | |---------------------------------------------------------------------*/ int j, n=mat->n, *nnz=mat->nzcount; if (hilo) for (j=0; jja[j], mat->ma[j], 0, nnz[j]-1, abval); else for (j=0; jja[j], mat->ma[j], 0, nnz[j]-1, abval); return; } /*------- end of hilosort ---------------------------------------------- |---------------------------------------------------------------------*/ void qsort3i(int *wa, int *cor1, int *cor2, int left, int right) /*---------------------------------------------------------------------- | | qqsort: sort wa[left]...wa[right] into increasing order | from Kernighan & Ritchie | |---------------------------------------------------------------------*/ { int i, last; if (left >= right) return; swapj(wa, left, (left+right)/2); swapj(cor1, left, (left+right)/2); swapj(cor2, left, (left+right)/2); last = left; for (i=left+1; i<=right; i++) { if (wa[i] < wa[left]) { swapj(wa, ++last, i); swapj(cor1, last, i); swapj(cor2, last, i); } } swapj(wa, left, last); swapj(cor1, left, last); swapj(cor2, left, last); qsort3i(wa, cor1, cor2, left, last-1); qsort3i(wa, cor1, cor2, last+1, right); } itsol-1.0.0/LIB/globheads.h0000640000265600020320000001620411062577473014510 0ustar tilleaadmin#ifndef __VBLOCK_HEADER_H__ #define __VBLOCK_HEADER_H__ #define MAX_BLOCK_SIZE 100 /* FORTRAN style vblock format, compatible for many FORTRAN routines */ #define DATA(a,row,i,j) (a[(j)*(row)+(i)]) /* the dimension of ith Block */ #define B_DIM(bs,i) (bs[i+1]-bs[i]) typedef struct SpaFmt { /*--------------------------------------------- | C-style CSR format - used internally | for all matrices in CSR format |---------------------------------------------*/ int n; int *nzcount; /* length of each row */ int **ja; /* pointer-to-pointer to store column indices */ double **ma; /* pointer-to-pointer to store nonzero entries */ } SparMat, *csptr; typedef double *BData; typedef struct VBSpaFmt { int n; /* the block row dimension of the matrix */ int *bsz; /* the row/col of the first element of each */ /* diagonal block */ int *nzcount; /* length of each row */ int **ja; /* pointer-to-pointer to store column indices */ BData **ba; /* pointer-to-pointer to store nonzero blocks */ BData *D; /* to store inversion of diagonals */ } VBSparMat, *vbsptr; typedef struct VBILUfac { int n; int *bsz; /* the row/col of the first element of each */ /* diagonal block */ BData *D; /* diagonal blocks */ vbsptr L; /* L part blocks */ vbsptr U; /* U part blocks */ int *work; /* working buffer */ BData bf; /* buffer of a temp block */ int DiagOpt; /* Option for diagonal inversion/solutiob */ /* opt = 1 -->> call luinv */ /* opt == 2 -->> block inverted call dgemv */ } VBILUSpar, *vbiluptr; typedef struct ILUfac { int n; csptr L; /* L part elements */ double *D; /* diagonal elements */ csptr U; /* U part elements */ int *work; /* working buffer */ } ILUSpar, LDUmat, *iluptr; typedef struct PerMat4 *p4ptr; typedef struct PerMat4 { /*------------------------------------------------------------ | struct for storing the block LU factorization | contains all the block factors except the | data related to the last block. | n = size of current block | symperm = whether or not permutations are symmetric. | used only in cleanP4.. | nB = size of B-block | L, U = ILU factors of B-block | F, E = sparse matrices in (1,2) and (2,1) | parts of matrix. | perm = (symmetric) permutation used in factorization | comes from the independent set ordering | rperm = unsymmetric permutation (rows) not used in this | version -- but left here for compatibility.. | D1, D2 = diagonal matrices (left, right) used for scaling | if scaling option is turned on. Note that the | method works by scaling the whole matrix first | (at any level) before anything else is done. | wk = a work vector of length n needed for various tasks | [reduces number of calls to malloc] |----------------------------------------------------------*/ int n; int nB; int symperm; /* LU factors */ struct SpaFmt *L; struct SpaFmt *U; /* E, F blocks */ struct SpaFmt *E; struct SpaFmt *F; int *rperm; /* row permutation */ int *perm; /* col. permutation */ double *D1 ; /* diagonal scaling row */ double *D2 ; /* diagonal scaling columns*/ double *wk; /* work array */ /* pointer to next and previous struct */ p4ptr prev; p4ptr next; } Per4Mat; /* -------------------------------------------------------------------*/ typedef struct ILUTfac *ilutptr; typedef struct ILUTfac { /*------------------------------------------------------------ | struct for storing data related to the last schur complement | we need to store the C matrix associated with the last block | and the ILUT factorization of the related Schur complement. | | n = size of C block = size of Schur complement | C = C block of last level matrix. | L, U = ILU factors of last schur complement. | | meth[4] = parameters for defining variants in factorization | - see function readin for details | rperm = row permutation used for very nonsymmetric matrices | [such as bottleneck transversal] -- NOT IN THIS VERSION | perm2 = unsymmetric permutation (columns) - used primarily | for the ILUTP version of ILUT/.. | D1, D2 = diagonal matrices (left, right) used for scaling | if scaling option is turned on. Note that the | method works by scaling the whole matrix first | (at any level) before anything else is done. | wk = a work vector of length n needed for various tasks | [reduces number of calls to malloc] |-----------------------------------------------------------*/ int n; /*-------------------- C matrix of last block */ struct SpaFmt *C; /* LU factorization */ struct SpaFmt *L; struct SpaFmt *U; /*-------------------- related to variants and methods */ /* int meth[4]; */ int *rperm; /* row single-sinded permutation */ int *perm; /* column perm . */ int *perm2; /* column permutation coming from pivoting in ILU */ double *D1; double *D2; double *wk; } IluSpar; typedef struct arms_st *arms; typedef struct arms_st { /* this is the arms preconditioner struct | it consists of a linked list of p4mat structs | and the ILUt factorization (in the form of an | IluSpar struct |---------------------------------------------- */ int n; /* dimension of matrix */ int nlev; /* number of levels */ ilutptr ilus; /* ILU for last level */ p4ptr levmat; /* level structure */ } armsMat; typedef struct __CompressType { int grp; /* -1: begin new group, >=0: belong to grp-th row */ int count; /* block size, valid only if grp = -1 */ } CompressType; typedef struct _SMat { /*-------------------- 3 types of matrices so far */ int n; int Mtype; /*-- type 1 = CSR, 2 = VBCSR, 3 = LDU */ csptr CSR; /* place holder for a CSR/CSC type matrix */ iluptr LDU; /* struct for an LDU type matrix */ vbsptr VBCSR; /* place holder for a block matrix */ void (*matvec)(struct _SMat*, double *, double *); } SMat, *SMatptr; typedef struct _SPre { /*-------------------- 3 types of matrices so far */ int Ptype; /*-- Ptype 1 = ILU, 2 = VBILU, 3 = Crout */ iluptr ILU; /* struct for an ILU type preconditioner */ vbiluptr VBILU; /* struct for a block preconditioner */ arms ARMS; /* struct for a block preconditioner */ int (*precon) (double *, double *, struct _SPre*); } SPre, *SPreptr; #endif /* __VBLOCK_HEADER_H__ */ itsol-1.0.0/LIB/defs.h0000640000265600020320000000121311062577473013473 0ustar tilleaadmin #define qsplit qsplit_ #define dgemv dgemv_ #define readmtc readmtc_ #define csrcsc csrcsc_ #define roscal roscal_ #define coscal coscal_ #ifdef _SGI #define dnrm2 dnrm2_ #define ddot ddot_ #define daxpy daxpy_ #else #ifdef _LINUX #define dnrm2 dnrm2_ #define ddot ddot_ #define daxpy daxpy_ #else #ifdef _IBM #define dnrm2 dnrm2 #define ddot ddot #define daxpy daxpy #else #define dnrm2 dnrm2_ #define ddot ddot_ #define daxpy daxpy_ #endif #endif #endif #ifndef min #define min(a,b) (((a)>(b))?(b):(a)) #endif #ifndef max #define max(a,b) (((a)>(b))?(a):(b)) #endif #define MAX_LINE 256 #define MAX_HBNAME 64 #define MAX_MAT 100 itsol-1.0.0/LIB/systimer.c0000640000265600020320000000161511062577473014432 0ustar tilleaadmin#include /* * Purpose * ======= * Returns the time in seconds used by the process. * * Note: the timer function call is machine dependent. Use conditional * compilation to choose the appropriate function. * */ #ifdef _GIVE_UP_THIS_ONE_ /* * It uses the system call gethrtime(3C), which is accurate to * nanoseconds. */ #include double sys_timer() { return ( (double)gethrtime() / 1e9 ); } #else #include #include #include #include #ifndef CLK_TCK #define CLK_TCK 100 #endif #ifndef CLOCKS_PER_SEC #define CLOCKS_PER_SEC 1000000 #endif double sys_timer_CLOCK() { clock_t tmp; tmp = clock(); return (double) tmp/(CLOCKS_PER_SEC); } double sys_timer() { struct tms use; clock_t tmp; times(&use); tmp = use.tms_utime + use.tms_stime; return (double)(tmp) / CLK_TCK; } #endif itsol-1.0.0/LIB/armsol20000640000265600020320000001535011062577473013712 0ustar tilleaadmin#include #include #include #include #include "./LIB/heads.h" #include "./LIB/protos.h" /*-----------------------------------------------------------------------*/ void dscale(int , double*, double*, double*); p4ptr Lvsol2(double *x, int nlev, p4ptr levmat, ilutptr ilusch) ; int Uvsol2(double *x, int nlev, int n, p4ptr levmat, ilutptr ilusch); void SchLsol(ilutptr ilusch, double *y) ; void SchUsol(ilutptr ilusch, double *y) ; /*-----------------------------------------------------------------------*/ p4ptr Lvsol2(double *x, int nlev, p4ptr levmat, ilutptr ilusch) { /* Macro L-solve -- corresponds to left (L) part of arms | preconditioning operation -- | on entry : | x = right- hand side to be operated on by the preconditioner | on return : x is overwritten | x = output result of operation | | Note : in-place operation -- b and x can occupy the same space.. | --------------------------------------------------------------------*/ /*-------------------- local variables */ int nloc=levmat->n, first, lenB; p4ptr last=levmat; /*-------------------- take care of special cases : nlev==0 --> lusol */ if (nlev == 0) { SchLsol(ilusch,x); return (last); } first = 0; /*-------------------- descend */ while (levmat) { nloc=levmat->n; lenB =levmat->nB; /*-------------------- left scaling */ if (levmat->D1 != NULL) dscale(nloc,levmat->D1, &x[first], &x[first]); /*-------------------- RESTRICTION/ DESCENT OPERATION */ if (lenB) descend (levmat, &x[first], &x[first]); first += lenB; last = levmat; levmat = levmat->next; /*--------------------------------------------------------------------- | next level +--------------------------------------------------------------------*/ } SchLsol(ilusch,&x[first]); return last; } int Uvsol2(double *x, int nlev, int n, p4ptr levmat, ilutptr ilusch) { /* Macro U-solve -- corresponds to left (L) part of arms | preconditioning operation -- | on entry : | b = right- hand side to be operated on by the preconditioner | on return = x has been overwritten = | x = output result of operation | | Note : in-place operation -- b and x can occupy the same space.. | --------------------------------------------------------------------*/ /*-------------------- local variables */ int nloc, lenB, first; /*-------------------- work array */ /*-------------------- take care of special cases : nlev==0 --> lusol */ /*-------------------- case of zero levels */ if (nlev == 0) { SchUsol(ilusch, x); return(0); } /*-------------------- general case */ nloc=levmat->n; lenB=levmat->nB; first = n - nloc; /*-------------------- last level */ first += lenB; SchUsol(ilusch, &x[first]); /*-------------------- other levels */ while (levmat) { nloc = levmat->n; first -= levmat->nB; if (levmat->n) ascend(levmat, &x[first],&x[first]); /*-------------------- right scaling */ if (levmat->D2 != NULL) dscale(nloc, levmat->D2, &x[first], &x[first]) ; levmat = levmat->prev; } return 0; /*-------------------- PROLONGATION/ ASCENT OPERATION */ } int armsol2(double *x, arms Prec) { /* combined preconditioning operation -- combines the | left and right actions. | | on entry : | x = right- hand side to be operated on by the preconditioner | on return : x is overwritten - | x = output result of operation | | Note : in-place operation -- b and x can occupy the same space.. | --------------------------------------------------------------------*/ /*-------------------- local variables */ p4ptr levmat = Prec->levmat; ilutptr ilusch = Prec->ilus; int nlev = Prec->nlev; int n = levmat->n; p4ptr last; if (nlev == 0) { n = ilusch->n; SchLsol(ilusch, x); SchUsol(ilusch, x); return 0; } last = Lvsol2(x, nlev, levmat, ilusch) ; Uvsol2(x, nlev, n, last, ilusch) ; return 0; } void SchLsol(ilutptr ilusch, double *y) { /*--------------------------------------------------------------------- | Forward solve for Schur complement part = |---------------------------------------------------------------------- | on entry: | ilusch = the LU matrix as provided from the ILU functions. | y = the right-hand-side vector | | on return | y = solution of LU x = y. [overwritten] |---------------------------------------------------------------------*/ /*-------------------- local variables */ int n = ilusch->n, j, *perm = ilusch->rperm; double *work = ilusch->wk; /*-------------------- begin: right scaling */ if (ilusch->D1 != NULL) dscale(n, ilusch->D1, y, y); /*-------------------- ONE SIDED ROW PERMS */ if (perm != NULL) { for (j=0; jL, work, y); } else Lsol(ilusch->L, y, y); /*---------------end of SchLsol--------------------------------------- ----------------------------------------------------------------------*/ } void SchUsol(ilutptr ilusch, double *y) { /*--------------------------------------------------------------------- | U-solve for Schur complement - |---------------------------------------------------------------------- | on entry: | ilusch = the LU matrix as provided from the ILU functions. | y = the right-hand-side vector | | on return | y = solution of U x = y. [overwritten on y] |----------------------------------------------------------------------*/ int n = ilusch->n, j, *perm = ilusch->perm, *cperm; double *work = ilusch->wk; /* -------------------- begin by U-solving */ /*-------------------- CASE: column pivoting used (as in ILUTP) */ if (ilusch->perm2 != NULL) { Usol(ilusch->U, y, y); cperm = ilusch->perm2; for (j=0; jU, y, work); /*-------------------- generic permutation */ if (perm != NULL) { for (j=0; jD2 !=NULL) dscale(n, ilusch->D2, y, y); } /*---------------end of SchUsol--------------------------------------- ----------------------------------------------------------------------*/ itsol-1.0.0/BUG_FIXES0000644000265600020320000000365511062577476013314 0ustar tilleaadmin NOT DONE YET: Subject: [ITSOL] bug report From: Dominique Belhachemi To: saad@cs.umn.edu Content-Type: text/plain Date: Sat, 06 Sep 2008 23:01:00 +0200 Message-Id: <1220734860.4915.6.camel@localhost> Mime-Version: 1.0 X-Mailer: Evolution 2.6.3 Content-Transfer-Encoding: 7bit X-Virus-Scanned: amavisd-new at cs.tu-berlin.de (including SpamAssassin) Status: R X-Status: A X-Keywords: Yousef, I tried to compile ITSOL_1 on my machine. It failed because of a typo in LIB/systimer.c Here comes the solution : --------------------------------- #include #ifndef CLK_TCK -#define ClK_TCK 100 +#define CLK_TCK 100 #endif #ifndef CLOCKS_PER_SEC --------------------------------- Thanks for working on ITSOL. Kind regards Dominique ======================================================================= NOT DONE YET: Here are some minor hints. 1) Some lines in LIB/tools.f are too long. For example: LIB/tools.f:826 2) Are you interested in warnings? 2a) LIB/tools.f:500.42: subroutine rnrms (nrow, nrm, a, ja, ia, diag) 1 Warning: Unused dummy argument 'ja' at (1) 2b) Warning: Nonconforming tab character in column 1 of line 826 Warning: Nonconforming tab character in column 3 of line 883 Warning: Nonconforming tab character in column 3 of line 885 Warning: Nonconforming tab character in column 3 of line 887 Warning: Nonconforming tab character in column 3 of line 888 Warning: Nonconforming tab character in column 3 of line 890 Warning: Nonconforming tab character in column 3 of line 891 Warning: Nonconforming tab character in column 3 of line 892 Warning: Nonconforming tab character in column 3 of line 893 Warning: Nonconforming tab character in column 3 of line 894 and so on.... 3) Everything else looks very good ;-) Kind regards Dominique =======================================================================itsol-1.0.0/iluk.c0000640000265600020320000002261311062577473013112 0ustar tilleaadmin#include #include #include #include #include "LIB/globheads.h" #include "LIB/protos.h" #ifndef min #define min(a,b) (((a)>(b))?(b):(a)) #endif #ifndef max #define max(a,b) (((a)>(b))?(a):(b)) #endif /*--------------------protos */ int lofC( int lofM, csptr csmat, iluptr lu, FILE *fp ); /*--------------------end protos */ int ilukC( int lofM, csptr csmat, iluptr lu, FILE *fp ) { /*---------------------------------------------------------------------------- * ILUK preconditioner * incomplete LU factorization with level of fill dropping *---------------------------------------------------------------------------- * Parameters *---------------------------------------------------------------------------- * on entry: * ========= * lofM = level of fill: all entries with level of fill > lofM are * dropped. Setting lofM = 0 gives BILU(0). * csmat = matrix stored in SpaFmt format -- see heads.h for details * on format * lu = pointer to a ILUKSpar struct -- see heads.h for details * on format * fp = file pointer for error log ( might be stderr ) * * on return: * ========== * ierr = return value. * ierr = 0 --> successful return. * ierr = -1 --> error in lofC * ierr = -2 --> zero diagonal found * lu->n = dimension of the matrix * ->L = L part -- stored in SpaFmt format * ->D = Diagonals * ->U = U part -- stored in SpaFmt format *---------------------------------------------------------------------------- * Notes: * ====== * All the diagonals of the input matrix must not be zero *--------------------------------------------------------------------------*/ int ierr; int n = csmat->n; int *jw, i, j, k, col, jpos, jrow; csptr L, U; double *D; setupILU( lu, n ); L = lu->L; U = lu->U; D = lu->D; /* symbolic factorization to calculate level of fill index arrays */ if( ( ierr = lofC( lofM, csmat, lu, fp ) ) != 0 ) { fprintf( fp, "Error: lofC\n" ); return -1; } jw = lu->work; /* set indicator array jw to -1 */ for( j = 0; j < n; j++ ) jw[j] = -1; /* beginning of main loop */ for( i = 0; i < n; i++ ) { /* set up the i-th row accroding to the nonzero information from symbolic factorization */ mallocRow( lu, i ); /* setup array jw[], and initial i-th row */ for( j = 0; j < L->nzcount[i]; j++ ) { /* initialize L part */ col = L->ja[i][j]; jw[col] = j; L->ma[i][j] = 0; } jw[i] = i; D[i] = 0; /* initialize diagonal */ for( j = 0; j < U->nzcount[i]; j++ ) { /* initialize U part */ col = U->ja[i][j]; jw[col] = j; U->ma[i][j] = 0; } /* copy row from csmat into lu */ for( j = 0; j < csmat->nzcount[i]; j++ ) { col = csmat->ja[i][j]; jpos = jw[col]; if( col < i ) L->ma[i][jpos] = csmat->ma[i][j]; else if( col == i ) D[i] = csmat->ma[i][j]; else U->ma[i][jpos] = csmat->ma[i][j]; } /* eliminate previous rows */ for( j = 0; j < L->nzcount[i]; j++ ) { jrow = L->ja[i][j]; /* get the multiplier for row to be eliminated (jrow) */ L->ma[i][j] *= D[jrow]; /* combine current row and row jrow */ for( k = 0; k < U->nzcount[jrow]; k++ ) { col = U->ja[jrow][k]; jpos = jw[col]; if( jpos == -1 ) continue; if( col < i ) L->ma[i][jpos] -= L->ma[i][j] * U->ma[jrow][k]; else if( col == i ) D[i] -= L->ma[i][j] * U->ma[jrow][k]; else U->ma[i][jpos] -= L->ma[i][j] * U->ma[jrow][k]; } } /* reset double-pointer to -1 ( U-part) */ for( j = 0; j < L->nzcount[i]; j++ ) { col = L->ja[i][j]; jw[col] = -1; } jw[i] = -1; for( j = 0; j < U->nzcount[i]; j++ ) { col = U->ja[i][j]; jw[col] = -1; } if( D[i] == 0 ) { for( j = i+1; j < n; j++ ) { L->ma[j] = NULL; U->ma[j] = NULL; } fprintf( fp, "fatal error: Zero diagonal found...\n" ); return -2; } D[i] = 1.0 / D[i]; } return 0; } int lofC( int lofM, csptr csmat, iluptr lu, FILE *fp ) { /*-------------------------------------------------------------------- * symbolic ilu factorization to calculate structure of ilu matrix * for specified level of fill *-------------------------------------------------------------------- * on entry: * ========= * lofM = level of fill, lofM >= 0 * csmat = matrix stored in SpaFmt format -- see heads.h for details * on format * lu = pointer to a ILUSpar struct -- see heads.h for details * on format * fp = file pointer for error log ( might be stderr ) *-------------------------------------------------------------------- * on return: * ========== * ierr = return value. * ierr = 0 --> successful return. * ierr != 0 --> error * lu->n = dimension of the block matrix * ->L = L part -- stored in SpaFmt format, patterns only in lofC * ->U = U part -- stored in SpaFmt format, patterns only in lofC *------------------------------------------------------------------*/ int n = csmat->n; int *levls = NULL, *jbuf = NULL, *iw = lu->work; int **ulvl; /* stores lev-fils for U part of ILU factorization*/ csptr L = lu->L, U = lu->U; /*-------------------------------------------------------------------- * n = number of rows or columns in matrix * inc = integer, count of nonzero(fillin) element of each row * after symbolic factorization * ju = entry of U part of each row * lvl = buffer to store levels of each row * jbuf = buffer to store column index of each row * iw = work array *------------------------------------------------------------------*/ int i, j, k, col, ip, it, jpiv; int incl, incu, jmin, kmin; levls = (int *)Malloc( n*sizeof(int), "lofC" ); jbuf = (int *)Malloc( n*sizeof(int), "lofC" ); ulvl = (int **)Malloc( n*sizeof(int *), "lofC" ); /* initilize iw */ for( j = 0; j < n; j++ ) iw[j] = -1; for( i = 0; i < n; i++ ) { incl = 0; incu = i; /*-------------------- assign lof = 0 for matrix elements */ for( j = 0; j < csmat->nzcount[i]; j++ ) { col = csmat->ja[i][j]; if( col < i ) { /*-------------------- L-part */ jbuf[incl] = col; levls[incl] = 0; iw[col] = incl++; } else if (col > i) { /*-------------------- U-part */ jbuf[incu] = col; levls[incu] = 0; iw[col] = incu++; } } /*-------------------- symbolic k,i,j Gaussian elimination */ jpiv = -1; while (++jpiv < incl) { k = jbuf[jpiv] ; /*-------------------- select leftmost pivot */ kmin = k; jmin = jpiv; for( j = jpiv + 1; j< incl; j++) { if( jbuf[j] < kmin ) { kmin = jbuf[j]; jmin = j; } } /*-------------------- swap */ if( jmin != jpiv ) { jbuf[jpiv] = kmin; jbuf[jmin] = k; iw[kmin] = jpiv; iw[k] = jmin; j = levls[jpiv] ; levls[jpiv] = levls[jmin]; levls[jmin] = j; k = kmin; } /*-------------------- symbolic linear combinaiton of rows */ for( j = 0; j < U->nzcount[k]; j++ ) { col = U->ja[k][j]; it = ulvl[k][j]+levls[jpiv]+1 ; if( it > lofM ) continue; ip = iw[col]; if( ip == -1 ) { if( col < i) { jbuf[incl] = col; levls[incl] = it; iw[col] = incl++; } else if( col > i ) { jbuf[incu] = col; levls[incu] = it; iw[col] = incu++; } } else levls[ip] = min(levls[ip], it); } } /* end - while loop */ /*-------------------- reset iw */ for( j = 0; j < incl; j++ ) iw[jbuf[j]] = -1; for( j = i; j < incu; j++ ) iw[jbuf[j]] = -1; /*-------------------- copy L-part */ L->nzcount[i] = incl; if(incl > 0 ) { L->ja[i] = (int *)Malloc( incl*sizeof(int), "lofC" ); memcpy( L->ja[i], jbuf, sizeof(int)*incl); } /*-------------------- copy U - part */ k = incu-i; U->nzcount[i] = k; if( k > 0 ) { U->ja[i] = (int *)Malloc( sizeof(int)*k, "lofC" ); memcpy(U->ja[i], jbuf+i, sizeof(int)*k ); /*-------------------- update matrix of levels */ ulvl[i] = (int *)Malloc( k*sizeof(int), "lofC" ); memcpy( ulvl[i], levls+i, k*sizeof(int) ); } } /*-------------------- free temp space and leave --*/ free(levls); free(jbuf); for(i = 0; i < n-1; i++ ) { if (U->nzcount[i]) free(ulvl[i]) ; } free(ulvl); return 0; } itsol-1.0.0/README_INSTALL0000640000265600020320000000313711062577476014053 0ustar tilleaadmin**NOTE** ILUC has been temporarily removed for a fix +======================================================================+ |----------------- Iterative Solvers Package --------------------------| +======================================================================+ This is part of the ITSOL extention to the SPARSKIT package. This particular sub-package provides preconditioners for solving general sparse * real-valued * linear systems of equations. Once you have unpacked the tar ball -- go to the ITSOL_1 directory and edit the file 'makefile' for customizing the loaders, compilers, compiler flags, etc ... then type make lib to create the library libitsol.a Once this is done you can try some of the test examples in TESTS_COO or TESTS_HB. You can for example go to TESTS_COO and type make all which will make the executables : arms.ex, ilut.ex, iluc.ex, iluk.ex, vbilut, and vbiluk then you can execute the script runall to run all these drivers with the two sample matrices provided in .\MATRICES [two for TESTS_COO and two for TESTS_HB] The makefile in TESTS_* will require that the user edit the links to blas and lapack in the LINKS directive. To test a single preconditioner, for example the arms preconditioner type for matrices stored in coo format type: make arms.ex This should create an executable called arms.ex Typing arms.ex should run this for the sample matrices in coordinate format located in SAMPLE_MATRICES and for the input parameters in the file inputs. [two sample matrices are provided in coordinate format and two in the hb format] itsol-1.0.0/makefile0000640000265600020320000000200611064041002013444 0ustar tilleaadmin# this makefile is for LINUX machines only # ILUC removed.. OBJ = fgmr.o iluk.o ilut.o arms2.o vbiluk.o vbilut.o auxill.o LIB = ./LIB/PQ.o ./LIB/piluNEW.o ./LIB/indsetC.o \ ./LIB/sets.o ./LIB/tools.o ./LIB/systimer.o ./LIB/misc.o \ ./LIB/MatOps.o ./LIB/ilutpC.o ./LIB/setblks.o ./LIB/svdInvC.o AR = ar -rcv # FC = f77 FCFLAGS = -c -g -Wall CC = gcc CCFLAGS = -c -g -DLINUX -Wall -O3 LD = f77 LDFLAGS = # # clear list of default suffixes, and declare default suffixes .SUFFIXES: .SUFFIXES: .f .c .o # default rule to make .o files from .f files .f.o : ; $(FC) $(FCFLAGS) $*.f -o $*.o .c.o : ; $(CC) $(CCFLAGS) $*.c -o $*.o # lib libitsol.a: $(OBJ) $(LIB) $(AR) libitsol.a $(OBJ) $(LIB) ## ranlib libitsol.a # clean : rm -f ${OBJ} *.o *.ex *~ core *.cache ${LIB} LIB/*~ LIB/*.cache OUT/* cleanall : rm -f ${OBJ} *.o *.ex *.a *.cache *~ core ${LIB} \ LIB/*~ LIB/*.cache OUT/* TESTS_COO/*.o TESTS_COO/*.ex \ TESTS_HB/*.o TESTS_HB/*.ex itsol-1.0.0/arms2.c0000640000265600020320000004067111062577473013176 0ustar tilleaadmin#include #include #include #include #define PERMTOL 0.99 /* 0 --> no permutation 0.01 to 0.1 good */ #include "./LIB/globheads.h" #include "./LIB/protos.h" /*-------------------- end protos */ int arms2(csptr Amat, int *ipar, double *droptol, int *lfil, double tolind, arms PreMat, FILE *ft) { /*--------------------------------------------------------------------- | MULTI-LEVEL BLOCK ILUT PRECONDITIONER. | ealier version: June 23, 1999 BJS -- | version2: Dec. 07th, 2000, YS [reorganized ] | version 3 (latest) Aug. 2005. [reorganized + includes ddpq] +---------------------------------------------------------------------- | ON ENTRY: | ========= | ( Amat ) = original matrix A stored in C-style Compressed Sparse | Row (CSR) format -- | see LIB/heads.h for the formal definition of this format. | | ipar[0:17] = integer array to store parameters for | arms construction (arms2) | | ipar[0]:=nlev. number of levels (reduction processes). | see also "on return" below. | | ipar[1]:= level-reordering option to be used. | if ipar[1]==0 ARMS uses a block independent set ordering | with a sort of reverse cutill Mc Kee ordering to build | the blocks. This yields a symmetric ordering. | in this case the reordering routine called is indsetC | if ipar[1] == 1, then a nonsymmetric ordering is used. | In this case, the B matrix is constructed to be as | diagonally dominant as possible and as sparse as possble. | in this case the reordering routine called is ddPQ. | | ipar[2]:=bsize. for indset Dimension of the blocks. | bsize is only a target block size. The size of | each block can vary and is >= bsize. | for ddPQ: this is only the smallest size of the | last level. arms will stop when either the number | of levels reaches nlev (ipar[0]) or the size of the | next level (C block) is less than bsize. | | ipar[3]:=iout if (iout > 0) statistics on the run are | printed to FILE *ft | | ipar[4-9] NOT used [reserved for later use] - set to zero. | | The following set method options for arms2. Their default values can | all be set to zero if desired. | | ipar[10-13] == meth[0:3] = method flags for interlevel blocks | ipar[14-17] == meth[0:3] = method flags for last level block - | with the following meaning in both cases: | meth[0] nonsummetric permutations of 1: yes. affects rperm | USED FOR LAST SCHUR COMPLEMENT | meth[1] permutations of columns 0:no 1: yes. So far this is | USED ONLY FOR LAST BLOCK [ILUTP instead of ILUT]. | (so ipar[11] does no matter - enter zero). If | ipar[15] is one then ILUTP will be used instead | of ILUT. Permutation data stored in: perm2. | meth[2] diag. row scaling. 0:no 1:yes. Data: D1 | meth[3] diag. column scaling. 0:no 1:yes. Data: D2 | all transformations related to parametres in meth[*] (permutation, | scaling,..) are applied to the matrix before processing it | | ft = file for printing statistics on run | | droptol = Threshold parameters for dropping elements in ILU | factorization. | droptol[0:4] = related to the multilevel block factorization | droptol[5:6] = related to ILU factorization of last block. | This flexibility is more than is really needed. one can use | a single parameter for all. it is preferable to use one value | for droptol[0:4] and another (smaller) for droptol[5:6] | droptol[0] = threshold for dropping in L [B]. See piluNEW.c: | droptol[1] = threshold for dropping in U [B]. | droptol[2] = threshold for dropping in L^{-1} F | droptol[3] = threshold for dropping in E U^{-1} | droptol[4] = threshold for dropping in Schur complement | droptol[5] = threshold for dropping in L in last block | [see ilutpC.c] | droptol[6] = threshold for dropping in U in last block | [see ilutpC.c] | This provides a rich selection - though in practice only 4 | parameters are needed [which can be set to be the same actually] -- indeed it makes sense to take | droptol[0] = droptol[1], droptol[2] = droptol[3], | and droptol[4] = droptol[5] | | lfil = lfil[0:6] is an array containing the fill-in parameters. | similar explanations as above, namely: | lfil[0] = amount of fill-in kept in L [B]. | lfil[1] = amount of fill-in kept in U [B]. | lfil[2] = amount of fill-in kept in E L\inv | lfil[3] = amount of fill-in kept in U \inv F | lfil[4] = amount of fill-in kept in S . | lfil[5] = amount of fill-in kept in L_S . | lfil[6] = amount of fill-in kept in U_S | | tolind = tolerance parameter used by the indset function. | a row is not accepted into the independent set if | the *relative* diagonal tolerance is below tolind. | see indset function for details. Good values are | between 0.05 and 0.5 -- larger values tend to be better | for harder problems. | | ON RETURN: |============= | | (PreMat) = arms data structure which consists of two parts: | levmat and ilsch. | | ++(levmat)= permuted and sorted matrices for each level of the block | factorization stored in PerMat4 struct. Specifically | each level in levmat contains the 4 matrices in: | | | |\ | | | | \ U | | | | \ | F | | | L \ | | | | \ | | | |----------+-------| | | | | | | E | | | | | | | | plus a few other things. See LIB/heads.h for details. | | ++(ilsch) = IluSpar struct. If the block of the last level is: | | | B F | | A_l = | | | | E C | | | then IluSpar contains the block C and an ILU | factorization (matrices L and U) for the last | Schur complement [S ~ C - E inv(B) F ] | (modulo dropping) see LIB/heads.h for details. | | ipar[0] = number of levels found (may differ from input value) | +---------------------------------------------------------------------*/ /*-------------------- function prototyping done in LIB/protos.h */ /*-------------------- move above to protos.h */ p4ptr levp, levc, levn, levmat = PreMat->levmat; csptr schur, B, F, E, C=NULL; ilutptr ilsch = PreMat->ilus; /*-------------------- local variables (initialized) */ double *dd1, *dd2; int nlev = ipar[0], bsize = ipar[2], iout = ipar[3], ierr = 0; int methL[4], methS[4]; /*-------------------- local variables (not initialized) */ int nA, nB, nC, j, n, ilev, symperm; /*-------------------- work arrays: */ int *iwork, *uwork; /* timer arrays: */ /* double *symtime, *unstime, *factime, *tottime;*/ /*---------------------------BEGIN ARMS-------------------------------*/ /* schur matrix starts being original A */ /*-------------------- begin */ schur = (csptr) Malloc(sizeof(SparMat), "arms2:1" ); /*--------------------------------------------------------------------- | The matrix (a,ja,ia) plays role of Schur compl. from the 0th level. +--------------------------------------------------------------------*/ nC = nA = n = Amat->n; if (bsize >= n) bsize = n-1; levmat->n = n; levmat->nB = 0; setupCS(schur, n,1); cscpy(Amat,schur); levc = levmat; /*--------------------------------------- */ levc->prev = levc->next = levp = NULL; levc->n = 0; memcpy(methL, &ipar[10], 4*sizeof(int)); memcpy(methS, &ipar[14], 4*sizeof(int)); /*--------------------------------------------------------------------- | The preconditioner construction is divided into two parts: | 1st part: construct and store multi-level L and U factors; | 2nd part: construct the ILUT factorization for the coarsest level +--------------------------------------------------------------------*/ if ( (iout > 0) && (nlev > 0) ) { fprintf(ft," \n"); fprintf(ft,"Level Total Unknowns B-block Coarse set\n"); fprintf(ft,"===== ============== ======= ==========\n"); } /*--------------------------------------------------------------------- | main loop to construct multi-level LU preconditioner. Loop is on the | level ilev. nA is the dimension of matrix A_l at each level. +--------------------------------------------------------------------*/ for (ilev = 0; ilev < nlev; ilev++) { /*-------------------- new nA is old nC -- from previous level */ nA = nC; if ( nA <= bsize ) goto label1000; /*-------------------- allocate work space */ iwork = (int *) Malloc(nA*sizeof(int), "arms2:2.5" ); symperm = 0; /* 0nly needed in cleanP4 */ if (ipar[1] == 1) uwork = (int *) Malloc(nA*sizeof(int), "arms2:2.5" ); else{ symperm = 1; uwork = iwork; } /*-------------------- SCALING*/ dd1 = NULL; dd2 = NULL; if (methL[2]) { dd1 = (double *) Malloc(nA*sizeof(double), "arms2:3" ); j=roscalC(schur, dd1,1); if (j) printf("ERROR in roscalC - row %d is a zero row\n",j); } if (methL[3]) { dd2 = (double *) Malloc(nA*sizeof(double), "arms2:4" ); j=coscalC(schur, dd2,1); if (j) printf("ERROR in coscalC - column %d is a zero column\n",j); } /*--------------------independent-sets-permutation------------------- | do reordering -- The matrix and its transpose are used. +--------------------------------------------------------------------*/ /* if (SHIFTTOL > 0.0) shiftsD(schur,SHIFTTOL); */ if (ipar[1] == 1) PQperm(schur, bsize, uwork, iwork, &nB, tolind) ; else indsetC (schur, bsize, iwork, &nB, tolind) ; /*--------------------------------------------------------------------- | nB is the total number of nodes in the independent set. | nC : nA - nB = the size of the reduced system. +--------------------------------------------------------------------*/ nC = nA - nB; /* if the size of B or C is zero , exit the main loop */ /* printf (" nB %d nC %d \n",nB, nC); */ if ( nB == 0 || nC == 0 ) goto label1000; /*--------------------------------------------------------------------- | The matrix for the current level is in (schur). | The permutations arrays are in iwork and uwork (row). | The routines rpermC, cpermC permute the matrix in place. *-----------------------------------------------------------------------*/ /* DEBUG : SHOULD THIS GO BEFORE GOTO LABEL1000 ?? */ rpermC(schur,uwork); cpermC(schur,iwork); /* prtC(schur, ilev) ; print matrix - debugging */ /*----------------------------------------------------------------------- | If this is the first level, the permuted matrix is stored in | (levc) = (levmat). Otherwise, the next level is created in (levc). +--------------------------------------------------------------------*/ if (ilev > 0) { /*- delete C matrix of any level except last one (no longer needed) */ cleanCS(C); levn = (p4ptr) Malloc(sizeof(Per4Mat), "arms2:6" ); /* levc->prev = levp; */ levc->next = levn; levp = levc; levc = levn; levc->prev = levp; } /*-------------------- p4ptr struct for current schur complement */ B = (csptr) Malloc(sizeof(SparMat), "arms2:7" ); E = (csptr) Malloc(sizeof(SparMat), "arms2:8" ); F = (csptr) Malloc(sizeof(SparMat), "arms2:9" ); C = (csptr) Malloc(sizeof(SparMat), "arms2:10" ); csSplit4(schur, nB, nC, B, F, E, C); setupP4(levc, nB, nC, F, E); /*-------------------- copy a few pointers ---- */ levc->perm = iwork; levc->rperm = uwork; levc->symperm = symperm; levc->D1=dd1; levc->D2=dd2; /*--------------------------------------------------------------------- | a copy of the matrix (schur) has been permuted. Now perform the | block factorization: | | | B F | | L 0 | | U L^-1 F | | | | = | | X | | = L x U | | E C | | E U^-1 I | | 0 A1 | | | The factors E U^-1 and L^-1 F are discarded after the factorization. | +--------------------------------------------------------------------*/ if (iout > 0) fprintf(ft,"%3d %13d %13d %10d\n", ilev+1,nA,nB,nC); /*--------------------------------------------------------------------- | PILUT constructs one level of the block ILU fact. The permuted matrix | is in (levc). The L and U factors will be stored in the p4mat struct. | destroy current Schur complement - no longer needed - and set-up new | one for next level... +--------------------------------------------------------------------*/ cleanCS(schur); schur = (csptr) Malloc(sizeof(SparMat), "arms2:11" ); setupCS(schur, nC,1); /*---------------------------------------------------------------------- | calling PILU to construct this level block factorization | ! core dump in extreme case of empty matrices. +----------------------------------------------------------------------*/ ierr = pilu(levc, B, C, droptol, lfil, schur) ; /* prtC(levc->L, ilev) ; */ if (ierr) { fprintf(ft," ERROR IN PILU -- IERR = %d\n", ierr); return(1); } cleanCS(B); } /*--------------------------------------------------------------------- | done with the reduction. Record the number of levels in ipar[0] |********************************************************************** +--------------------------------------------------------------------*/ label1000: /* printf (" nnz_Schur %d \n",cs_nnz (schur)); */ levc->next = NULL; ipar[0] = ilev; PreMat->nlev = ilev; PreMat->n = n; nC = schur->n; setupILUT(ilsch,nC); /*--------------------------------------------------------------------*/ /* define C-matrix (member of ilsch) to be last C matrix */ if (ilev > 0) ilsch->C=C; /*-------------------- for ilut fact of schur matrix */ /* SCALING */ ilsch->D1 = NULL; if (methS[2]) { ilsch->D1 = (double *) Malloc(nC*sizeof(double), "arms2:iluschD1" ); j=roscalC(schur, ilsch->D1, 1); if (j) printf("ERROR in roscalC - row %d is a zero row\n",j); } ilsch->D2 = NULL; if (methS[3]) { ilsch->D2 = (double *) Malloc(nC*sizeof(double), "arms2:iluschD1" ); j =coscalC(schur, ilsch->D2, 1); if (j) printf("ERROR in coscalC - column %d is a zero column\n",j); } /*--------------------------------------------------------------------- | get ILUT factorization for the last reduced system. +--------------------------------------------------------------------*/ uwork = NULL; iwork = NULL; if (methS[0]) { iwork = (int *) Malloc(nC*sizeof(int), "arms2:3" ); uwork = (int *) Malloc(nC*sizeof(int), "arms2:3.5" ); tolind = 0.0; PQperm(schur, bsize, uwork, iwork, &nB, tolind) ; rpermC(schur,uwork); cpermC(schur,iwork); } ilsch->rperm = uwork; ilsch->perm = iwork; /* printf(" lf : %d %d %d %d %d %d %d \n",lfil[0], lfil[1], lfil[2], lfil[3], lfil[4], lfil[5], lfil[6]) ; */ ilsch->perm2 = NULL; if (methS[1] == 0) ierr = ilutD(schur, droptol, lfil, ilsch); else { ilsch->perm2 = (int *) Malloc(nC*sizeof(int), "arms2:ilutpC" ); for (j=0; jperm2[j] = j; ierr = ilutpC(schur, droptol, lfil, PERMTOL, nC, ilsch); } /*---------- OPTIMIZATRION: NEED TO COMPOUND THE TWO RIGHT PERMUTATIONS -- CHANGES HERE AND IN USCHUR SOLVE == compound permutations */ if (ierr) { fprintf(ft," ERROR IN ILUT -- IERR = %d\n", ierr); return(1); } /* Last Schur complement no longer needed */ cleanCS(schur); return 0; }/*-----end-of-ARMS2---------------------------------------------------- +--------------------------------------------------------------------*/ itsol-1.0.0/ilut.c0000640000265600020320000002114711062577473013124 0ustar tilleaadmin#include #include #include #include "./LIB/globheads.h" #include "./LIB/protos.h" /*-------------------- end protos*/ int ilut( csptr csmat, iluptr lu, int lfil, double tol, FILE *fp ) { /*---------------------------------------------------------------------------- * ILUT preconditioner * incomplete LU factorization with dual truncation mechanism * NOTE : no pivoting implemented as yet in GE for diagonal elements *---------------------------------------------------------------------------- * Parameters *---------------------------------------------------------------------------- * on entry: * ========= * csmat = matrix stored in SpaFmt format -- see heads.h for details * lu = pointer to a ILUSpar struct -- see heads.h for details * lfil = integer. The fill-in parameter. Each column of L and * each column of U will have a maximum of lfil elements. * WARNING: THE MEANING OF LFIL HAS CHANGED WITH RESPECT TO * EARLIER VERSIONS. * lfil must be .ge. 0. * tol = real*8. Sets the threshold for dropping small terms in the * factorization. See below for details on dropping strategy. * fp = file pointer for error log ( might be stdout ) * * on return: * ========== * ierr = return value. * ierr = 0 --> successful return. * ierr = -1 --> Illegal value for lfil * ierr = -2 --> zero diagonal or zero col encountered * lu->n = dimension of the matrix * ->L = L part -- stored in SpaFmt format * ->D = Diagonals * ->U = U part -- stored in SpaFmt format *---------------------------------------------------------------------------- * Notes: * ====== * All the diagonals of the input matrix must not be zero *---------------------------------------------------------------------------- * Dual drop-off strategy works as follows. * * 1) Theresholding in L and U as set by tol. Any element whose size * is less than some tolerance (relative to the norm of current * row in u) is dropped. * * 2) Keeping only the largest lfil elements in the i-th column of L * and the largest lfil elements in the i-th column of U. * * Flexibility: one can use tol=0 to get a strategy based on keeping the * largest elements in each column of L and U. Taking tol .ne. 0 but lfil=n * will give the usual threshold strategy (however, fill-in is then * impredictible). *--------------------------------------------------------------------------*/ int n = csmat->n; int len, lenu, lenl; int nzcount, *ja, *jbuf, *iw, i, j, k; int col, jpos, jrow, upos; double t, tnorm, tolnorm, fact, lxu, *wn, *ma, *w; csptr L, U; double *D; if( lfil < 0 ) { fprintf( fp, "ilut: Illegal value for lfil.\n" ); return -1; } setupILU( lu, n ); L = lu->L; U = lu->U; D = lu->D; iw = (int *)Malloc( n*sizeof(int), "ilut" ); jbuf = (int *)Malloc( n*sizeof(int), "ilut" ); wn = (double *)Malloc( n * sizeof(double), "ilut" ); w = (double *)Malloc( n * sizeof(double), "ilut" ); /* set indicator array jw to -1 */ for( i = 0; i < n; i++ ) iw[i] = -1; /* beginning of main loop */ for( i = 0; i < n; i++ ) { nzcount = csmat->nzcount[i]; ja = csmat->ja[i]; ma = csmat->ma[i]; tnorm = 0; for( j = 0; j < nzcount; j++ ) { tnorm += fabs( ma[j] ); } if( tnorm == 0.0 ) { fprintf( fp, "ilut: zero row encountered.\n" ); return -2; } tnorm /= (double)nzcount; tolnorm = tol * tnorm; /* unpack L-part and U-part of column of A in arrays w */ lenu = 0; lenl = 0; jbuf[i] = i; w[i] = 0; iw[i] = i; for( j = 0; j < nzcount; j++ ) { col = ja[j]; t = ma[j]; if( col < i ) { iw[col] = lenl; jbuf[lenl] = col; w[lenl] = t; lenl++; } else if( col == i ) { w[i] = t; } else { lenu++; jpos = i + lenu; iw[col] = jpos; jbuf[jpos] = col; w[jpos] = t; } } j = -1; len = 0; /* eliminate previous rows */ while( ++j < lenl ) { /*---------------------------------------------------------------------------- * in order to do the elimination in the correct order we must select the * smallest column index among jbuf[k], k = j+1, ..., lenl *--------------------------------------------------------------------------*/ jrow = jbuf[j]; jpos = j; /* determine smallest column index */ for( k = j + 1; k < lenl; k++ ) { if( jbuf[k] < jrow ) { jrow = jbuf[k]; jpos = k; } } if( jpos != j ) { col = jbuf[j]; jbuf[j] = jbuf[jpos]; jbuf[jpos] = col; iw[jrow] = j; iw[col] = jpos; t = w[j]; w[j] = w[jpos]; w[jpos] = t; } /* get the multiplier */ fact = w[j] * D[jrow]; w[j] = fact; /* zero out element in row by resetting iw(n+jrow) to -1 */ iw[jrow] = -1; /* combine current row and row jrow */ nzcount = U->nzcount[jrow]; ja = U->ja[jrow]; ma = U->ma[jrow]; for( k = 0; k < nzcount; k++ ) { col = ja[k]; jpos = iw[col]; lxu = - fact * ma[k]; /* if fill-in element is small then disregard */ if( fabs( lxu ) < tolnorm && jpos == -1 ) continue; if( col < i ) { /* dealing with lower part */ if( jpos == -1 ) { /* this is a fill-in element */ jbuf[lenl] = col; iw[col] = lenl; w[lenl] = lxu; lenl++; } else { w[jpos] += lxu; } } else { /* dealing with upper part */ // if( jpos == -1 ) { if( jpos == -1 && fabs(lxu) > tolnorm) { /* this is a fill-in element */ lenu++; upos = i + lenu; jbuf[upos] = col; iw[col] = upos; w[upos] = lxu; } else { w[jpos] += lxu; } } } } /* restore iw */ iw[i] = -1; for( j = 0; j < lenu; j++ ) { iw[jbuf[i+j+1]] = -1; } /*---------- case when diagonal is zero */ if( w[i] == 0.0 ) { fprintf( fp, "zero diagonal encountered.\n" ); for( j = i; j < n; j++ ) { L->ja[j] = NULL; L->ma[j] = NULL; U->ja[j] = NULL; U->ma[j] = NULL; } return -2; } /*-----------Update diagonal */ D[i] = 1 / w[i]; /* update L-matrix */ // len = min( lenl, lfil ); len = lenl < lfil ? lenl : lfil; for( j = 0; j < lenl; j++ ) { wn[j] = fabs( w[j] ); iw[j] = j; } qsplit( wn, iw, &lenl, &len ); L->nzcount[i] = len; if( len > 0 ) { ja = L->ja[i] = (int *)Malloc( len*sizeof(int), "ilut" ); ma = L->ma[i] = (double *)Malloc( len*sizeof(double), "ilut" ); } for( j = 0; j < len; j++ ) { jpos = iw[j]; ja[j] = jbuf[jpos]; ma[j] = w[jpos]; } for( j = 0; j < lenl; j++ ) iw[j] = -1; /* update U-matrix */ // len = min( lenu, lfil ); len = lenu < lfil ? lenu : lfil; for( j = 0; j < lenu; j++ ) { wn[j] = fabs( w[i+j+1] ); iw[j] = i+j+1; } qsplit( wn, iw, &lenu, &len ); U->nzcount[i] = len; if( len > 0 ) { ja = U->ja[i] = (int *)Malloc( len*sizeof(int), "ilut" ); ma = U->ma[i] = (double *)Malloc( len*sizeof(double), "ilut" ); } for( j = 0; j < len; j++ ) { jpos = iw[j]; ja[j] = jbuf[jpos]; ma[j] = w[jpos]; } for( j = 0; j < lenu; j++ ) { iw[j] = -1; } } free( iw ); free( jbuf ); free( wn ); return 0; } int lutsolC( double *y, double *x, iluptr lu ) { /*---------------------------------------------------------------------- * performs a forward followed by a backward solve * for LU matrix as produced by ilut * y = right-hand-side * x = solution on return * lu = LU matrix as produced by ilut. *--------------------------------------------------------------------*/ int n = lu->n, i, j, nzcount, *ja; double *D, *ma; csptr L, U; L = lu->L; U = lu->U; D = lu->D; /* Block L solve */ for( i = 0; i < n; i++ ) { x[i] = y[i]; nzcount = L->nzcount[i]; ja = L->ja[i]; ma = L->ma[i]; for( j = 0; j < nzcount; j++ ) { x[i] -= x[ja[j]] * ma[j]; } } /* Block -- U solve */ for( i = n-1; i >= 0; i-- ) { nzcount = U->nzcount[i]; ja = U->ja[i]; ma = U->ma[i]; for( j = 0; j < nzcount; j++ ) { x[i] -= x[ja[j]] * ma[j]; } x[i] *= D[i]; } return 0; } itsol-1.0.0/ChangeLog_dli0000640000265600020320000000015511062577476014404 0ustar tilleaadminLIBS/systimer.c Fixed typo CLK_TCK LIBS/tools.f: rnrms: removed unused argument ja And other minor fixes itsol-1.0.0/auxill.c0000640000265600020320000003414711062577473013451 0ustar tilleaadmin#include #include #include #include "LIB/globheads.h" #include "LIB/protos.h" #include "ios.h" #define MAX_NUM_LEV 5 /* maximum number of levels for arms */ int readhb_c(int *NN, double **AA, int **JA, int **IA, io_t *pio, double **rhs, double **guess, int *rsa) { int job, ncol, nrow, nrhs, ierr; char guesol[3], title[73], key[9], type[4]; int *ia = NULL, *ja = NULL, *Tia = NULL, *Tja = NULL; double *Ta = NULL, *a = NULL; int n, nnz, tmp1, tmp2; /* find out size of Harwell-Boeing matrix ---------------------------*/ *rsa = 0; job = 0; tmp1 = tmp2 = 1; readmtc( &tmp1, &tmp2, &job, pio->Fname, Ta, Tja, Tia, *rhs, &nrhs, guesol, &nrow, &ncol, &nnz, title, key, type, &ierr ); if( ierr != 0 ) { fprintf( stderr, "readhb: err in read matrix header = %d\n", ierr ); return ierr; } /* some consistency checks ------------------------------------------*/ pio->ndim = n = ncol; if( nrow != ncol ) { fprintf( stderr, "readhb: matrix is not square\n" ); return -1; } if( type[1] == 'S' || type[1] == 's' ) *rsa = 1; /* allocate space ---------------------------------------------------*/ Tia = (int *)Malloc( sizeof(int)*(n+1), "readhb" ); Tja = (int *)Malloc( sizeof(int)*nnz, "readhb" ); Ta = (double *)Malloc( sizeof(double)*nnz, "readhb" ); *rhs = (double *)Malloc( sizeof(double)*n, "readhb" ); *guess = (double *)Malloc( sizeof(double)*n, "readhb" ); /* read matrix ------------------------------------------------------*/ job = 2; tmp1 = n+1; tmp2 = nnz; readmtc( &tmp1, &tmp2, &job, pio->Fname, Ta, Tja, Tia, *rhs, &nrhs, guesol, &nrow, &ncol, &nnz, title, key, type, &ierr ); if( ierr != 0 ) { fprintf( stderr, "readhb: err in read matrix data = %d\n", ierr ); return ierr; } tmp1 = tmp2 = 1; ia = (int *)Malloc( sizeof(int)*(n+1), "readhb" ); ja = (int *)Malloc( sizeof(int)*nnz, "readhb" ); a = (double *)Malloc( sizeof(double)*nnz, "readhb" ); csrcsc( &n, &tmp1, &tmp2, Ta, Tja, Tia, a, ja, ia); /*-------------------- io struct update */ pio->ndim = n; pio->nnz = nnz; if (*rsa == 1) pio->nnz = nnz+nnz-n; strncpy( pio->type, type, 3 ); pio->type[3] = '\0'; /*-------------------- copy pointers */ *AA=a; *JA=ja; *IA = ia; *NN = n; /*-------------------- free temps */ free( Ta ); Ta = NULL; free( Tja ); Tja = NULL; free( Tia ); Tia = NULL; return 0; } int read_inputs( char *in_file, io_t *pio ) { FILE *finputs; char line[MAX_LINE], *p1, *p2; if( NULL == ( finputs = fopen( in_file, "r" ) ) ) return -1; memset( line, 0, MAX_LINE ); /*-------------------- line 1 : Number of params = number of tests*/ fgets( line, MAX_LINE, finputs ); for( p1 = line; ' ' == *p1; p1++ ); for( p2 = p1; ' ' != *p2; p2++ ); *p2 = '\0'; pio->nparam = atoi( p1 ); /*-------------------- line 2 : krylov subspace dimension */ memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, finputs ); for( p1 = line; ' ' == *p1; p1++ ); for( p2 = p1; ' ' != *p2; p2++ ); *p2 = '\0'; pio->im = atoi( p1 ); /*-------------------- Line 3 : maximum number of iterations */ memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, finputs ); for( p1 = line; ' ' == *p1; p1++ ); for( p2 = p1; ' ' != *p2; p2++ ); *p2 = '\0'; pio->maxits = atoi( p1 ); /*-------------------- Line 4 : tolerance for stopping */ memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, finputs ); for( p1 = line; ' ' == *p1; p1++ ); for( p2 = p1; ' ' != *p2; p2++ ); *p2 = '\0'; pio->tol = atof( p1 ); /* this is now set manually in main memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, finputs ); for( p1 = line; ' ' == *p1; p1++ ); for( p2 = p1; ' ' != *p2; p2++ ); *p2 = '\0'; pio->eps = atof( p1 ); */ /*-------------------- Line 5 : initial lfil for iluk, ilut etc */ memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, finputs ); for( p1 = line; ' ' == *p1; p1++ ); for( p2 = p1; ' ' != *p2; p2++ ); *p2 = '\0'; pio->lfil0 = atoi( p1 ); /*-------------------- Line 6 : increment for lfil for consecutive tests */ memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, finputs ); for( p1 = line; ' ' == *p1; p1++ ); for( p2 = p1; ' ' != *p2; p2++ ); *p2 = '\0'; pio->lfilInc = atoi( p1 ); /*-------------------- Line 7 : initial drop tol for ilut etc.. */ memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, finputs ); for( p1 = line; ' ' == *p1; p1++ ); for( p2 = p1; ' ' != *p2; p2++ ); *p2 = '\0'; pio->tol0 = atof( p1 ); /*-------------------- Line 8: multiplier for droptop for consecutive tests */ memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, finputs ); for( p1 = line; ' ' == *p1; p1++ ); for( p2 = p1; ' ' != *p2; p2++ ); *p2 = '\0'; pio->tolMul = atof( p1 ); /*-------------------- Line 9: fill-level used by ILUK ONLY */ memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, finputs ); for( p1 = line; ' ' == *p1; p1++ ); for( p2 = p1; ' ' != *p2; p2++ ); *p2 = '\0'; pio->fill_lev = atoi( p1 ); /*-------------------- Fill-lev increment is set to one */ pio->fill_lev_inc = 1; /*-------------------- Line 10: Ind. set perms or PQ perms [ARMS only] */ memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, finputs ); for( p1 = line; ' ' == *p1; p1++ ); for( p2 = p1; ' ' != *p2; p2++ ); *p2 = '\0'; pio->perm_type = atoi( p1 ); /*-------------------- Line 11: Block size -- */ memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, finputs ); for( p1 = line; ' ' == *p1; p1++ ); for( p2 = p1; ' ' != *p2; p2++ ); *p2 = '\0'; pio->Bsize = atoi( p1 ); /*-------------------- DONE -------------------- */ fclose( finputs ); return 0; } int get_matrix_info( FILE *fmat, io_t *pio ) { char line[MAX_LINE], *p1, *p2; memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, fmat ); for( p1 = line; '\'' != *p1; p1++ ); p1++; for( p2 = p1; '\'' != *p2; p2++ ); *p2 = '\0'; strcpy( pio->Fname, p1 ); for( p1 = p2+1; '\'' != *p1; p1++ ); p1++; for( p2 = p1; '\'' != *p2; p2++ ); *p2 = '\0'; strcpy( pio->HBnameF, p1 ); return 0; } void output_blocks( int nBlock, int *nB, FILE *f ) { int i; fprintf( f, "\nBlocks:\n" ); for( i = 0; i < nBlock; i++ ) { fprintf( f, "%2d ", nB[i] ); if( (i+1) % 25 == 0 ) fprintf( f, "\n" ); } fprintf( f, "\n" ); fflush( f ); } void output_perm( int n, int *perm, FILE *f ) { int i; fprintf( f, "\nPermutation array:\n" ); for( i = 0; i < n; i++ ) { fprintf( f, "%6d ", perm[i] ); if( (i+1) % 10 == 0 ) fprintf( f, "\n" ); } fprintf( f, "\n" ); fflush( f ); } int read_coo(double **VAL, int **COL, int **ROW, io_t *pio, double **rhs, double **sol) { /*-------------------- reads a matrix in coordinate format. ! arrays VAL, COL, ROW are allocated and created ! for rhs: memory allocation done + artificial rhs created. ! various other things are filled in pio !------------------------------------------------------------*/ FILE *matf = NULL; double *aa; int *ii, *jj; int k, n, nnz; char *p1, *p2; char line[MAX_LINE]; /*-------------------- start */ matf = fopen(pio->Fname,"r"); /*-------------------- mtx format .. in some cases n, nnz are read separately per line */ fscanf(matf," %d %d %d\n", &n, &k, &nnz); if (n != k) { fprintf(stdout,"This is not a square matrix -- stopping \n"); return(1); } /* separate reads for n and nnz fscanf(matf," %d\n", &n); fscanf(matf," %d\n", &nnz); */ pio->ndim = n; pio->nnz = nnz; pio->type[3] = '\0'; /*-------------------- allocate memory for matrix and rhs */ *rhs = (double *)Malloc( n*sizeof(double), "read_coo:1" ); *sol = (double *)Malloc( n*sizeof(double), "read_coo:2" ); aa = (double *)Malloc( nnz*sizeof(double),"read_coo:3" ); jj = (int *)Malloc( nnz*sizeof(int), "read_coo:4" ); ii = (int *)Malloc( nnz*sizeof(int), "read_coo:5" ); for (k=0; kfout; fprintf( f, "\n \n"); fprintf( f, " ======================================================\n" ); fprintf( f, " MATRIX TESTED MATRIX %-15s \n",pio->HBnameF); fprintf( f, " ------------------------------------------------------\n" ); fprintf( f, " SIZE = %-12d NonZeros = %-12d \n",pio->ndim,pio->nnz ); fprintf( f, " PRECONDITIONER = %s \n",pio->PrecMeth); fprintf( f, " ======================================================\n" ); fprintf( f, "\n" ); fprintf( f, " -------------------------------------------------------------------------\n"); fprintf( f, "| lf | tol | P-T | I-T | nz(LU)/nz | Its | ErrNorm | RsdNorm |\n"); fprintf( f, " -------------------------------------------------------------------------\n"); fflush( f ); } void output_header_vb( io_t *pio ){ FILE *f = pio->fout; fprintf( f, "\n \n"); fprintf( f, " ======================================================\n" ); fprintf( f, " MATRIX TESTED MATRIX %-15s \n",pio->HBnameF); fprintf( f, " ------------------------------------------------------\n" ); fprintf( f, " SIZE = %-12d NonZeros = %-12d \n",pio->ndim,pio->nnz ); fprintf( f, " PRECONDITIONER = %s \n",pio->PrecMeth); fprintf( f, "| with angle tolerance : %-25.2f |\n", pio->eps ); fprintf( f, "======================================================\n" ); fprintf( f, "\n" ); fprintf( f, "=============== PRECONDITIONER STATS =================\n" ); fprintf( f, "| Time of Hash | Time of Angle | Time of Total |\n" ); fprintf( f, "------------------------------------------------------\n" ); fprintf( f, "| %-12.3f | %-13.3f | %-13.3f |\n", pio->tm_h, pio->tm_a, pio->tm_b ); fprintf( f, "------------------------------------------------------\n" ); fprintf( f, "| V cmpr. rate | E cmpr. rate | Cmpr. Effc. (%%) |\n" ); fprintf( f, "------------------------------------------------------\n" ); fprintf( f, "| %-12.2f | %-13.2f | %-13.2f |\n", pio->rt_v, pio->rt_e, pio->ceff ); fprintf( f, "======================================================\n" ); fprintf( f, "\n" ); fprintf( f, " -------------------------------------------------------------------------\n"); fprintf( f, "| lf | tol | P-T | I-T | nz(LU)/nz | Its | ErrNorm | RsdNorm |\n"); fprintf( f, " -------------------------------------------------------------------------\n"); fflush( f ); } void output_result( int lfil, io_t *pio, int iparam ){ FILE *f = pio->fout; int i; double tol = pio->tol0; for( i = 1; i < iparam; i++ ) tol *= pio->tolMul; fprintf( f,"| %3d |%8.2g |%8.3f |%8.3f |%10.3f | %3d |%8.2g |%8.2g |\n", lfil, tol, pio->tm_p, pio->tm_i, pio->fillfact, pio->its, pio->enorm, pio->rnorm ); fprintf(f," -------------------------------------------------------------------------\n"); fflush( f ); } void set_arms_pars(io_t* io, int Dscale, int *ipar, double *dropcoef, int *lfil){ /*-------------------------------------------------*/ /* sets parameters required by arms preconditioner */ /* input io_t, Dscale */ /* output ipar tolcoef, lfil */ /*-------------------- trigger an error if not set */ int j; for (j=0; j< 17; j++) ipar[j] = 0; /*-------------------- */ ipar[0] = MAX_NUM_LEV; /* max number of levels allowed */ fprintf(stdout," %d maxlev \n",ipar[0]); ipar[1] = io->perm_type; /* Indset (0) / PQ (1) permutation */ /* note that these refer to completely */ /* different methods for reordering A */ /* 0 = standard ARMS independent sets */ /* 1 = arms with ddPQ ordering */ ipar[2] = io->Bsize; /* smallest size allowed for last schur comp. */ ipar[3] = 1; /* whether or not to print statistics */ /*-------------------- interlevel methods */ ipar[10] = 0; /* Always do permutations - currently not used */ ipar[11] = 0; /* ILUT or ILUTP - currently only ILUT is implemented */ ipar[12] = Dscale; /* diagonal row scaling before PILUT 0:no 1:yes */ ipar[13] = Dscale; /* diagonal column scaling before PILUT 0:no 1:yes */ /*-------------------- last level methods */ ipar[14] = 0; /* Always do permutations at last level */ ipar[15] = 1; /* -> ILUTP for last level (0 = ILUT at last level) */ ipar[16] = Dscale; /* diagonal row scaling 0:no 1:yes */ ipar[17] = Dscale; /* diagonal column scaling 0:no 1:yes */ /*-------------------- set lfil */ for (j=0; j<7; j++){ lfil[j] = io->lfil0; } /*--------- dropcoef (droptol[k] = tol0*dropcoef[k]) ----- */ dropcoef[0] = 1.6; /* dropcoef for L of B block */ dropcoef[1] = 1.6; /* dropcoef for U of B block */ dropcoef[2] = 1.6; /* dropcoef for L\ inv F */ dropcoef[3] = 1.6; /* dropcoef for U\ inv E */ dropcoef[4] = 0.004; /* dropcoef for forming schur comple. */ dropcoef[5] = 0.004; /* dropcoef for last level L */ dropcoef[6] = 0.004; /* dropcoef for last level U */ } void randvec (double *v, int n) { /* fills v with random values */ double x; int k, seed = 4321; srand(seed); for (k=0; k #include #include #include #include "LIB/globheads.h" #ifndef min #define min(a,b) (((a)>(b))?(b):(a)) #endif #ifndef max #define max(a,b) (((a)>(b))?(a):(b)) #endif #define SVD 1 #define dgemm dgemm_ /*-------------------- protos */ void *Malloc(int nbytes, char *msg); int vblusolC(double *y, double *x, vbiluptr lu); int invGauss(int nn, double *A); int invSVD(int nn, double *A) ; void dgemm(char*, char*, int*, int*, int*, double*, double*, int*, double*, int*, double*, double*, int*) ; int setupVBMat(vbsptr vbmat, int n, int *nB); int mallocVBRow(vbiluptr lu, int nrow); void zrmC(int m, int n, BData data); int lofC( int lofM, vbsptr vbmat, vbiluptr lu, FILE *fp ); int setupVBILU(vbiluptr lu, int n, int *bsz); void copyBData(int m, int n, BData dst, BData src, int isig); int lofC( int lofM, vbsptr vbmat, vbiluptr lu, FILE *fp ); /*-------------------- END of protos */ int vbilukC( int lofM, vbsptr vbmat, vbiluptr lu, FILE *fp ) { /*---------------------------------------------------------------------------- * Block ILUK preconditioner * Block incomplete LU factorization with level of fill dropping * This version uses svd to invert diagonal blocks *---------------------------------------------------------------------------- * Parameters *---------------------------------------------------------------------------- * on entry: * ========= * lofM = level of fill: all entries with level of fill > lofM are * dropped. Setting lofM = 0 gives BILU(0). * vbmat = block matrix stored in VBSpaFmt format -- see globheads.h for * details on format, the block sizes might be different * lu = pointer to a VBILUSpar struct -- see globheads.h for details * on format * fp = file pointer for error log ( might be stderr ) * * on return: * ========== * ierr = return value. * ierr = 0 --> successful return. * ierr = -1 --> error in lofC * ierr = -2 --> singular diagonal block * lu->n = dimension of the block matrix * ->bsz = the row/col of the first element of each diagonal block * the size of the i-th row block should be bsz[i+1] - bsz[i] * ->L = L part -- stored in VBSpaFmt format * ->D = Diagonals * ->U = U part -- stored in VBSpaFmt format *---------------------------------------------------------------------------- * Notes: * ====== * All the diagonal blocks of the input block matrix must not be singular *--------------------------------------------------------------------------*/ int ierr; int n = vbmat->n, *bsz = vbmat->bsz; int *jw, i, j, k, col, jpos, jrow, dim, sz; int mm, nn, kk; double alpha1 = 1.0, beta1 = 0.0, alpha2 = -1.0, beta2 = 1.0; vbsptr L, U; setupVBILU( lu, n, bsz ); L = lu->L; U = lu->U; /* symbolic factorization to calculate level of fill index arrays */ if( ( ierr = lofC( lofM, vbmat, lu, fp ) ) != 0 ) { fprintf( fp, "Error: lofC\n" ); return -1; } jw = lu->work; /* set indicator array jw to -1 */ for( j = 0; j < n; j++ ) jw[j] = -1; /* beginning of main loop */ for( i = 0; i < n; i++ ) { dim = B_DIM(bsz,i); /* number of rows of blocks in i-th row */ /* set up the i-th row accroding to the nonzero information from symbolic factorization */ mallocVBRow( lu, i ); /* setup array jw[], and initial i-th row */ for( j = 0; j < L->nzcount[i]; j++ ) { /* initialize L part */ col = L->ja[i][j]; sz = B_DIM(bsz,col); jw[col] = j; zrmC( dim, sz, L->ba[i][j] ); } jw[i] = i; zrmC( dim, dim, lu->D[i] ); /* initialize diagonal */ for( j = 0; j < U->nzcount[i]; j++ ) { /* initialize U part */ col = U->ja[i][j]; sz = B_DIM(bsz,col); jw[col] = j; zrmC( dim, sz, U->ba[i][j] ); } /* copy row from vbmat into lu */ for( j = 0; j < vbmat->nzcount[i]; j++ ) { col = vbmat->ja[i][j]; sz = B_DIM(bsz,col); /* number of columns of current block */ jpos = jw[col]; if( col < i ) { copyBData( dim, sz, L->ba[i][jpos], vbmat->ba[i][j], 0 ); } else if( col == i ) { copyBData( dim, sz, lu->D[i], vbmat->ba[i][j], 0 ); } else { copyBData( dim, sz, U->ba[i][jpos], vbmat->ba[i][j], 0 ); } } /* eliminate previous rows */ for( j = 0; j < L->nzcount[i]; j++ ) { jrow = L->ja[i][j]; mm = dim; /* number of rows of current block */ nn = B_DIM(bsz,jrow); /* number of cols of current block */ /* get the multiplier for row to be eliminated (jrow) */ dgemm( "n", "n", &mm, &nn, &nn, &alpha1, L->ba[i][j], &mm, lu->D[jrow], &nn, &beta1, lu->bf, &mm ); copyBData( mm, nn, L->ba[i][j], lu->bf, 0 ); /* combine current row and row jrow */ for( k = 0; k < U->nzcount[jrow]; k++ ) { col = U->ja[jrow][k]; jpos = jw[col]; if( jpos == -1 ) continue; if( col < i ) { kk = B_DIM(bsz,col); dgemm( "n", "n", &mm, &kk, &nn, &alpha2, L->ba[i][j], &mm, U->ba[jrow][k], &nn, &beta2, L->ba[i][jpos], &mm ); } else if( col == i ) { dgemm( "n", "n", &mm, &mm, &nn, &alpha2, L->ba[i][j], &mm, U->ba[jrow][k], &nn, &beta2, lu->D[i], &mm ); } else { kk = B_DIM(bsz,col); dgemm( "n", "n", &mm, &kk, &nn, &alpha2, L->ba[i][j], &mm, U->ba[jrow][k], &nn, &beta2, U->ba[i][jpos], &mm ); } } } /*-------------------- reset double-pointer to -1 ( U-part) */ for( j = 0; j < L->nzcount[i]; j++ ) { col = L->ja[i][j]; jw[col] = -1; } jw[i] = -1; for( j = 0; j < U->nzcount[i]; j++ ) { col = U->ja[i][j]; jw[col] = -1; } /*-------------------- calculate truncated inverse of diagonal element of U */ if (SVD) ierr = invSVD(dim,lu->D[i]); else ierr = invGauss(dim,lu->D[i]); if( ierr != 0 ) { for( j = i+1; j < n; j++ ) { lu->D[j] = NULL; L->ba[j] = NULL; U->ba[j] = NULL; } fprintf( fp, "fatal error: Singular diagonal block...\n" ); return -2; } } lu->DiagOpt = 2; return 0; } int lofC( int lofM, vbsptr vbmat, vbiluptr lu, FILE *fp ) { /*-------------------------------------------------------------------- * symbolic ilu factorization to calculate structure of ilu matrix * for specified level of fill *-------------------------------------------------------------------- * on entry: * ========= * lofM = level of fill, lofM >= 0 * vbmat = block matrix stored in VBSpaFmt format -- see globheads.h for * details on format, size of blocks might be different * lu = pointer to a VBILUSpar struct -- see globheads.h for details * on format * fp = file pointer for error log ( might be stderr ) *-------------------------------------------------------------------- * on return: * ========== * ierr = return value. * ierr = 0 --> successful return. * ierr != 0 --> error * lu->n = dimension of the block matrix * ->L = L part -- stored in BSpaFmt format, patterns only in lofC * ->U = U part -- stored in BSpaFmt format, patterns only in lofC *------------------------------------------------------------------*/ int n = vbmat->n; int *levls = NULL, *jbuf = NULL, *iw = lu->work; int **ulvl; /* stores lev-fils for U part of ILU factorization*/ vbsptr L = lu->L, U = lu->U; /*-------------------------------------------------------------------- * n = number of rows or columns in matrix * inc = integer, count of nonzero(fillin) element of each row * after symbolic factorization * ju = entry of U part of each row * lvl = buffer to store levels of each row * jbuf = buffer to store column index of each row * iw = work array *------------------------------------------------------------------*/ int i, j, k, col, ip, it, jpiv; int incl, incu, jmin, kmin; levls = (int *)Malloc( n*sizeof(int), "lofC" ); jbuf = (int *)Malloc( n*sizeof(int), "lofC" ); ulvl = (int **)Malloc( n*sizeof(int *), "lofC" ); /* initilize iw */ for( j = 0; j < n; j++ ) iw[j] = -1; for( i = 0; i < n; i++ ) { incl = 0; incu = i; /*-------------------- assign lof = 0 for matrix elements */ for( j = 0; j < vbmat->nzcount[i]; j++ ) { col = vbmat->ja[i][j]; if( col < i ) { /*-------------------- L-part */ jbuf[incl] = col; levls[incl] = 0; iw[col] = incl++; } else if (col > i) { /*-------------------- U-part */ jbuf[incu] = col; levls[incu] = 0; iw[col] = incu++; } } /*-------------------- symbolic k,i,j Gaussian elimination */ jpiv = -1; while (++jpiv < incl) { k = jbuf[jpiv] ; /*-------------------- select leftmost pivot */ kmin = k; jmin = jpiv; for( j = jpiv + 1; j< incl; j++) { if( jbuf[j] < kmin ) { kmin = jbuf[j]; jmin = j; } } /*-------------------- swap */ if( jmin != jpiv ) { jbuf[jpiv] = kmin; jbuf[jmin] = k; iw[kmin] = jpiv; iw[k] = jmin; j = levls[jpiv] ; levls[jpiv] = levls[jmin]; levls[jmin] = j; k = kmin; } /*-------------------- symbolic linear combinaiton of rows */ for( j = 0; j < U->nzcount[k]; j++ ) { col = U->ja[k][j]; it = ulvl[k][j]+levls[jpiv]+1 ; if( it > lofM ) continue; ip = iw[col]; if( ip == -1 ) { if( col < i) { jbuf[incl] = col; levls[incl] = it; iw[col] = incl++; } else if( col > i ) { jbuf[incu] = col; levls[incu] = it; iw[col] = incu++; } } else levls[ip] = min(levls[ip], it); } } /* end - while loop */ /*-------------------- reset iw */ for( j = 0; j < incl; j++ ) iw[jbuf[j]] = -1; for( j = i; j < incu; j++ ) iw[jbuf[j]] = -1; /*-------------------- copy L-part */ L->nzcount[i] = incl; if(incl > 0 ) { L->ja[i] = (int *)Malloc( incl*sizeof(int), "lofC" ); memcpy( L->ja[i], jbuf, sizeof(int)*incl); } /*-------------------- copy U - part */ k = incu-i; U->nzcount[i] = k; if( k > 0 ) { U->ja[i] = (int *)Malloc( sizeof(int)*k, "lofC" ); memcpy(U->ja[i], jbuf+i, sizeof(int)*k ); /*-------------------- update matrix of levels */ ulvl[i] = (int *)Malloc( k*sizeof(int), "lofC" ); memcpy( ulvl[i], levls+i, k*sizeof(int) ); } } /*-------------------- free temp space and leave --*/ free(levls); free(jbuf); for(i = 0; i < n-1; i++ ) { if (U->nzcount[i]) free(ulvl[i]) ; } free(ulvl); return 0; } itsol-1.0.0/GNU0000640000265600020320000004310011062577473012350 0ustar tilleaadmin GNU GENERAL PUBLIC LICENSE Version 2, June 1991 Copyright (C) 1989, 1991 Free Software Foundation, Inc. 675 Mass Ave, Cambridge, MA 02139, USA Everyone is permitted to copy and distribute verbatim copies of this license document, but changing it is not allowed. Preamble The licenses for most software are designed to take away your freedom to share and change it. By contrast, the GNU General Public License is intended to guarantee your freedom to share and change free software--to make sure the software is free for all its users. This General Public License applies to most of the Free Software Foundation's software and to any other program whose authors commit to using it. (Some other Free Software Foundation software is covered by the GNU Library General Public License instead.) You can apply it to your programs, too. When we speak of free software, we are referring to freedom, not price. Our General Public Licenses are designed to make sure that you have the freedom to distribute copies of free software (and charge for this service if you wish), that you receive source code or can get it if you want it, that you can change the software or use pieces of it in new free programs; and that you know you can do these things. To protect your rights, we need to make restrictions that forbid anyone to deny you these rights or to ask you to surrender the rights. These restrictions translate to certain responsibilities for you if you distribute copies of the software, or if you modify it. For example, if you distribute copies of such a program, whether gratis or for a fee, you must give the recipients all the rights that you have. You must make sure that they, too, receive or can get the source code. And you must show them these terms so they know their rights. We protect your rights with two steps: (1) copyright the software, and (2) offer you this license which gives you legal permission to copy, distribute and/or modify the software. Also, for each author's protection and ours, we want to make certain that everyone understands that there is no warranty for this free software. If the software is modified by someone else and passed on, we want its recipients to know that what they have is not the original, so that any problems introduced by others will not reflect on the original authors' reputations. Finally, any free program is threatened constantly by software patents. We wish to avoid the danger that redistributors of a free program will individually obtain patent licenses, in effect making the program proprietary. To prevent this, we have made it clear that any patent must be licensed for everyone's free use or not licensed at all. The precise terms and conditions for copying, distribution and modification follow. GNU GENERAL PUBLIC LICENSE TERMS AND CONDITIONS FOR COPYING, DISTRIBUTION AND MODIFICATION 0. This License applies to any program or other work which contains a notice placed by the copyright holder saying it may be distributed under the terms of this General Public License. The "Program", below, refers to any such program or work, and a "work based on the Program" means either the Program or any derivative work under copyright law: that is to say, a work containing the Program or a portion of it, either verbatim or with modifications and/or translated into another language. (Hereinafter, translation is included without limitation in the term "modification".) Each licensee is addressed as "you". Activities other than copying, distribution and modification are not covered by this License; they are outside its scope. The act of running the Program is not restricted, and the output from the Program is covered only if its contents constitute a work based on the Program (independent of having been made by running the Program). Whether that is true depends on what the Program does. 1. You may copy and distribute verbatim copies of the Program's source code as you receive it, in any medium, provided that you conspicuously and appropriately publish on each copy an appropriate copyright notice and disclaimer of warranty; keep intact all the notices that refer to this License and to the absence of any warranty; and give any other recipients of the Program a copy of this License along with the Program. You may charge a fee for the physical act of transferring a copy, and you may at your option offer warranty protection in exchange for a fee. 2. You may modify your copy or copies of the Program or any portion of it, thus forming a work based on the Program, and copy and distribute such modifications or work under the terms of Section 1 above, provided that you also meet all of these conditions: a) You must cause the modified files to carry prominent notices stating that you changed the files and the date of any change. b) You must cause any work that you distribute or publish, that in whole or in part contains or is derived from the Program or any part thereof, to be licensed as a whole at no charge to all third parties under the terms of this License. c) If the modified program normally reads commands interactively when run, you must cause it, when started running for such interactive use in the most ordinary way, to print or display an announcement including an appropriate copyright notice and a notice that there is no warranty (or else, saying that you provide a warranty) and that users may redistribute the program under these conditions, and telling the user how to view a copy of this License. (Exception: if the Program itself is interactive but does not normally print such an announcement, your work based on the Program is not required to print an announcement.) These requirements apply to the modified work as a whole. If identifiable sections of that work are not derived from the Program, and can be reasonably considered independent and separate works in themselves, then this License, and its terms, do not apply to those sections when you distribute them as separate works. But when you distribute the same sections as part of a whole which is a work based on the Program, the distribution of the whole must be on the terms of this License, whose permissions for other licensees extend to the entire whole, and thus to each and every part regardless of who wrote it. Thus, it is not the intent of this section to claim rights or contest your rights to work written entirely by you; rather, the intent is to exercise the right to control the distribution of derivative or collective works based on the Program. In addition, mere aggregation of another work not based on the Program with the Program (or with a work based on the Program) on a volume of a storage or distribution medium does not bring the other work under the scope of this License. 3. You may copy and distribute the Program (or a work based on it, under Section 2) in object code or executable form under the terms of Sections 1 and 2 above provided that you also do one of the following: a) Accompany it with the complete corresponding machine-readable source code, which must be distributed under the terms of Sections 1 and 2 above on a medium customarily used for software interchange; or, b) Accompany it with a written offer, valid for at least three years, to give any third party, for a charge no more than your cost of physically performing source distribution, a complete machine-readable copy of the corresponding source code, to be distributed under the terms of Sections 1 and 2 above on a medium customarily used for software interchange; or, c) Accompany it with the information you received as to the offer to distribute corresponding source code. (This alternative is allowed only for noncommercial distribution and only if you received the program in object code or executable form with such an offer, in accord with Subsection b above.) The source code for a work means the preferred form of the work for making modifications to it. For an executable work, complete source code means all the source code for all modules it contains, plus any associated interface definition files, plus the scripts used to control compilation and installation of the executable. However, as a special exception, the source code distributed need not include anything that is normally distributed (in either source or binary form) with the major components (compiler, kernel, and so on) of the operating system on which the executable runs, unless that component itself accompanies the executable. If distribution of executable or object code is made by offering access to copy from a designated place, then offering equivalent access to copy the source code from the same place counts as distribution of the source code, even though third parties are not compelled to copy the source along with the object code. 4. You may not copy, modify, sublicense, or distribute the Program except as expressly provided under this License. Any attempt otherwise to copy, modify, sublicense or distribute the Program is void, and will automatically terminate your rights under this License. However, parties who have received copies, or rights, from you under this License will not have their licenses terminated so long as such parties remain in full compliance. 5. You are not required to accept this License, since you have not signed it. However, nothing else grants you permission to modify or distribute the Program or its derivative works. These actions are prohibited by law if you do not accept this License. Therefore, by modifying or distributing the Program (or any work based on the Program), you indicate your acceptance of this License to do so, and all its terms and conditions for copying, distributing or modifying the Program or works based on it. 6. Each time you redistribute the Program (or any work based on the Program), the recipient automatically receives a license from the original licensor to copy, distribute or modify the Program subject to these terms and conditions. You may not impose any further restrictions on the recipients' exercise of the rights granted herein. You are not responsible for enforcing compliance by third parties to this License. 7. If, as a consequence of a court judgment or allegation of patent infringement or for any other reason (not limited to patent issues), conditions are imposed on you (whether by court order, agreement or otherwise) that contradict the conditions of this License, they do not excuse you from the conditions of this License. If you cannot distribute so as to satisfy simultaneously your obligations under this License and any other pertinent obligations, then as a consequence you may not distribute the Program at all. For example, if a patent license would not permit royalty-free redistribution of the Program by all those who receive copies directly or indirectly through you, then the only way you could satisfy both it and this License would be to refrain entirely from distribution of the Program. If any portion of this section is held invalid or unenforceable under any particular circumstance, the balance of the section is intended to apply and the section as a whole is intended to apply in other circumstances. It is not the purpose of this section to induce you to infringe any patents or other property right claims or to contest validity of any such claims; this section has the sole purpose of protecting the integrity of the free software distribution system, which is implemented by public license practices. Many people have made generous contributions to the wide range of software distributed through that system in reliance on consistent application of that system; it is up to the author/donor to decide if he or she is willing to distribute software through any other system and a licensee cannot impose that choice. This section is intended to make thoroughly clear what is believed to be a consequence of the rest of this License. 8. If the distribution and/or use of the Program is restricted in certain countries either by patents or by copyrighted interfaces, the original copyright holder who places the Program under this License may add an explicit geographical distribution limitation excluding those countries, so that distribution is permitted only in or among countries not thus excluded. In such case, this License incorporates the limitation as if written in the body of this License. 9. The Free Software Foundation may publish revised and/or new versions of the General Public License from time to time. Such new versions will be similar in spirit to the present version, but may differ in detail to address new problems or concerns. Each version is given a distinguishing version number. If the Program specifies a version number of this License which applies to it and "any later version", you have the option of following the terms and conditions either of that version or of any later version published by the Free Software Foundation. If the Program does not specify a version number of this License, you may choose any version ever published by the Free Software Foundation. 10. If you wish to incorporate parts of the Program into other free programs whose distribution conditions are different, write to the author to ask for permission. For software which is copyrighted by the Free Software Foundation, write to the Free Software Foundation; we sometimes make exceptions for this. Our decision will be guided by the two goals of preserving the free status of all derivatives of our free software and of promoting the sharing and reuse of software generally. NO WARRANTY 11. BECAUSE THE PROGRAM IS LICENSED FREE OF CHARGE, THERE IS NO WARRANTY FOR THE PROGRAM, TO THE EXTENT PERMITTED BY APPLICABLE LAW. EXCEPT WHEN OTHERWISE STATED IN WRITING THE COPYRIGHT HOLDERS AND/OR OTHER PARTIES PROVIDE THE PROGRAM "AS IS" WITHOUT WARRANTY OF ANY KIND, EITHER EXPRESSED OR IMPLIED, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE. THE ENTIRE RISK AS TO THE QUALITY AND PERFORMANCE OF THE PROGRAM IS WITH YOU. SHOULD THE PROGRAM PROVE DEFECTIVE, YOU ASSUME THE COST OF ALL NECESSARY SERVICING, REPAIR OR CORRECTION. 12. IN NO EVENT UNLESS REQUIRED BY APPLICABLE LAW OR AGREED TO IN WRITING WILL ANY COPYRIGHT HOLDER, OR ANY OTHER PARTY WHO MAY MODIFY AND/OR REDISTRIBUTE THE PROGRAM AS PERMITTED ABOVE, BE LIABLE TO YOU FOR DAMAGES, INCLUDING ANY GENERAL, SPECIAL, INCIDENTAL OR CONSEQUENTIAL DAMAGES ARISING OUT OF THE USE OR INABILITY TO USE THE PROGRAM (INCLUDING BUT NOT LIMITED TO LOSS OF DATA OR DATA BEING RENDERED INACCURATE OR LOSSES SUSTAINED BY YOU OR THIRD PARTIES OR A FAILURE OF THE PROGRAM TO OPERATE WITH ANY OTHER PROGRAMS), EVEN IF SUCH HOLDER OR OTHER PARTY HAS BEEN ADVISED OF THE POSSIBILITY OF SUCH DAMAGES. END OF TERMS AND CONDITIONS Appendix: How to Apply These Terms to Your New Programs If you develop a new program, and you want it to be of the greatest possible use to the public, the best way to achieve this is to make it free software which everyone can redistribute and change under these terms. To do so, attach the following notices to the program. It is safest to attach them to the start of each source file to most effectively convey the exclusion of warranty; and each file should have at least the "copyright" line and a pointer to where the full notice is found. Copyright (C) 19yy This program is free software; you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation; either version 2 of the License, or (at your option) any later version. This program is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. You should have received a copy of the GNU General Public License along with this program; if not, write to the Free Software Foundation, Inc., 675 Mass Ave, Cambridge, MA 02139, USA. Also add information on how to contact you by electronic and paper mail. If the program is interactive, make it output a short notice like this when it starts in an interactive mode: Gnomovision version 69, Copyright (C) 19yy name of author Gnomovision comes with ABSOLUTELY NO WARRANTY; for details type `show w'. This is free software, and you are welcome to redistribute it under certain conditions; type `show c' for details. The hypothetical commands `show w' and `show c' should show the appropriate parts of the General Public License. Of course, the commands you use may be called something other than `show w' and `show c'; they could even be mouse-clicks or menu items--whatever suits your program. You should also get your employer (if you work as a programmer) or your school, if any, to sign a "copyright disclaimer" for the program, if necessary. Here is a sample; alter the names: Yoyodyne, Inc., hereby disclaims all copyright interest in the program `Gnomovision' (which makes passes at compilers) written by James Hacker. , 1 April 1989 Ty Coon, President of Vice This General Public License does not permit incorporating your program into proprietary programs. If your program is a subroutine library, you may consider it more useful to permit linking proprietary applications with the library. If this is what you want to do, use the GNU Library General Public License instead of this License. itsol-1.0.0/fgmr.c0000640000265600020320000001643011062577473013101 0ustar tilleaadmin#include #include #include #include #include "./LIB/globheads.h" #include "./LIB/protos.h" #define epsmac 1.0e-16 int fgmr(SMatptr Amat, SPreptr lu, double *rhs, double *sol, double tol, int im, int *itmax, FILE *fits){ /*---------------------------------------------------------------------- | *** Preconditioned FGMRES *** +----------------------------------------------------------------------- | This is a simple version of the ARMS preconditioned FGMRES algorithm. +----------------------------------------------------------------------- | Y. S. Dec. 2000. -- Apr. 2008 +----------------------------------------------------------------------- | on entry: |---------- | |(Amat) = matrix struct. the matvec operation is Amat->matvec. |(lu) = preconditioner struct.. the preconditioner is lu->precon | if (lu == NULL) the no-preconditioning option is invoked. | rhs = real vector of length n containing the right hand side. | sol = real vector of length n containing an initial guess to the | solution on input. | tol = tolerance for stopping iteration | im = Krylov subspace dimension | (itmax) = max number of iterations allowed. | fits = NULL: no output | != NULL: file handle to output " resid vs time and its" | | on return: |---------- | fgmr int = 0 --> successful return. | int = 1 --> convergence not achieved in itmax iterations. | sol = contains an approximate solution (upon successful return). | itmax = has changed. It now contains the number of steps required | to converge -- +----------------------------------------------------------------------- | internal work arrays: |---------- | vv = work array of length [im+1][n] (used to store the Arnoldi | basis) | hh = work array of length [im][im+1] (Householder matrix) | z = work array of length [im][n] to store preconditioned vectors +----------------------------------------------------------------------- | subroutines called : | lu->precon - preconditionning operation +---------------------------------------------------------------------*/ int n=Amat->n, maxits = *itmax; int i, i1, ii, j, k, k1, its, retval, tmp1 = 1; double **hh, *c, *s, *rs, t; double negt, beta, eps1=0.0, gam, **vv, **z; double t1=0.0, t2=0.0; its = 0; vv = (double **)Malloc((im+1)*sizeof(double *), "fgmres"); z = (double **)Malloc(im*sizeof(double *), "fgmres"); for (i=0; i<=im; i++) { vv[i] = (double *)Malloc(n*sizeof(double), "fgmres"); } hh = (double **)Malloc(im*sizeof(double *), "fgmres"); for (i=0; imatvec(Amat, sol, vv[0]); for (j=0; jprecon(vv[i], z[i],lu) ; } /*-------------------- matvec operation w = A z_{j} = A M^{-1} v_{j} */ Amat->matvec(Amat, z[i], vv[i1]); /*------------------------------------------------------------ | modified gram - schmidt... | h_{i,j} = (w,v_{i}) | w = w - h_{i,j} v_{i} +------------------------------------------------------------*/ for (j=0; j<=i; j++) { t = DDOT(n, vv[j], tmp1, vv[i1], tmp1); hh[i][j] = t; negt = -t; DAXPY(n, negt, vv[j], tmp1, vv[i1], tmp1); } /*-------------------- h_{j+1,j} = ||w||_{2} */ t = DNRM2(n, vv[i1], tmp1); hh[i][i1] = t; if (t == 0.0) goto label58; t = 1.0/t; /*-------------------- v_{j+1} = w / h_{j+1,j} */ for (k=0; k eps1) && (its < maxits) ) goto label4; /*-------------------- now compute solution. 1st, solve upper triangular system*/ rs[i] = rs[i]/hh[i][i]; for (ii=1; ii<=i; ii++) { k=i-ii; k1 = k+1; t=rs[k]; for (j=k1; j<=i; j++) t = t - hh[j][k]*rs[j]; rs[k] = t/hh[k][k]; } /*-------------------- linear combination of v[i]'s to get sol. */ for (j=0; j<=i; j++) { t = rs[j]; for (k=0; k= maxits) goto label991; goto label20; label990: retval = 0; goto label888; label991: retval = 1; label888: for (i=0; i<=im; i++) free(vv[i]); free(vv); for (i=0; i #include #include #include #include "../LIB/globheads.h" #include "../LIB/defs.h" #include "../LIB/protos.h" #include "../ios.h" #include /*-------------------- protos */ void output_header( io_t *pio ); void output_result( int lfil, io_t *pio, int iparam ); int readhb_c(int *NN, double **AA, int **JA, int **IA, io_t *pio, double **rhs, double **guess, int *rsa); int read_inputs( char *in_file, io_t *pio ); int get_matrix_info( FILE *fmat, io_t *pio ); void randvec (double *v, int n); /*-------------------- end protos */ int main () { int ierr = 0; /*------------------------------------------------------------------- * options *-----------------------------------------------------------------*/ /* -- plotting is for writing stats into OUT/.... in raw form */ int plotting = 0, output_lu = 0, diagscal = 0; char pltfile[256]; FILE *fits = NULL; csptr csmat = NULL; SMatptr MAT; SPreptr PRE; iluptr lu = NULL; double *sol = NULL, *x = NULL, *rhs = NULL; int lfil; double tol; /*-------------------- temp Harwell Boeing arrays */ double *AA; int *IA, *JA; int n, rsa; /*-------------------- end*/ FILE *flog = stdout, *fmat = NULL; io_t io; double tm1, tm2; int mat, numat, iparam, i; double terr; char line[MAX_LINE]; MAT = (SMatptr)Malloc( sizeof(SMat), "main:MAT" ); PRE = (SPreptr)Malloc( sizeof(SPre), "main:PRE" ); /*-------------------- read Harwell-Boeing matrix */ memset( &io, 0, sizeof(io) ); if( read_inputs( "inputs", &io ) != 0 ) { fprintf( flog, "Invalid inputs file...\n" ); goto ERROR_HANDLE; } /*-----------------------------------------------------------------*/ if( NULL == ( fmat = fopen( "matfile_hb", "r" ) ) ) { fprintf( flog, "Can't open matfile_hb...\n" ); goto ERROR_HANDLE; } memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, fmat ); if( ( numat = atoi( line ) ) <= 0 ) { fprintf( flog, "Invalid count of matrices...\n" ); goto ERROR_HANDLE; } /*-------------------- open file OUT/ILUT.out for all performance results of this run (all matrices and params) also set io->PrecMeth */ /* sprintf( io.outfile, "OUT/%s_ILUT.out", io.HBnameF );*/ strcpy(io.outfile,"OUT/ILUT.out"); strcpy(io.PrecMeth,"ILUT"); if( NULL == ( io.fout = fopen( io.outfile, "w" ) ) ) { fprintf(flog,"Can't open output file %s...\n", io.outfile); goto ERROR_HANDLE; } /*-------------------- LOOP THROUGH MATRICES */ for( mat = 1; mat <= numat; mat++ ) { if( get_matrix_info( fmat, &io ) != 0 ) { fprintf( flog, "Invalid format in matfile_hb...\n" ); goto ERROR_HANDLE; } fprintf( flog, "MATRIX: %s...\n", io.HBnameF ); /* Read in matrix and allocate memory------------------------------*/ csmat = (csptr)Malloc( sizeof(SparMat), "main" ); ierr = readhb_c(&n, &AA, &JA, &IA, &io, &rhs, &sol, &rsa); if( ierr != 0 ) { fprintf( flog, "readhb_c error = %d\n", ierr ); goto ERROR_HANDLE; } if( ( ierr = CSRcs( n, AA, JA, IA, csmat, rsa ) ) != 0 ) { fprintf( stderr, "readhb: CSRcs error\n" ); return ierr; } /*-------------------- free fortran arrays */ free(IA); IA = NULL; free(AA); AA = NULL; free(JA); JA = NULL; /*------------ Diagonal Scaling ----------*/ if (diagscal ==1) { int nrm=1; double *diag; diag = (double *)Malloc( sizeof(double)*n, "mainILUC:diag" ); ierr = roscalC( csmat, diag, nrm); if( ierr != 0 ) { fprintf( stderr, "main-ilut: roscal: a zero row...\n" ); return ierr; } ierr = coscalC( csmat, diag, nrm ); if( ierr != 0 ) { fprintf( stderr, "main-ilut: roscal: a zero col...\n" ); return ierr; } free(diag); } /*---------------------------------------------------------------------- | The right-hand side is generated by assuming the solution is | a vector of ones. To be changed if rhs is available from data. |---------------------------------------------------------------------*/ x = (double *)Malloc( io.ndim * sizeof(double), "main" ); for( i = 0; i < io.ndim; i++ ) x[i] = 1.0; matvec( csmat, x, rhs ); output_header( &io ); /*-------------------- set initial lfil and tol */ lfil = io.lfil0; tol = io.tol0; /*-------------------- LOOP through parameters */ for( iparam = 1; iparam <= io.nparam; iparam++ ) { fprintf( flog, "iparam = %d\n", iparam ); lu = (iluptr)Malloc( sizeof(ILUSpar), "main" ); fprintf( flog, "begin ilut\n" ); tm1 = sys_timer(); /*-------------------- call ILUT preconditioner set-up */ ierr = ilut( csmat, lu, lfil, tol, flog ); tm2 = sys_timer(); if( ierr != 0 ) { fprintf( io.fout, " *** ILUT error - code %d \n", ierr); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } if(output_lu ) { char matdata[MAX_LINE]; sprintf( matdata, "OUT/%s.dat", io.HBnameF ); outputLU( lu, matdata ); } io.tm_p = tm2 - tm1; io.fillfact = (double)nnz_ilu( lu )/(double)(io.nnz + 1); fprintf( flog, "ilut ends, fill factor (mem used) = %f\n", io.fillfact ); if( condestLU( lu, sol, x, flog ) != 0 ) { fprintf( flog, "Not attempting iterative solution.\n" ); fprintf( io.fout, "Not attempting iterative solution.\n" ); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } /*-------------------- initial guess */ /* for( i = 0; i < io.ndim; i++ ) x[i] = 0.0; */ randvec(x, n); /*-------------------- create a file for printing 'its -- time -- res' info from fgmres */ if(plotting ) { sprintf( pltfile, "OUT/%s_ILUT_F%05d_T%08.6f", io.HBnameF, lfil,tol); if( NULL == ( fits = fopen( pltfile, "w" ) ) ) { fprintf( flog, "Can't open output file %s...\n", pltfile ); goto ERROR_HANDLE; } } else fits =NULL; /*-------------------- set up the structs before calling fgmr */ MAT->n = n; MAT->CSR = csmat; MAT->matvec = matvecCSR; PRE->ILU = lu; PRE->precon = preconILU; /*-------------------- call fgmr */ io.its = io.maxits; tm1 = sys_timer(); fgmr(MAT, PRE, rhs, x, io.tol, io.im, &io.its, fits ); tm2 = sys_timer(); io.tm_i = tm2 - tm1; if( io.its < io.maxits ) fprintf( flog, "param %03d OK: converged in %d steps...\n\n", iparam, io.its ); else fprintf( flog, "not converged in %d steps...\n\n", io.maxits ); if( fits ) fclose( fits ); /*-------------------- calculate error and res norms */ terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( x[i] - 1.0 ) * ( x[i] - 1.0 ); io.enorm = sqrt(terr); matvec( csmat, x, sol ); terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( rhs[i] - sol[i] ) * ( rhs[i] - sol[i] ); io.rnorm = sqrt(terr); /*-------------------- Test with next params */ NEXT_PARA: output_result( lfil, &io, iparam ); lfil += io.lfilInc; tol *= io.tolMul; cleanILU(lu); } /*-------------------- Test with next matrix */ /* NEXT_MAT: --- not used! */ cleanCS( csmat ); free( sol ); free( x ); free( rhs ); } fclose( io.fout ); if( flog != stdout ) fclose ( flog ); fclose( fmat ); free(MAT) ; free (PRE); return 0; ERROR_HANDLE: exit( -1 ); } itsol-1.0.0/TESTS_HB/OUT/0000751000265600020320000000000011062575440013710 5ustar tilleaadminitsol-1.0.0/TESTS_HB/mainILUKhb.c0000640000265600020320000001613211062577476015346 0ustar tilleaadmin#include #include #include #include #include "../LIB/globheads.h" #include "../LIB/defs.h" #include "../LIB/protos.h" #include "../ios.h" #include /*-------------------- protos */ void output_header( io_t *pio ); void output_result(int lfil, io_t *pio, int iparam ); int readhb_c(int *NN, double **AA, int **JA, int **IA, io_t *pio, double **rhs, double **guess, int *rsa); int read_inputs( char *in_file, io_t *pio ); int get_matrix_info( FILE *fmat, io_t *pio ); void randvec (double *v, int n); /*-------------------- end protos */ int main(){ int ierr = 0; /*------------------------------------------------------------------- * options *-----------------------------------------------------------------*/ int plotting = 0, skip_its = 0; char pltfile[256]; FILE *fits = NULL; csptr csmat = NULL; SMatptr MAT; SPreptr PRE; double *AA; int *JA, *IA; iluptr lu = NULL; double *sol = NULL, *x = NULL, *rhs = NULL; int n, lfil, rsa; FILE *flog = stdout, *fmat = NULL; io_t io; double tm1, tm2; int mat, numat, iparam, i; double terr; char line[MAX_LINE]; MAT = (SMatptr)Malloc( sizeof(SMat), "main:MAT" ); PRE = (SPreptr)Malloc( sizeof(SPre), "main:PRE" ); /*------------------------------------------------------------------- * reads matrix from Harwell Boeing file * * solves using block level of fill ILU preconditioned fgmres * *-----------------------------------------------------------------*/ memset( &io, 0, sizeof(io) ); /*-----------------------------------------------------------------*/ if( read_inputs( "inputs", &io ) != 0 ) { fprintf( flog, "Invalid inputs file...\n" ); goto ERROR_HANDLE; } /*-----------------------------------------------------------------*/ if( NULL == ( fmat = fopen( "matfile_hb", "r" ) ) ) { fprintf( flog, "Can't open matfile_hb...\n" ); goto ERROR_HANDLE; } memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, fmat ); if( ( numat = atoi( line ) ) <= 0 ) { fprintf( flog, "Invalid count of matrices...\n" ); goto ERROR_HANDLE; } /*-------------------- open file OUT/ILUK.out for all performance results of this run (all matrices and params) also set io->PrecMeth */ /* sprintf( io.outfile, "OUT/%s_ILUK.out", io.HBnameF );*/ strcpy(io.outfile,"OUT/ILUK.out"); strcpy(io.PrecMeth,"ILUK"); if( NULL == ( io.fout = fopen( io.outfile, "w" ) ) ) { fprintf(flog,"Can't open output file %s...\n", io.outfile); goto ERROR_HANDLE; } /* LOOP THROUGH MATRICES ------------------------------------------*/ for( mat = 1; mat <= numat; mat++ ) { if( get_matrix_info( fmat, &io ) != 0 ) { fprintf( flog, "Invalid format in matfile_hb...\n" ); goto ERROR_HANDLE; } fprintf( flog, "MATRIX: %s...\n", io.HBnameF ); /*-------------------- Read in matrix and allocate memory-------*/ ierr = readhb_c(&n, &AA, &JA, &IA, &io, &rhs, &sol, &rsa ); if( ierr != 0 ) { fprintf( flog, "readhb_c error = %d\n", ierr ); goto ERROR_HANDLE; } /*-------------------- convert to C-style CSR matrix */ csmat = (csptr)Malloc( sizeof(SparMat), "main" ); if( ( ierr = CSRcs( n, AA, JA, IA, csmat, rsa ) ) != 0 ) { fprintf( stderr, "readhb: oidCSRcs error\n" ); return ierr; } free( AA); AA = NULL; free( JA ); JA = NULL; free( IA ); IA = NULL; /*---------------------------------------------------------------------- | The right-hand side is generated by assuming the solution is | a vector of ones. To be changed if rhs0 is available from data. |---------------------------------------------------------------------*/ x = (double *)Malloc( io.ndim * sizeof(double), "main" ); for( i = 0; i < io.ndim; i++ ) x[i] = 1.0; matvec(csmat, x, rhs ); output_header( &io ); lfil = io.fill_lev; /* make sure this is set to zero*/ io.tol0 = 0.0; /* LOOP THROUGH PARAMETERS ---------------------------------------*/ for( iparam = 1; iparam <= io.nparam; iparam++ ) { fprintf( flog, "iparam = %d\n", iparam ); lu = (iluptr)Malloc( sizeof(ILUSpar), "main" ); fprintf( flog, "begin iluk\n" ); tm1 = sys_timer(); /*-------------------- call ILUK preconditioner set-up */ ierr = ilukC(lfil, csmat, lu, flog ); tm2 = sys_timer(); if( ierr == -2 ) { fprintf( io.fout, "zero diagonal element found...\n" ); cleanILU( lu ); goto NEXT_MAT; } else if( ierr != 0 ) { fprintf( flog, "*** iluk error, ierr != 0 ***\n" ); goto ERROR_HANDLE; } io.tm_p = tm2 - tm1; io.fillfact = (double)nnz_ilu( lu )/(double)(io.nnz + 1); fprintf( flog, "iluk ends, fill factor (mem used) = %f\n", io.fillfact ); if( skip_its ) { io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } // check condition number estimation if( condestLU( lu, sol, x, flog ) != 0 ) { fprintf( flog, "Not attempting iterative solution.\n" ); fprintf( io.fout, "Not attempting iterative solution.\n" ); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } /* initial guess */ /* for( i = 0; i < io.ndim; i++ ) { sol[i] = 0.0; } */ randvec (sol,n); /* initial guess */ /*-------------------- create a file for printing 'its -- time -- res' info from fgmres */ if (plotting ) { sprintf( pltfile, "OUT/%s_ILUK_F%05d", io.HBnameF, lfil); if( NULL == ( fits = fopen( pltfile, "w" ) ) ) { fprintf( flog, "Can't open output file %s...\n", pltfile ); goto ERROR_HANDLE; } } else fits =NULL; io.its = io.maxits; tm1 = sys_timer(); /*-------------------- set up the structs before calling fgmr */ MAT->n = n; MAT->CSR = csmat; MAT->matvec = matvecCSR; PRE->ILU = lu; PRE->precon = preconILU; /*-------------------- call fgmr */ fgmr(MAT, PRE, rhs, sol, io.tol, io.im, &io.its, fits); tm2 = sys_timer(); io.tm_i = tm2 - tm1; if( io.its < io.maxits ) fprintf( flog, "param %03d OK: converged in %d steps...\n\n", iparam, io.its ); else fprintf( flog, "not converged in %d steps...\n\n", io.maxits ); if( fits ) fclose( fits ); /*-------------------- calculate error and residual norms */ terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( sol[i] - 1.0 ) * ( sol[i] - 1.0 ); io.enorm = sqrt(terr); matvec( csmat, sol, x ); terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( rhs[i] - x[i] ) * ( rhs[i] - x[i] ); io.rnorm = sqrt(terr); /*-------------------- Test with next params */ NEXT_PARA: output_result( lfil, &io, iparam ); lfil += io.fill_lev_inc; cleanILU( lu ); } /*-------------------- Test with next matrix */ NEXT_MAT: cleanCS( csmat ); free( sol ); free( x ); free( rhs ); } fclose( io.fout ); if( flog != stdout ) fclose ( flog ); fclose( fmat ); free(MAT) ; free (PRE); return 0; ERROR_HANDLE: errexit( "main.c\n" ); return(1) ; } itsol-1.0.0/TESTS_HB/mainARMShb.c0000640000265600020320000002171111062577476015343 0ustar tilleaadmin/*---------------------------------------------------------------------------* * main test driver for the ARMS2 preconditioner for * Matrices in the Harwell Boeing format *---------------------------------------------------------------------------* * Yousef Saad - Aug. 2005. * * * * Report bugs / send comments to: saad@cs.umn.edu * *---------------------------------------------------------------------------*/ #include #include #include "string.h" #include #include "../LIB/globheads.h" #include "../LIB/defs.h" #include "../LIB/protos.h" #include "../ios.h" #include #define csrcoo csrcoo_ #define TOL_DD 0.2 /* diagonal dominance tolerance for ind-*/ /*-ependent sets */ /*-------------------- protos */ void output_header( io_t *pio ); void output_result( int lfil, io_t *pio, int iparam ); void set_arms_pars(io_t* io, int Dscale, int *ipar, double *tolcoef, int *lfil); int readhb_c(int *NN, double **AA, int **JA, int **IA, io_t *pio, double **rhs, double **guess, int *rsa); int read_inputs( char *in_file, io_t *pio ); int get_matrix_info( FILE *fmat, io_t *pio ); void randvec (double *v, int n); /*-------------------- end protos */ int main () { int ierr = 0; /*------------------------------------------------------------------- * options *-----------------------------------------------------------------*/ int plotting=0, diagscal = 1; char pltfile[256]; FILE *fits = NULL; double tol, tolind = TOL_DD; int j, lfil; csptr csmat = NULL; /* matrix in csr formt */ arms ArmsSt = NULL; /* arms preconditioner structure */ SMatptr MAT = NULL; /* Matrix structure for matvecs */ SPreptr PRE = NULL; /* general precond structure */ double *sol = NULL, *x = NULL, *rhs = NULL; /*-------------------- method for incrementing lfil is set here */ int lfil_arr[7]; double droptol[7], dropcoef[7]; int ipar[18]; /*-------------------- harwell boeing temporary arrays */ double *AA; int *IA, *JA; int rsa; int n; /*-------------------- IO-related */ FILE *flog = stdout; /* to output stats */ FILE *fmat = NULL; /* matrix file */ io_t io; /* structure for handling I/O functions + a few other things */ double tm1, tm2; int mat, numat, iparam, i; double terr; char line[MAX_LINE]; MAT = (SMatptr)Malloc( sizeof(SMat), "main:MAT" ); PRE = (SPreptr)Malloc( sizeof(SPre), "main:PRE" ); /*------------------------------------------------------------------- * reads matrix from Harwell Boeing file * solves using ARMS preconditioned fgmres *-----------------------------------------------------------------*/ memset(&io, 0, sizeof(io) ); /*-----------------------------------------------------------------*/ if( read_inputs( "inputs", &io ) != 0 ) { fprintf( flog, "ERROR reading inputs from file...\n" ); goto ERROR_HANDLE; } /*-----------------------------------------------------------------*/ if( NULL == ( fmat = fopen( "matfile_hb", "r" ) ) ) { fprintf( flog, "Can't open matfile_hb...\n" ); goto ERROR_HANDLE; } memset(line, 0, MAX_LINE ); fgets(line, MAX_LINE, fmat ); if( (numat = atoi( line ) ) <= 0 ) { fprintf( flog, "Invalid count of matrices...\n" ); goto ERROR_HANDLE; } /*-------------------- set parameters for arms */ set_arms_pars(&io, diagscal, ipar, dropcoef, lfil_arr); /*-------------------- open file OUT/ARMS.out for all performance results of this run (all matrices and params) also set io->PrecMeth */ /* sprintf( io.outfile, "OUT/%s_ARMS.out", io.HBnameF );*/ if (io.perm_type){ strcpy(io.outfile,"OUT/ARMS_DDPQ.out"); strcpy(io.PrecMeth,"ARMS_DDPQ"); } else{ strcpy(io.outfile,"OUT/ARMS.out"); strcpy(io.PrecMeth,"ARMS"); } if( NULL == ( io.fout = fopen( io.outfile, "w" ) ) ) { fprintf(flog,"Can't open output file %s...\n", io.outfile); goto ERROR_HANDLE; } /*-------------------- LOOP through matrices -*/ for( mat = 1; mat <= numat; mat++ ) { if( get_matrix_info( fmat, &io ) != 0 ) { fprintf( flog, "Invalid format in matfile_hb...\n" ); goto ERROR_HANDLE; } fprintf( flog, "MATRIX: %s...\n", io.HBnameF ); /* Read in matrix and allocate memory------------------------------*/ csmat = (csptr)Malloc( sizeof(SparMat), "main:csmat" ); ierr = readhb_c(&n,&AA, &JA, &IA, &io, &rhs, &sol, &rsa); if( ierr != 0 ) { fprintf( flog, "readhb_c error = %d\n", ierr ); goto ERROR_HANDLE; } /*-------------------- keep a copy in csmat format for matvecs */ csmat = (csptr)Malloc( sizeof(SparMat), "main" ); if( ( ierr = CSRcs( n, AA, JA, IA, csmat, rsa ) ) != 0 ) { fprintf( stderr, "readhb: oidCSRcs error\n" ); return ierr; } /*-------------------- free temp IA, AA, JA arrays [no longer needed] */ free(IA); IA = NULL; free(AA); AA = NULL; free(JA); JA = NULL; /*---------------------------------------------------------------------- | The right-hand side is generated by assuming the solution is | a vector of ones. To be changed if rhs is available from data. |---------------------------------------------------------------------*/ x = (double *)Malloc( io.ndim * sizeof(double), "main" ); for( i = 0; i < io.ndim; i++ ) x[i] = 1.0; matvec(csmat, x, rhs) ; output_header(&io ); /*-------------------- set initial lfil and tol */ lfil = io.lfil0; tol = io.tol0; /*-------------------- LOOP THROUGH PARAMETERS */ for( iparam = 1; iparam <= io.nparam; iparam++ ) { fprintf( flog, "Parameter case = %d\n", iparam ); for (j=0; j<7; j++) { lfil_arr[j] = lfil*((int) io.nnz/n); droptol[j] = tol*dropcoef[j]; } ArmsSt = (arms) Malloc(sizeof(armsMat),"main:ArmsSt"); setup_arms(ArmsSt); fprintf( flog, "begin arms\n" ); tm1 = sys_timer(); /*-------------------- call ARMS preconditioner set-up */ ierr = arms2(csmat, ipar, droptol, lfil_arr, tolind, ArmsSt, flog); tm2 = sys_timer(); if( ierr != 0) { fprintf( io.fout, " ** ARMS2 error - code %d...\n",ierr); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } io.tm_p = tm2 - tm1; io.fillfact = (double)nnz_arms( ArmsSt, flog)/(double)(io.nnz + 1); fprintf( flog, "ARMS ends, fill factor (mem used) = %f\n", io.fillfact ); /*-------------------- get rough idea of cond number - exit if too big */ if(condestArms(ArmsSt, x, flog ) != 0 ) { fprintf( flog, "Not attempting iterative solution.\n" ); fprintf( io.fout, "Not attempting iterative solution.\n" ); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } /*-------------------- initial guess */ /* for(i=0; i < io.ndim; i++ ) x[i] = 0.0 */ randvec(x, n); /*-------------------- create a file for printing 'its -- time -- res' info from fgmres */ if(plotting ) { sprintf(pltfile, "OUT/%s_ARMS_F%05d_T%08.6f", io.HBnameF, lfil,tol); if( NULL == (fits = fopen( pltfile, "w" ) ) ) { fprintf(flog, "Can't open output file %s...\n", pltfile ); goto ERROR_HANDLE; } } else fits =NULL; /*-------------------- set up the structs before calling fgmr */ MAT->n = n; MAT->CSR = csmat; MAT->matvec = matvecCSR; PRE->ARMS = ArmsSt; PRE->precon = preconARMS; /*-------------------- call fgmr */ io.its = io.maxits; tm1 = sys_timer(); fgmr(MAT, PRE, rhs, x, io.tol, io.im, &io.its, fits); tm2 = sys_timer(); io.tm_i = tm2 - tm1; if( io.its < io.maxits ) fprintf( flog, "param %03d OK: converged in %d steps...\n", iparam, io.its ); else fprintf( flog, "not converged in %d steps...\n", io.maxits ); if( fits ) fclose( fits ); /*-------------------- calculate error norm from assumed solution of all 1's */ terr = 0.0; for( i = 0; i < io.ndim; i++ ) { terr += ( x[i] - 1.0 ) * ( x[i] - 1.0 ); } io.enorm = sqrt(terr); /*-------------------- calculate residual norm from generated rhs */ matvec(csmat, x, sol ); terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( rhs[i] - sol[i] ) * ( rhs[i] - sol[i] ); io.rnorm = sqrt(terr); /*----------------------------- go to next param case */ NEXT_PARA: output_result(lfil, &io, iparam ); lfil += io.lfilInc; tol *= io.tolMul; cleanARMS( ArmsSt); } /*-------------------- NEXT_MAT: */ cleanCS(csmat); free( sol ); free( x ); free( rhs ); } fclose( io.fout ); if( flog != stdout ) fclose ( flog ); fclose( fmat ); free(MAT); free(PRE); return 0; ERROR_HANDLE: exit( -1 ); } itsol-1.0.0/TESTS_HB/mainVBILUKhb.c0000640000265600020320000002442511062577476015602 0ustar tilleaadmin/*---------------------------------------------------------------------------* * main test driver for VBILU * *---------------------------------------------------------------------------* * Na Li, Aug 26, 2001 -- Y.Saad 07/05 * * * * Report bugs / send comments to: saad@cs.umn.edu, nli@cs.umn.edu * *---------------------------------------------------------------------------*/ #include #include #include #include #include "../LIB/globheads.h" #include "../LIB/defs.h" #include "../LIB/protos.h" #include "../ios.h" #include /*-------------------- protos */ void output_header_vb( io_t *pio ); void output_result(int lfil, io_t *pio, int iparam ); int readhb_c(int *NN, double **AA, int **JA, int **IA, io_t *pio, double **rhs, double **guess, int *rsa); int read_inputs( char *in_file, io_t *pio ); int get_matrix_info( FILE *fmat, io_t *pio ); void randvec (double *v, int n); void output_blocks( int nBlock, int *nB, FILE *f ); void output_perm( int n, int *perm, FILE *f ); /*-------------------- end protos */ int main () { int ierr = 0; /*------------------------------------------------------------------- * options *-----------------------------------------------------------------*/ int plotting = 0, output_mat = 0, diagscal = 0; char pltfile[256]; FILE *fits = NULL; csptr csmat = NULL; vbsptr vbmat = NULL; vbiluptr lu = NULL; SMatptr MAT; SPreptr PRE; double *sol = NULL, *x = NULL, *rhs0 = NULL, *rhs = NULL; int lfil, nBlock, *nB = NULL, *perm = NULL; /*-------------------- temp HB arrays - fortran style */ int *IA, *JA; double *AA; int rsa, n; FILE *flog = stdout, *fmat = NULL; io_t io; double tm1, tm2; int mat, numat, iparam, i; double terr; char line[MAX_LINE]; MAT = (SMatptr)Malloc( sizeof(SMat), "main:MAT" ); PRE = (SPreptr)Malloc( sizeof(SPre), "main:PRE" ); /*------------------------------------------------------------------- * reads matrix from Harwell Boeing file * * solves using block level of fill ILU preconditioned fgmres * *-----------------------------------------------------------------*/ memset( &io, 0, sizeof(io) ); /*-----------------------------------------------------------------*/ if( read_inputs( "inputs", &io ) != 0 ) { fprintf( flog, "Invalid inputs file...\n" ); goto ERROR_HANDLE; } /* set any parameters manually */ /* io.eps is the angle tolerance for grouping two columns in same supernode. This is a cosine and should be <= 1. */ io.eps = 0.8; /*-----------------------------------------------------------------*/ if( NULL == ( fmat = fopen( "matfile_hb", "r" ) ) ) { fprintf( flog, "Can't open matfile_hb...\n" ); goto ERROR_HANDLE; } memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, fmat ); if( ( numat = atoi( line ) ) <= 0 ) { fprintf( flog, "Invalid count of matrices...\n" ); goto ERROR_HANDLE; } /*-------------------- open file OUT/VBILUK.out for all performance results of this run (all matrices and params) also set io->PrecMeth */ /* sprintf( io.outfile, "OUT/%s_VBILUK.out", io.HBnameF );*/ strcpy(io.outfile,"OUT/VBILUK.out"); strcpy(io.PrecMeth,"Variable Block ILUK (VBILUK)"); if( NULL == ( io.fout = fopen( io.outfile, "w" ) ) ) { fprintf(flog,"Can't open output file %s...\n", io.outfile); goto ERROR_HANDLE; } /*------------------------------------------------------------*/ /*-------------------- LOOP through MATRICES */ /*------------------------------------------------------------*/ for( mat = 1; mat <= numat; mat++ ) { if( get_matrix_info( fmat, &io ) != 0 ) { fprintf( flog, "Invalid format in matfile_hb...\n" ); goto ERROR_HANDLE; } fprintf( flog, "MATRIX: %s...\n", io.HBnameF ); /* Read in matrix and allocate memory------------------------------*/ csmat = (csptr)Malloc( sizeof(SparMat), "main" ); ierr = readhb_c(&n, &AA, &JA, &IA, &io, &rhs0, &sol, &rsa); if( ierr != 0 ) { fprintf( flog, "readhb_c error = %d\n", ierr ); goto ERROR_HANDLE; } // csmat = (csptr)Malloc( sizeof(SparMat), "main" ); if( ( ierr = CSRcs( n, AA, JA, IA, csmat, rsa ) ) != 0 ) { fprintf( stderr, "readhb: CSRcs error\n" ); return ierr; } /*--Free memory ---*/ free( AA); AA = NULL; free( JA ); JA = NULL; free( IA ); IA = NULL; /*-------------------- diag scaling */ if (diagscal ==1) { int nrm=1; double *diag; diag = (double *)Malloc( sizeof(double)*n, "mainILUC:diag" ); ierr = roscalC( csmat, diag, nrm); if( ierr != 0 ) { fprintf( stderr, "main-vbiluk: roscal: a zero row...\n" ); return ierr; } ierr = coscalC( csmat, diag, nrm ); if( ierr != 0 ) { fprintf( stderr, "main-vbiluk: roscal: a zero col...\n" ); return ierr; } free(diag); } /*---------------------------------------------------------------------- | The right-hand side is generated by assuming the solution is | a vector of ones. To be changed if rhs0 is available from data. |---------------------------------------------------------------------*/ rhs = (double *)Malloc( io.ndim * sizeof(double), "main" ); x = (double *)Malloc( io.ndim * sizeof(double), "main" ); for( i = 0; i < io.ndim; i++ ) x[i] = 1.0; matvec( csmat, x, rhs0 ); ierr = init_blocks( csmat, &nBlock, &nB, &perm, io.eps, &io.tm_h, &io.tm_a ); io.tm_b = io.tm_h + io.tm_a; if( ierr != 0 ) { fprintf( flog, "*** in init_blocks ierr != 0 ***\n" ); goto ERROR_HANDLE; } /*-------------------- permutes the rows and columns of the matrix */ if( dpermC( csmat, perm ) != 0 ) { fprintf( flog, "*** dpermC error ***\n" ); goto ERROR_HANDLE; } /*-------------------- permutes right hand side */ for( i = 0; i < io.ndim; i++ ) rhs[perm[i]] = rhs0[i]; /*-------------------- convert to block matrix. */ vbmat = (vbsptr)Malloc( sizeof(VBSparMat), "main" ); ierr = csrvbsrC( 1, nBlock, nB, csmat, vbmat ); if( ierr != 0 ) { fprintf( flog, "*** in csrvbsr ierr != 0 ***\n" ); goto ERROR_HANDLE; } if( output_mat ) { char matdata[MAX_LINE]; FILE *fmatlab; int ii, jj; sprintf( matdata, "OUT/%s.dat", io.HBnameF ); if( NULL != ( fmatlab = fopen( matdata, "w" ) ) ) { fprintf( fmatlab, "%d %d 0\n", csmat->n, csmat->n ); for( ii = 0; ii < csmat->n; ii++ ) for( jj = 0; jj < csmat->nzcount[ii]; jj++ ) fprintf( fmatlab, "%d %d 1\n", ii+1, csmat->ja[ii][jj]+1 ); fclose( fmatlab ); } } io.rt_v = (double)csmat->n / (double)vbmat->n; io.rt_e = (double)nnzCS( csmat ) / (double)nnzVBMat( vbmat ); io.ceff = (double)nnzCS( csmat ) / (double)memVBMat( vbmat ) * 100; output_header_vb( &io ); lfil = io.fill_lev; /* make sure this is set to zero*/ io.tol0 = 0.0; /*-------------------- LOOP through parameters */ for( iparam = 1; iparam <= io.nparam; iparam++ ) { fprintf( flog, "iparam = %d\n", iparam ); lu = (vbiluptr)Malloc( sizeof(VBILUSpar), "main" ); fprintf( flog, "begin vbiluk\n" ); tm1 = sys_timer(); /*-------------------- call VBILUK preconditioner set-up */ ierr = vbilukC( lfil, vbmat, lu, flog ); tm2 = sys_timer(); if( ierr == -2 ) { fprintf( io.fout, "Singular diagonal block...\n" ); cleanVBILU( lu ); goto NEXT_MAT; } else if( ierr != 0 ) { fprintf( flog, "*** vbilu error, ierr != 0 ***\n" ); goto ERROR_HANDLE; } io.tm_p = tm2 - tm1; io.fillfact = (double)nnz_vbilu( lu )/(double)(io.nnz + 1); fprintf( flog, "vbiluk ends, fill factor (mem used) = %f\n", io.fillfact ); if( VBcondestC( lu, sol, x, flog ) != 0 ) { fprintf( flog, "Not attempting iterative solution.\n" ); fprintf( io.fout, "Not attempting iterative solution.\n" ); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } /*-------------------- initial guess */ /* for( i = 0; i < io.ndim; i++ ) x[i] = 0.0; */ randvec(x, n); /*-------------------- create a file for printing 'its -- time -- res' info from fgmres */ if (plotting ) { sprintf( pltfile, "OUT/%s_VBILUK_F%05d", io.HBnameF, lfil); if( NULL == ( fits = fopen( pltfile, "w" ) ) ) { fprintf( flog, "Can't open output file %s...\n", pltfile ); goto ERROR_HANDLE; } } else fits =NULL; /*-------------------- set up the structs before calling fgmr */ MAT->n = n; MAT->CSR = csmat; MAT->matvec = matvecCSR; PRE->VBILU = lu; PRE->precon = preconVBR; /*-------------------- call fgmr */ io.its = io.maxits; tm1 = sys_timer(); fgmr(MAT, PRE, rhs, x, io.tol, io.im, &io.its, fits); tm2 = sys_timer(); io.tm_i = tm2 - tm1; if( io.its < io.maxits ) fprintf( flog, "param %03d OK: converged in %d steps...\n\n", iparam, io.its ); else fprintf( flog, "not converged in %d steps...\n\n", io.maxits ); if( fits ) fclose( fits ); /*-------------------- calculate error and residual norms */ vbmatvec( vbmat, x, sol ); terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( rhs[i] - sol[i] ) * ( rhs[i] - sol[i] ); io.rnorm = sqrt(terr); /* get sol vector of original matrix (before permutation) */ for( i = 0; i < io.ndim; i++ ) sol[perm[i]] = x[i]; /* calculate error norm */ terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( sol[i] - 1.0 ) * ( sol[i] - 1.0 ); io.enorm = sqrt(terr); /*-------------------- next params */ NEXT_PARA: output_result(lfil, &io, iparam ); lfil += io.fill_lev_inc; cleanVBILU( lu ); } /*-------------------- next matrix */ NEXT_MAT: /* output_blocks( nBlock, nB, io.fout );*/ cleanCS( csmat ); cleanVBMat( vbmat ); free( nB ); free( perm ); free( sol ); free( x ); free( rhs0 ); free( rhs ); } fclose( io.fout ); if( flog != stdout ) fclose ( flog ); fclose( fmat ); free(MAT); free(PRE); return 0; ERROR_HANDLE: errexit( "main.c\n" ); return 1; } itsol-1.0.0/TESTS_HB/mainVBILUThb.c0000640000265600020320000002455711062577476015621 0ustar tilleaadmin/*---------------------------------------------------------------------------* * main test driver for VBILU * *---------------------------------------------------------------------------* * Na Li, Aug 26, 2001 -- YS 2005 * * * * Report bugs / send comments to: saad@cs.umn.edu, nli@cs.umn.edu * *---------------------------------------------------------------------------*/ #include #include #include #include #include "../LIB/globheads.h" #include "../LIB/defs.h" #include "../LIB/protos.h" #include "../ios.h" #include /*-------------------- protos */ void output_header_vb( io_t *pio ); void output_result( int lfil, io_t *pio, int iparam ); int readhb_c(int *NN, double **AA, int **JA, int **IA, io_t *pio, double **rhs, double **guess, int *rsa); int read_inputs( char *in_file, io_t *pio ); int get_matrix_info( FILE *fmat, io_t *pio ); void randvec (double *v, int n); void output_blocks( int nBlock, int *nB, FILE *f ); void output_perm( int n, int *perm, FILE *f ); /*-------------------- end protos */ int main() { int ierr = 0; /*------------------------------------------------------------------- * options *-----------------------------------------------------------------*/ int plotting = 0, output_mat = 0, skip_its = 0, diagscal = 0; char pltfile[256]; FILE *fits = NULL; csptr csmat = NULL; vbsptr vbmat = NULL; vbiluptr lu = NULL; SMatptr MAT; SPreptr PRE; double *sol = NULL, *x = NULL, *rhs0 = NULL, *rhs = NULL; BData *w = NULL; int lfil, max_blk_sz = MAX_BLOCK_SIZE*MAX_BLOCK_SIZE*sizeof(double); int nBlock, *nB = NULL, *perm = NULL; double tol; FILE *flog = stdout, *fmat = NULL; io_t io; double tm1, tm2; int mat, numat, iparam, i; double terr; char line[MAX_LINE]; int *IA, *JA; double *AA; int n, rsa; MAT = (SMatptr)Malloc( sizeof(SMat), "main:MAT" ); PRE = (SPreptr)Malloc( sizeof(SPre), "main:PRE" ); /*------------------------------------------------------------------- * reads matrix from Harwell Boeing file * * solves using block level of fill ILU preconditioned fgmres * *-----------------------------------------------------------------*/ memset( &io, 0, sizeof(io) ); /*-----------------------------------------------------------------*/ if( read_inputs( "inputs", &io ) != 0 ) { fprintf( flog, "Invalid inputs file...\n" ); goto ERROR_HANDLE; } /* set any parameters manually */ /* io.eps is the angle tolerance for grouping two columns in same supernode. This is a cosine and should be <= 1. */ io.eps = 0.8; /*-----------------------------------------------------------------*/ if( NULL == ( fmat = fopen( "matfile_hb", "r" ) ) ) { fprintf( flog, "Can't open matfile_hb...\n" ); goto ERROR_HANDLE; } memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, fmat ); if( ( numat = atoi( line ) ) <= 0 ) { fprintf( flog, "Invalid count of matrices...\n" ); goto ERROR_HANDLE; } /*-------------------- open file OUT/ILUT.out for all performance results of this run (all matrices and params) also set io->PrecMeth */ /* sprintf( io.outfile, "OUT/%s_ILUT.out", io.HBnameF );*/ strcpy(io.outfile,"OUT/ILUT.out"); strcpy(io.PrecMeth,"Variable Block ILUT (VBILUT)"); if( NULL == ( io.fout = fopen( io.outfile, "w" ) ) ) { fprintf(flog,"Can't open output file %s...\n", io.outfile); goto ERROR_HANDLE; } /* LOOP THROUGH MATRICES ------------------------------------------*/ for( mat = 1; mat <= numat; mat++ ) { if( get_matrix_info( fmat, &io ) != 0 ) { fprintf( flog, "Invalid format in matfile_hb...\n" ); goto ERROR_HANDLE; } fprintf( flog, "MATRIX: %s...\n", io.HBnameF ); /* Read in matrix and allocate memory------------------------------*/ csmat = (csptr)Malloc( sizeof(SparMat), "main" ); ierr = readhb_c(&n, &AA, &JA, &IA, &io, &rhs0, &sol, &rsa); if( ierr != 0 ) { fprintf( flog, "readhb_c error = %d\n", ierr ); goto ERROR_HANDLE; } if( ( ierr = CSRcs( n, AA, JA, IA, csmat, rsa ) ) != 0 ) { fprintf( stderr, "readhb: CSRcs error\n" ); return ierr; } /* Free Memory */ free( AA); AA = NULL; free( JA ); JA = NULL; free( IA ); IA = NULL; /*----Daigonal Scaling -------*/ if (diagscal ==1) { int nrm=1; double *diag; diag = (double *)Malloc( sizeof(double)*n, "mainILUC:diag" ); ierr = roscalC( csmat, diag, nrm); if( ierr != 0 ) { fprintf( stderr, "main-vbiluk: roscal: a zero row...\n" ); return ierr; } ierr = coscalC( csmat, diag, nrm ); if( ierr != 0 ) { fprintf( stderr, "main-vbiluk: roscal: a zero col...\n" ); return ierr; } free(diag); } /*---------------------------------------------------------------------- | The right-hand side is generated by assuming the solution is | a vector of ones. To be changed if rhs0 is available from data. |---------------------------------------------------------------------*/ rhs = (double *)Malloc( io.ndim * sizeof(double), "main" ); x = (double *)Malloc( io.ndim * sizeof(double), "main" ); for( i = 0; i < io.ndim; i++ ) x[i] = 1.0; matvec( csmat, x, rhs0 ); ierr = init_blocks( csmat, &nBlock, &nB, &perm, io.eps, &io.tm_h, &io.tm_a ); io.tm_b = io.tm_h + io.tm_a; if( ierr != 0 ) { fprintf( flog, "*** in init_blocks ierr != 0 ***\n" ); goto ERROR_HANDLE; } /*----- permutes the rows and columns of the matrix ------------------*/ if( dpermC( csmat, perm ) != 0 ) { fprintf( flog, "*** dpermC error ***\n" ); goto ERROR_HANDLE; } /*----- permutes right hand side -------------------------------------*/ for( i = 0; i < io.ndim; i++ ) rhs[perm[i]] = rhs0[i]; vbmat = (vbsptr)Malloc( sizeof(VBSparMat), "main" ); ierr = csrvbsrC( 1, nBlock, nB, csmat, vbmat ); if( ierr != 0 ) { fprintf( flog, "*** in csrvbsr ierr != 0 ***\n" ); goto ERROR_HANDLE; } if( output_mat ) { char matdata[MAX_LINE]; FILE *fmatlab; int ii, jj; sprintf( matdata, "OUT/%s.dat", io.HBnameF ); if( NULL != ( fmatlab = fopen( matdata, "w" ) ) ) { fprintf( fmatlab, "%d %d 0\n", csmat->n, csmat->n ); for( ii = 0; ii < csmat->n; ii++ ) for( jj = 0; jj < csmat->nzcount[ii]; jj++ ) fprintf( fmatlab, "%d %d 1\n", ii+1, csmat->ja[ii][jj]+1 ); fclose( fmatlab ); } } io.rt_v = (double)csmat->n / (double)vbmat->n; io.rt_e = (double)nnzCS( csmat ) / (double)nnzVBMat( vbmat ); io.ceff = (double)nnzCS( csmat ) / (double)memVBMat( vbmat ) * 100; output_header_vb( &io ); lfil = io.lfil0; tol = io.tol0; w = (BData *)Malloc(vbmat->n*sizeof(BData),"main"); for( i = 0; i < vbmat->n; i++ ) w[i] = (double *)Malloc( max_blk_sz, "main" ); /* LOOP THROUGH PARAMETERS ---------------------------------------*/ for( iparam = 1; iparam <= io.nparam; iparam++ ) { fprintf( flog, "iparam = %d\n", iparam ); lu = (vbiluptr)Malloc( sizeof(VBILUSpar), "main" ); fprintf( flog, "begin vbilut\n" ); tm1 = sys_timer(); /*-------------------- call VBILUT preconditioner set-up */ ierr = vbilutC( vbmat, lu, lfil, tol, w, flog ); tm2 = sys_timer(); if( ierr == -2 ) { fprintf( io.fout, "Singular diagonal block...\n" ); cleanVBILU( lu ); goto NEXT_MAT; } else if( ierr != 0 ) { fprintf( flog, "*** vbilu error, ierr != 0 ***\n" ); goto ERROR_HANDLE; } io.tm_p = tm2 - tm1; io.fillfact = (double)nnz_vbilu( lu )/(double)(io.nnz + 1); fprintf( flog, "vbilut ends, fill factor (mem used) = %f\n", io.fillfact ); if( skip_its ) { io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } if( VBcondestC( lu, sol, x, flog ) != 0 ) { fprintf( flog, "Not attempting iterative solution.\n" ); fprintf( io.fout, "Not attempting iterative solution.\n" ); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } /*-------------------- initial guess */ /* for( i = 0; i < io.ndim; i++ ) x[i] = 0.0; */ randvec(x, n); /*-------------------- create a file for printing */ if(plotting ) { sprintf( pltfile, "OUT/%s_VBILUT_F%05d_T%08.6f", io.HBnameF, lfil,tol); if( NULL == ( fits = fopen( pltfile, "w" ) ) ) { fprintf( flog, "Can't open output file %s...\n", pltfile ); goto ERROR_HANDLE; } } else fits =NULL; /*-------------------- set up the structs before calling fgmr */ MAT->n = n; MAT->CSR = csmat; MAT->matvec = matvecCSR; PRE->VBILU = lu; PRE->precon = preconVBR; /*-------------------- call fgmr */ io.its = io.maxits; tm1 = sys_timer(); fgmr(MAT, PRE, rhs, x, io.tol, io.im, &io.its, fits); tm2 = sys_timer(); io.tm_i = tm2 - tm1; if( io.its < io.maxits ) fprintf( flog, "param %03d OK: converged in %d steps...\n\n", iparam, io.its ); else fprintf( flog, "not converged in %d steps...\n\n", io.maxits ); if( fits ) fclose( fits ); /* calculate residual norm */ vbmatvec( vbmat, x, sol ); terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( rhs[i] - sol[i] ) * ( rhs[i] - sol[i] ); io.rnorm = sqrt(terr); /* get sol vector of original matrix (before permutation) */ for( i = 0; i < io.ndim; i++ ) sol[perm[i]] = x[i]; /* calculate error norm */ terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( sol[i] - 1.0 ) * ( sol[i] - 1.0 ); io.enorm = sqrt(terr); NEXT_PARA: output_result(lfil, &io, iparam ); lfil += io.lfilInc; tol *= io.tolMul; cleanVBILU( lu ); } NEXT_MAT: /* output_blocks( nBlock, nB, io.fout ); */ for( i = 0; i < vbmat->n; i++ ) free( w[i] ); free( w ); cleanCS( csmat ); cleanVBMat( vbmat ); free( nB ); free( perm ); free( sol ); free( x ); free( rhs0 ); free( rhs ); } fclose( io.fout ); if( flog != stdout ) fclose ( flog ); fclose( fmat ); free(MAT); free(PRE); return 0; ERROR_HANDLE: errexit( "main.c\n" ); return 1; } itsol-1.0.0/TESTS_HB/runall0000750000265600020320000000020511062577476014473 0ustar tilleaadmin#/bin/sh ###(cd ..; make lib) make all ./arms.ex ./ilut.ex ### ./iluc.ex ./iluk.ex ./vbiluk.ex ./vbilut.ex echo 'DONE -) ' itsol-1.0.0/TESTS_HB/inputs0000640000265600020320000000341511062577476014524 0ustar tilleaadmin3 1. nparam = number of tests for the preconditioner (see below) 60 2. dim = dimension of Krylov subspace in (outer) FGMRES 300 3. maxits = maxits in outer fgmres. 1.0e-8 4. tol = tolerance for stopping iteration 10 5. lfil0 = initial lfil 5 6. lfilInc = increment for lfil 0.1 7. tol0 = initial tol 0.01 8. tolMul = multiple increment for tol0 2 9. USED BY ILUK ONLY: fill_lev = fill level 0 10. ARMS ONLY: PQ perms or Ind. Sets. 400 11. ARMS ONLY: Block-size for independent sets/ last block ### end INPUT PARAMETERS in file "inputs": ---------------------------------- nparam : number of tests dim : dimension of Krylov subspace in (outer) FGMRES maxits : Maximum number of outer iterations tol : tolerance for stopping iteration eps : not available in Hash-based algorithm. <= 1. indicating how close are two rows or columns which can be grouped in the same block. lfil0 : initial fill-in parameter lfilInc : increment for the fill-in parameter after each test **** next two are for VBILUT only -- tol0 : the initial threshold for dropping small terms in the actorization tolMul : multiple for the threshold after each test **** next two are for ILUK only -- fill_lev : Level of fill for ILUK preconditioner **** next are for ARMS only perm_type: PQ or Indset ordering Bsize : block size - This has a dual role. It is the block size for indset permutations. It is also the last block size for PQ orderings [i.e, algorithm stops when schur complement reaches a size <= Bsize] itsol-1.0.0/TESTS_HB/MATRICES/0000751000265600020320000000000011062574351014450 5ustar tilleaadminitsol-1.0.0/TESTS_HB/MATRICES/PORES30000640000265600020320000026146411062577476015376 0ustar tilleaadmin1UNSYMMETRIC MATRIX FROM PORES PORES 3 1121 34 218 869 0 RUA 532 532 3474 0 (16I5) (16I5) (4D20.10) 1 4 6 10 12 16 18 22 24 28 30 34 36 40 42 46 48 52 54 58 60 64 66 70 72 76 78 82 84 88 90 94 96 100 102 106 108 112 114 118 120 124 126 130 132 136 138 142 144 148 150 154 156 160 162 166 168 172 174 178 180 184 186 190 192 196 198 202 204 208 210 215 217 223 227 231 235 241 245 253 259 267 273 281 287 295 301 309 315 323 329 337 343 351 357 365 371 379 385 393 399 407 413 421 427 435 441 449 455 463 469 477 483 491 497 505 511 519 525 533 539 547 553 561 567 575 581 589 595 603 609 617 623 631 637 645 651 659 665 673 679 687 693 700 706 711 713 718 720 726 728 734 739 747 751 761 767 777 783 793 799 809 815 825 831 841 847 857 863 873 879 889 895 905 911 921 927 937 943 953 959 969 975 985 991 1001 1007 1017 1023 1033 1039 1049 1055 1065 1071 1081 1087 1097 1103 1113 1119 1129 1135 1145 1151 1161 1167 1177 1183 1193 1199 1209 1215 1225 1231 1241 1247 1257 1263 1272 1278 1284 1286 1292 1294 1301 1303 1311 1317 1325 1327 1337 1341 1351 1355 1365 1369 1379 1383 1393 1397 1407 1411 1421 1425 1435 1439 1449 1453 1463 1467 1477 1481 1491 1495 1505 1509 1519 1523 1533 1537 1547 1551 1561 1565 1575 1579 1589 1593 1603 1607 1617 1621 1631 1635 1645 1649 1659 1663 1673 1677 1687 1691 1701 1705 1715 1719 1729 1733 1743 1747 1757 1761 1771 1775 1784 1788 1794 1796 1803 1805 1813 1817 1825 1831 1839 1843 1853 1859 1869 1875 1885 1891 1901 1907 1917 1923 1933 1939 1949 1955 1965 1971 1981 1987 1997 2003 2013 2019 2029 2035 2045 2051 2061 2067 2077 2083 2093 2099 2109 2115 2125 2131 2141 2147 2157 2163 2173 2179 2189 2195 2205 2211 2221 2227 2237 2243 2253 2259 2269 2275 2285 2291 2301 2307 2317 2323 2333 2339 2349 2355 2364 2370 2376 2378 2384 2386 2392 2394 2400 2402 2410 2415 2425 2432 2442 2449 2459 2466 2476 2483 2493 2500 2510 2517 2527 2534 2544 2551 2561 2568 2578 2585 2595 2602 2612 2619 2629 2636 2646 2653 2663 2670 2680 2687 2697 2704 2714 2721 2731 2738 2748 2755 2765 2772 2782 2789 2799 2806 2816 2823 2833 2840 2850 2857 2867 2874 2884 2891 2901 2908 2918 2925 2935 2942 2952 2959 2968 2975 2981 2983 2989 2991 2997 2999 3004 3006 3012 3015 3023 3028 3036 3041 3049 3054 3062 3067 3075 3080 3088 3093 3101 3106 3114 3119 3127 3132 3140 3145 3153 3158 3166 3171 3179 3184 3192 3197 3205 3210 3218 3223 3231 3236 3244 3249 3257 3262 3270 3275 3283 3288 3296 3301 3309 3314 3322 3327 3335 3340 3348 3353 3361 3366 3374 3379 3387 3392 3400 3405 3413 3418 3426 3431 3438 3443 3448 3450 3455 3457 3463 3465 3470 3475 1 2 3 1 2 1 3 4 5 3 4 3 5 6 7 5 6 5 7 8 9 7 8 7 9 10 11 9 10 9 11 12 13 11 12 11 13 14 15 13 14 13 15 16 17 15 16 15 17 18 19 17 18 17 19 20 21 19 20 19 21 22 23 21 22 21 23 24 25 23 24 23 25 26 27 25 26 25 27 28 29 27 28 27 29 30 31 29 30 29 31 32 33 31 32 31 33 34 35 33 34 33 35 36 37 35 36 35 37 38 39 37 38 37 39 40 41 39 40 39 41 42 43 41 42 41 43 44 45 43 44 43 45 46 47 45 46 45 47 48 49 47 48 47 49 50 51 49 50 49 51 52 53 51 52 51 53 54 55 53 54 53 55 56 57 55 56 55 57 58 59 57 58 57 59 60 61 59 60 59 61 62 63 61 62 61 63 64 65 63 64 63 65 66 67 65 66 65 67 68 69 67 68 67 69 70 71 69 70 69 71 72 73 74 71 72 71 72 73 74 75 76 71 72 73 74 73 74 75 76 73 74 75 76 77 78 79 80 153 154 77 78 153 154 77 78 79 80 81 82 155 156 77 78 79 80 155 156 79 80 81 82 83 84 157 158 79 80 81 82 157 158 81 82 83 84 85 86 159 160 81 82 83 84 159 160 83 84 85 86 87 88 161 162 83 84 85 86 161 162 85 86 87 88 89 90 163 164 85 86 87 88 163 164 87 88 89 90 91 92 165 166 87 88 89 90 165 166 89 90 91 92 93 94 167 168 89 90 91 92 167 168 91 92 93 94 95 96 169 170 91 92 93 94 169 170 93 94 95 96 97 98 171 172 93 94 95 96 171 172 95 96 97 98 99 100 173 174 95 96 97 98 173 174 97 98 99 100 101 102 175 176 97 98 99 100 175 176 99 100 101 102 103 104 177 178 99 100 101 102 177 178 101 102 103 104 105 106 179 180 101 102 103 104 179 180 103 104 105 106 107 108 181 182 103 104 105 106 181 182 105 106 107 108 109 110 183 184 105 106 107 108 183 184 107 108 109 110 111 112 185 186 107 108 109 110 185 186 109 110 111 112 113 114 187 188 109 110 111 112 187 188 111 112 113 114 115 116 189 190 111 112 113 114 189 190 113 114 115 116 117 118 191 192 113 114 115 116 191 192 115 116 117 118 119 120 193 194 115 116 117 118 193 194 117 118 119 120 121 122 195 196 117 118 119 120 195 196 119 120 121 122 123 124 197 198 119 120 121 122 197 198 121 122 123 124 125 126 199 200 121 122 123 124 199 200 123 124 125 126 127 128 201 202 123 124 125 126 201 202 125 126 127 128 129 130 203 204 125 126 127 128 203 204 127 128 129 130 131 132 205 206 127 128 129 130 205 206 129 130 131 132 133 134 207 208 129 130 131 132 207 208 131 132 133 134 135 136 209 210 131 132 133 134 209 210 133 134 135 136 137 138 211 212 133 134 135 136 211 212 135 136 137 138 139 140 213 214 135 136 137 138 213 214 137 138 139 140 141 142 215 216 137 138 139 140 215 216 139 140 141 142 143 144 217 218 139 140 141 142 217 218 141 142 143 144 145 219 220 141 142 143 144 219 220 143 145 146 147 221 145 146 145 147 148 149 223 147 148 147 149 150 151 152 225 149 150 149 150 151 152 227 228 149 150 151 152 228 77 78 153 154 155 156 229 230 153 154 229 230 79 80 153 154 155 156 157 158 231 232 153 154 155 156 231 232 81 82 155 156 157 158 159 160 233 234 155 156 157 158 233 234 83 84 157 158 159 160 161 162 235 236 157 158 159 160 235 236 85 86 159 160 161 162 163 164 237 238 159 160 161 162 237 238 87 88 161 162 163 164 165 166 239 240 161 162 163 164 239 240 89 90 163 164 165 166 167 168 241 242 163 164 165 166 241 242 91 92 165 166 167 168 169 170 243 244 165 166 167 168 243 244 93 94 167 168 169 170 171 172 245 246 167 168 169 170 245 246 95 96 169 170 171 172 173 174 247 248 169 170 171 172 247 248 97 98 171 172 173 174 175 176 249 250 171 172 173 174 249 250 99 100 173 174 175 176 177 178 251 252 173 174 175 176 251 252 101 102 175 176 177 178 179 180 253 254 175 176 177 178 253 254 103 104 177 178 179 180 181 182 255 256 177 178 179 180 255 256 105 106 179 180 181 182 183 184 257 258 179 180 181 182 257 258 107 108 181 182 183 184 185 186 259 260 181 182 183 184 259 260 109 110 183 184 185 186 187 188 261 262 183 184 185 186 261 262 111 112 185 186 187 188 189 190 263 264 185 186 187 188 263 264 113 114 187 188 189 190 191 192 265 266 187 188 189 190 265 266 115 116 189 190 191 192 193 194 267 268 189 190 191 192 267 268 117 118 191 192 193 194 195 196 269 270 191 192 193 194 269 270 119 120 193 194 195 196 197 198 271 272 193 194 195 196 271 272 121 122 195 196 197 198 199 200 273 274 195 196 197 198 273 274 123 124 197 198 199 200 201 202 275 276 197 198 199 200 275 276 125 126 199 200 201 202 203 204 277 278 199 200 201 202 277 278 127 128 201 202 203 204 205 206 279 280 201 202 203 204 279 280 129 130 203 204 205 206 207 208 281 282 203 204 205 206 281 282 131 132 205 206 207 208 209 210 283 284 205 206 207 208 283 284 133 134 207 208 209 210 211 212 285 286 207 208 209 210 285 286 135 136 209 210 211 212 213 214 287 288 209 210 211 212 287 288 137 138 211 212 213 214 215 216 289 290 211 212 213 214 289 290 139 140 213 214 215 216 217 218 291 292 213 214 215 216 291 292 141 142 215 216 217 218 219 220 293 294 215 216 217 218 293 294 143 144 217 218 219 220 221 295 296 217 218 219 220 295 296 145 219 221 222 223 297 221 222 147 221 223 224 225 299 223 224 149 223 225 226 227 228 301 225 226 151 152 225 226 227 228 303 304 151 225 226 227 228 304 153 154 229 230 231 232 305 306 229 230 155 156 229 230 231 232 233 234 307 308 229 230 231 232 157 158 231 232 233 234 235 236 309 310 231 232 233 234 159 160 233 234 235 236 237 238 311 312 233 234 235 236 161 162 235 236 237 238 239 240 313 314 235 236 237 238 163 164 237 238 239 240 241 242 315 316 237 238 239 240 165 166 239 240 241 242 243 244 317 318 239 240 241 242 167 168 241 242 243 244 245 246 319 320 241 242 243 244 169 170 243 244 245 246 247 248 321 322 243 244 245 246 171 172 245 246 247 248 249 250 323 324 245 246 247 248 173 174 247 248 249 250 251 252 325 326 247 248 249 250 175 176 249 250 251 252 253 254 327 328 249 250 251 252 177 178 251 252 253 254 255 256 329 330 251 252 253 254 179 180 253 254 255 256 257 258 331 332 253 254 255 256 181 182 255 256 257 258 259 260 333 334 255 256 257 258 183 184 257 258 259 260 261 262 335 336 257 258 259 260 185 186 259 260 261 262 263 264 337 338 259 260 261 262 187 188 261 262 263 264 265 266 339 340 261 262 263 264 189 190 263 264 265 266 267 268 341 342 263 264 265 266 191 192 265 266 267 268 269 270 343 344 265 266 267 268 193 194 267 268 269 270 271 272 345 346 267 268 269 270 195 196 269 270 271 272 273 274 347 348 269 270 271 272 197 198 271 272 273 274 275 276 349 350 271 272 273 274 199 200 273 274 275 276 277 278 351 352 273 274 275 276 201 202 275 276 277 278 279 280 353 354 275 276 277 278 203 204 277 278 279 280 281 282 355 356 277 278 279 280 205 206 279 280 281 282 283 284 357 358 279 280 281 282 207 208 281 282 283 284 285 286 359 360 281 282 283 284 209 210 283 284 285 286 287 288 361 362 283 284 285 286 211 212 285 286 287 288 289 290 363 364 285 286 287 288 213 214 287 288 289 290 291 292 365 366 287 288 289 290 215 216 289 290 291 292 293 294 367 368 289 290 291 292 217 218 291 292 293 294 295 296 369 370 291 292 293 294 219 220 293 294 295 296 297 371 372 293 294 295 296 221 295 297 298 299 373 297 298 223 297 299 300 301 302 375 299 300 225 299 300 301 302 303 304 377 299 300 301 302 227 228 301 302 303 304 379 380 227 301 302 303 304 380 229 230 305 306 307 308 381 382 229 230 305 306 231 232 305 306 307 308 309 310 383 384 231 232 305 306 307 308 233 234 307 308 309 310 311 312 385 386 233 234 307 308 309 310 235 236 309 310 311 312 313 314 387 388 235 236 309 310 311 312 237 238 311 312 313 314 315 316 389 390 237 238 311 312 313 314 239 240 313 314 315 316 317 318 391 392 239 240 313 314 315 316 241 242 315 316 317 318 319 320 393 394 241 242 315 316 317 318 243 244 317 318 319 320 321 322 395 396 243 244 317 318 319 320 245 246 319 320 321 322 323 324 397 398 245 246 319 320 321 322 247 248 321 322 323 324 325 326 399 400 247 248 321 322 323 324 249 250 323 324 325 326 327 328 401 402 249 250 323 324 325 326 251 252 325 326 327 328 329 330 403 404 251 252 325 326 327 328 253 254 327 328 329 330 331 332 405 406 253 254 327 328 329 330 255 256 329 330 331 332 333 334 407 408 255 256 329 330 331 332 257 258 331 332 333 334 335 336 409 410 257 258 331 332 333 334 259 260 333 334 335 336 337 338 411 412 259 260 333 334 335 336 261 262 335 336 337 338 339 340 413 414 261 262 335 336 337 338 263 264 337 338 339 340 341 342 415 416 263 264 337 338 339 340 265 266 339 340 341 342 343 344 417 418 265 266 339 340 341 342 267 268 341 342 343 344 345 346 419 420 267 268 341 342 343 344 269 270 343 344 345 346 347 348 421 422 269 270 343 344 345 346 271 272 345 346 347 348 349 350 423 424 271 272 345 346 347 348 273 274 347 348 349 350 351 352 425 426 273 274 347 348 349 350 275 276 349 350 351 352 353 354 427 428 275 276 349 350 351 352 277 278 351 352 353 354 355 356 429 430 277 278 351 352 353 354 279 280 353 354 355 356 357 358 431 432 279 280 353 354 355 356 281 282 355 356 357 358 359 360 433 434 281 282 355 356 357 358 283 284 357 358 359 360 361 362 435 436 283 284 357 358 359 360 285 286 359 360 361 362 363 364 437 438 285 286 359 360 361 362 287 288 361 362 363 364 365 366 439 440 287 288 361 362 363 364 289 290 363 364 365 366 367 368 441 442 289 290 363 364 365 366 291 292 365 366 367 368 369 370 443 444 291 292 365 366 367 368 293 294 367 368 369 370 371 372 445 446 293 294 367 368 369 370 295 296 369 370 371 372 373 447 448 295 296 369 370 371 372 297 371 373 374 375 449 373 374 299 373 375 376 377 451 375 376 301 375 377 378 379 453 377 378 303 304 377 379 380 455 379 380 305 306 381 382 383 384 457 458 305 306 381 382 458 307 308 381 382 383 384 385 386 459 460 307 308 381 382 383 384 460 309 310 383 384 385 386 387 388 461 462 309 310 383 384 385 386 462 311 312 385 386 387 388 389 390 463 464 311 312 385 386 387 388 464 313 314 387 388 389 390 391 392 465 466 313 314 387 388 389 390 466 315 316 389 390 391 392 393 394 467 468 315 316 389 390 391 392 468 317 318 391 392 393 394 395 396 469 470 317 318 391 392 393 394 470 319 320 393 394 395 396 397 398 471 472 319 320 393 394 395 396 472 321 322 395 396 397 398 399 400 473 474 321 322 395 396 397 398 474 323 324 397 398 399 400 401 402 475 476 323 324 397 398 399 400 476 325 326 399 400 401 402 403 404 477 478 325 326 399 400 401 402 478 327 328 401 402 403 404 405 406 479 480 327 328 401 402 403 404 480 329 330 403 404 405 406 407 408 481 482 329 330 403 404 405 406 482 331 332 405 406 407 408 409 410 483 484 331 332 405 406 407 408 484 333 334 407 408 409 410 411 412 485 486 333 334 407 408 409 410 486 335 336 409 410 411 412 413 414 487 488 335 336 409 410 411 412 488 337 338 411 412 413 414 415 416 489 490 337 338 411 412 413 414 490 339 340 413 414 415 416 417 418 491 492 339 340 413 414 415 416 492 341 342 415 416 417 418 419 420 493 494 341 342 415 416 417 418 494 343 344 417 418 419 420 421 422 495 496 343 344 417 418 419 420 496 345 346 419 420 421 422 423 424 497 498 345 346 419 420 421 422 498 347 348 421 422 423 424 425 426 499 500 347 348 421 422 423 424 500 349 350 423 424 425 426 427 428 501 502 349 350 423 424 425 426 502 351 352 425 426 427 428 429 430 503 504 351 352 425 426 427 428 504 353 354 427 428 429 430 431 432 505 506 353 354 427 428 429 430 506 355 356 429 430 431 432 433 434 507 508 355 356 429 430 431 432 508 357 358 431 432 433 434 435 436 509 510 357 358 431 432 433 434 510 359 360 433 434 435 436 437 438 511 512 359 360 433 434 435 436 512 361 362 435 436 437 438 439 440 513 514 361 362 435 436 437 438 514 363 364 437 438 439 440 441 442 515 516 363 364 437 438 439 440 516 365 366 439 440 441 442 443 444 517 518 365 366 439 440 441 442 518 367 368 441 442 443 444 445 446 519 520 367 368 441 442 443 444 520 369 370 443 444 445 446 447 448 521 522 369 370 443 444 445 446 522 371 372 445 446 447 448 449 523 524 371 372 445 446 447 448 524 373 447 449 450 451 525 449 450 375 449 451 452 453 527 451 452 377 451 453 454 455 529 453 454 379 453 455 456 531 455 456 381 382 457 458 459 460 381 457 458 383 384 457 458 459 460 461 462 383 457 458 459 460 385 386 459 460 461 462 463 464 385 459 460 461 462 387 388 461 462 463 464 465 466 387 461 462 463 464 389 390 463 464 465 466 467 468 389 463 464 465 466 391 392 465 466 467 468 469 470 391 465 466 467 468 393 394 467 468 469 470 471 472 393 467 468 469 470 395 396 469 470 471 472 473 474 395 469 470 471 472 397 398 471 472 473 474 475 476 397 471 472 473 474 399 400 473 474 475 476 477 478 399 473 474 475 476 401 402 475 476 477 478 479 480 401 475 476 477 478 403 404 477 478 479 480 481 482 403 477 478 479 480 405 406 479 480 481 482 483 484 405 479 480 481 482 407 408 481 482 483 484 485 486 407 481 482 483 484 409 410 483 484 485 486 487 488 409 483 484 485 486 411 412 485 486 487 488 489 490 411 485 486 487 488 413 414 487 488 489 490 491 492 413 487 488 489 490 415 416 489 490 491 492 493 494 415 489 490 491 492 417 418 491 492 493 494 495 496 417 491 492 493 494 419 420 493 494 495 496 497 498 419 493 494 495 496 421 422 495 496 497 498 499 500 421 495 496 497 498 423 424 497 498 499 500 501 502 423 497 498 499 500 425 426 499 500 501 502 503 504 425 499 500 501 502 427 428 501 502 503 504 505 506 427 501 502 503 504 429 430 503 504 505 506 507 508 429 503 504 505 506 431 432 505 506 507 508 509 510 431 505 506 507 508 433 434 507 508 509 510 511 512 433 507 508 509 510 435 436 509 510 511 512 513 514 435 509 510 511 512 437 438 511 512 513 514 515 516 437 511 512 513 514 439 440 513 514 515 516 517 518 439 513 514 515 516 441 442 515 516 517 518 519 520 441 515 516 517 518 443 444 517 518 519 520 521 522 443 517 518 519 520 445 446 519 520 521 522 523 524 445 519 520 521 522 447 448 521 522 523 524 525 447 521 522 523 524 449 523 525 526 527 525 526 451 525 527 528 529 527 528 453 527 529 530 531 532 529 530 455 529 530 531 532 455 529 530 531 532 -0.3155489089E+02 -0.2376065184E-01 0.3136638385E+02 0.1433257682E+04 -0.1659633607E+04 0.3136638385E+02 -0.6949281056E+02 -0.2448368194E-01 0.3791016643E+02 0.1477128137E+04 -0.1710279238E+04 0.3791016643E+02 -0.8288075824E+02 -0.2520705066E-01 0.4474789557E+02 0.1521070604E+04 -0.1760980423E+04 0.4474789557E+02 -0.9685667915E+02 -0.2593016403E-01 0.5187964671E+02 0.1565042077E+04 -0.1811691043E+04 0.5187964671E+02 -0.1114198042E+03 -0.2665361615E-01 0.5930457079E+02 0.1609074027E+04 -0.1862449777E+04 0.5930457079E+02 -0.1265679074E+03 -0.2737681297E-01 0.6702129650E+02 0.1653127801E+04 -0.1913213311E+04 0.6702129650E+02 -0.1422979180E+03 -0.2810034856E-01 0.7502811942E+02 0.1697237442E+04 -0.1964021980E+04 0.7502811942E+02 -0.1586058335E+03 -0.2882362884E-01 0.8332274698E+02 0.1741365858E+04 -0.2014833476E+04 0.8332274698E+02 -0.1754882045E+03 -0.2954695085E-01 0.9190401997E+02 0.1785530185E+04 -0.2065668037E+04 0.9190401997E+02 -0.1929413774E+03 -0.3027061170E-01 0.1007694412E+03 0.1829747855E+04 -0.2116546092E+04 0.1007694412E+03 -0.2109607159E+03 -0.3099401720E-01 0.1099168770E+03 0.1873982631E+04 -0.2167425885E+04 0.1099168770E+03 -0.2295419284E+03 -0.3171776156E-01 0.1193441642E+03 0.1918270248E+04 -0.2218348838E+04 0.1193441642E+03 -0.2486805910E+03 -0.3244125057E-01 0.1290490474E+03 0.1962574689E+04 -0.2269273336E+04 0.1290490474E+03 -0.2683722245E+03 -0.3316507846E-01 0.1390292975E+03 0.2006931887E+04 -0.2320240931E+04 0.1390292975E+03 -0.2886116923E+03 -0.3388865100E-01 0.1492820123E+03 0.2051305935E+04 -0.2371210077E+04 0.1492820123E+03 -0.3093950568E+03 -0.3461226530E-01 0.1598061536E+03 0.2095714895E+04 -0.2422201609E+04 0.1598061536E+03 -0.3307183624E+03 -0.3533621851E-01 0.1705988014E+03 0.2140176878E+04 -0.2473236392E+04 0.1705988014E+03 -0.3525763787E+03 -0.3605991635E-01 0.1816576506E+03 0.2184656036E+04 -0.2524272919E+04 0.1816576506E+03 -0.3749645239E+03 -0.3678395312E-01 0.1929804193E+03 0.2229188522E+04 -0.2575352883E+04 0.1929804193E+03 -0.3978781449E+03 -0.3750773451E-01 0.2045647415E+03 0.2273738490E+04 -0.2626434777E+04 0.2045647415E+03 -0.4213125887E+03 -0.3823185484E-01 0.2164083248E+03 0.2318342137E+04 -0.2677560322E+04 0.2164083248E+03 -0.4452623802E+03 -0.3895571977E-01 0.2285079918E+03 0.2362963601E+04 -0.2728688002E+04 0.2285079918E+03 -0.4697236877E+03 -0.3967962646E-01 0.2408630855E+03 0.2407621079E+04 -0.2779838736E+04 0.2408630855E+03 -0.4946927325E+03 -0.4040387212E-01 0.2534704816E+03 0.2452332782E+04 -0.2831033455E+04 0.2534704816E+03 -0.5201640796E+03 -0.4112786232E-01 0.2663278746E+03 0.2497062814E+04 -0.2882230620E+04 0.2663278746E+03 -0.5461330909E+03 -0.4185219147E-01 0.2794329266E+03 0.2541847429E+04 -0.2933471988E+04 0.2794329266E+03 -0.5725951439E+03 -0.4257626512E-01 0.2927833583E+03 0.2586650697E+04 -0.2984715999E+04 0.2927833583E+03 -0.5995457163E+03 -0.4330067769E-01 0.3063769214E+03 0.2631508888E+04 -0.3036004419E+04 0.3063769214E+03 -0.6269801982E+03 -0.4402483466E-01 0.3202112595E+03 0.2676386035E+04 -0.3087295663E+04 0.3202112595E+03 -0.6548940178E+03 -0.4474933049E-01 0.3342841520E+03 0.2721318420E+04 -0.3138631507E+04 0.3342841520E+03 -0.6832815712E+03 -0.4547357057E-01 0.3485922208E+03 0.2766270038E+04 -0.3189970342E+04 0.3485922208E+03 -0.7121394538E+03 -0.4619785209E-01 0.3631354367E+03 0.2811259095E+04 -0.3241333092E+04 0.3631354367E+03 -0.7414643098E+03 -0.4692247219E-01 0.3779104703E+03 0.2856303813E+04 -0.3292740695E+04 0.3779104703E+03 -0.7712505888E+03 -0.4764683617E-01 0.3929151061E+03 0.2901368122E+04 -0.3344151500E+04 0.3929151061E+03 -0.8014939350E+03 -0.4837153841E-01 0.4081471986E+03 0.2946488337E+04 -0.3395607301E+04 0.4081471986E+03 -0.7863581909E+03 -0.6493665282E+00 0.3777728213E+03 0.6002189158E+00 0.2991628347E+04 -0.3447066423E+04 0.3777728213E+03 0.6002189158E+00 -0.5573477016E+03 -0.8407492867E+02 0.1791496931E+03 0.8341226062E+02 -0.2576563419E+04 0.3210679587E+02 0.5613483824E+04 -0.3530729661E+04 0.1791496931E+03 0.8341226062E+02 -0.1794759034E+03 -0.8349946862E+02 -0.2874688652E+04 0.2992814733E+04 0.5957592646E+04 -0.6543446184E+04 -0.4920659447E+05 -0.5237500265E+00 0.2176961500E+03 0.2118958094E-02 0.4898877407E+05 0.4889606997E+00 0.2343500438E+04 -0.2372214451E+04 -0.1190036396E+02 0.9695645821E+02 0.2176961500E+03 0.2118958094E-02 -0.4826919293E+05 -0.5039686452E+00 0.2216432660E+03 0.2101284346E-02 0.4782955430E+05 0.4655517390E+00 -0.3785884806E+03 0.3483603660E+01 0.2442855555E+04 -0.2478380203E+04 -0.1915500551E+02 0.9773386687E+02 0.2216432660E+03 0.2101284346E-02 -0.4711564618E+05 -0.4823415885E+00 0.2250810792E+03 0.2076436571E-02 0.4666860921E+05 0.4424407732E+00 -0.3859225014E+03 0.3556205775E+01 0.2541037154E+04 -0.2585234577E+04 -0.1845583130E+02 0.9827807502E+02 0.2250810792E+03 0.2076436571E-02 -0.4596121669E+05 -0.4611932383E+00 0.2280121002E+03 0.2044885304E-02 0.4550779749E+05 0.4198222937E+00 -0.3920692936E+03 0.3617372054E+01 0.2638033159E+04 -0.2691955403E+04 -0.1772950975E+02 0.9868159003E+02 0.2280121002E+03 0.2044885304E-02 -0.4480401297E+05 -0.4405306341E+00 0.2304370852E+03 0.2007074860E-02 0.4434522436E+05 0.3977021285E+00 -0.3970111300E+03 0.3666797781E+01 0.2733918630E+04 -0.2798560951E+04 -0.1705122864E+02 0.9894244575E+02 0.2304370852E+03 0.2007074860E-02 -0.4364593342E+05 -0.4203898351E+00 0.2323567837E+03 0.1963445153E-02 0.4318278672E+05 0.3761160471E+00 -0.4008070357E+03 0.3705172262E+01 0.2828730119E+04 -0.2905011859E+04 -0.1643421758E+02 0.9906200162E+02 0.2323567837E+03 0.1963445153E-02 -0.4248516928E+05 -0.4007712416E+00 0.2337737869E+03 0.1914442190E-02 0.4201867246E+05 0.3550632671E+00 -0.4035312820E+03 0.3733249005E+01 0.2922539665E+04 -0.3011326323E+04 -0.1585861055E+02 0.9903713653E+02 0.2337737869E+03 0.1914442190E-02 -0.4132337040E+05 -0.3817016629E+00 0.2346896091E+03 0.1860496583E-02 0.4085452734E+05 0.3345697215E+00 -0.4052402784E+03 0.3751682493E+01 0.3015409754E+04 -0.3117507106E+04 -0.1533060573E+02 0.9887004237E+02 0.2346896091E+03 0.1860496583E-02 -0.4015889835E+05 -0.3631778893E+00 0.2351057734E+03 0.1802026331E-02 0.3968870988E+05 0.3146313523E+00 -0.4059992019E+03 0.3761140442E+01 0.3107409448E+04 -0.3223551489E+04 -0.1485417695E+02 0.9855738943E+02 0.2351057734E+03 0.1802026331E-02 -0.3899323729E+05 -0.3452193604E+00 0.2350237757E+03 0.1739444370E-02 0.3852270123E+05 0.2952667684E+00 -0.4058798471E+03 0.3762438452E+01 0.3198587253E+04 -0.3329461972E+04 -0.1440609165E+02 0.9810089911E+02 0.2350237757E+03 0.1739444370E-02 -0.3782485834E+05 -0.3278203591E+00 0.2344451503E+03 0.1673152138E-02 0.3735496947E+05 0.2764694386E+00 -0.4049336199E+03 0.3756129941E+01 0.3289005858E+04 -0.3435235845E+04 -0.1399765623E+02 0.9749732800E+02 0.2344451503E+03 0.1673152138E-02 -0.3665512173E+05 -0.3109952284E+00 0.2333720142E+03 0.1603550274E-02 0.3618687118E+05 0.2582529041E+00 -0.4032262302E+03 0.3742942606E+01 0.3378710815E+04 -0.3540875527E+04 -0.1360868983E+02 0.9674835143E+02 0.2333720142E+03 0.1603550274E-02 -0.3548254024E+05 -0.2947367913E+00 0.2318050378E+03 0.1531019546E-02 0.3501691637E+05 0.2406089095E+00 -0.4008062152E+03 0.3723403756E+01 0.3467767536E+04 -0.3646399168E+04 -0.1323821363E+02 0.9585089003E+02 0.2318050378E+03 0.1531019546E-02 -0.3430851280E+05 -0.2790562047E+00 0.2297449908E+03 0.1455935449E-02 0.3384650251E+05 0.2235484501E+00 -0.3977240413E+03 0.3698083841E+01 0.3556194542E+04 -0.3751767409E+04 -0.1288975629E+02 0.9480627615E+02 0.2297449908E+03 0.1455935449E-02 -0.3313218301E+05 -0.2639489074E+00 0.2271939839E+03 0.1378676370E-02 0.3267477033E+05 0.2070659136E+00 -0.3940368592E+03 0.3667614645E+01 0.3644050407E+04 -0.3856999526E+04 -0.1254677467E+02 0.9361237689E+02 0.2271939839E+03 0.1378676370E-02 -0.3195291507E+05 -0.2494116737E+00 0.2241532891E+03 0.1299607927E-02 0.3150108063E+05 0.1911573307E+00 -0.3897880558E+03 0.3632484604E+01 0.3731380482E+04 -0.3962094119E+04 -0.1221099966E+02 0.9226715549E+02 0.2241532891E+03 0.1299607927E-02 -0.3077178409E+05 -0.2354511664E+00 0.2206242312E+03 0.1219090779E-02 0.3032650595E+05 0.1758286380E+00 -0.3850254259E+03 0.3593205739E+01 0.3818235093E+04 -0.4067053547E+04 -0.1188464901E+02 0.9077225975E+02 0.2206242312E+03 0.1219090779E-02 -0.2958752659E+05 -0.2220595499E+00 0.2166080836E+03 0.1137480176E-02 0.2914978019E+05 0.1610712842E+00 -0.3798015603E+03 0.3550414588E+01 0.3904652954E+04 -0.4171874982E+04 -0.1155344773E+02 0.8912396742E+02 0.2166080836E+03 0.1137480176E-02 -0.2840110639E+05 -0.2092417085E+00 0.2121061944E+03 0.1055128494E-02 0.2797186456E+05 0.1468894461E+00 -0.3741571521E+03 0.3504522684E+01 0.3990678526E+04 -0.4276560641E+04 -0.1122065709E+02 0.8732375904E+02 0.2121061944E+03 0.1055128494E-02 -0.2721136374E+05 -0.1969908025E+00 0.2071202163E+03 0.9723847039E-03 0.2679159632E+05 0.1332755828E+00 -0.3681382633E+03 0.3456100508E+01 0.4076361118E+04 -0.4381108015E+04 -0.1088890382E+02 0.8536815869E+02 0.2071202163E+03 0.9723847039E-03 -0.2601906567E+05 -0.1853103285E+00 0.2016508635E+03 0.8895924188E-03 0.2560974010E+05 0.1202322013E+00 -0.3617955240E+03 0.3405677882E+01 0.4161757481E+04 -0.4485539971E+04 -0.1054571158E+02 0.8325831998E+02 0.2016508635E+03 0.8895924188E-03 -0.2482318434E+05 -0.1741943079E+00 0.1956987603E+03 0.8070942084E-03 0.2442526674E+05 0.1077532312E+00 -0.3551686846E+03 0.3353766131E+01 0.4246875230E+04 -0.4589812240E+04 -0.1019363447E+02 0.8099021812E+02 0.1956987603E+03 0.8070942084E-03 -0.2362433211E+05 -0.1636456724E+00 0.1892656209E+03 0.7252384541E-03 0.2323878627E+05 0.9584061636E-01 -0.3483016031E+03 0.3300827287E+01 0.4331780992E+04 -0.4693947656E+04 -0.9836466654E+01 0.7856479865E+02 0.1892656209E+03 0.7252384541E-03 -0.2242144491E+05 -0.1536602264E+00 0.1823525723E+03 0.6443746374E-03 0.2204923177E+05 0.8448946343E-01 -0.3412429756E+03 0.3247450089E+01 0.4416512639E+04 -0.4797943822E+04 -0.9461960592E+01 0.7597815885E+02 0.1823525723E+03 0.6443746374E-03 -0.2121501276E+05 -0.1442410742E+00 0.1749606626E+03 0.5648586584E-03 0.2085709109E+05 0.7370217123E-01 -0.3340300333E+03 0.3194064460E+01 0.4501111818E+04 -0.4901802475E+04 -0.9072796830E+01 0.7323049005E+02 0.1749606626E+03 0.5648586584E-03 -0.2000427254E+05 -0.1353874627E+00 0.1670908208E+03 0.4870557987E-03 0.1966159911E+05 0.6347726586E-01 -0.3267031172E+03 0.3141145408E+01 0.4585619943E+04 -0.5005522180E+04 -0.8667914155E+01 0.7031850844E+02 0.1670908208E+03 0.4870557987E-03 -0.1878846368E+05 -0.1271005601E+00 0.1587443713E+03 0.4113472949E-03 0.1846199304E+05 0.5381516903E-01 -0.3193014652E+03 0.3089158823E+01 0.4670068675E+04 -0.5109101447E+04 -0.8237098561E+01 0.6723856000E+02 0.1587443713E+03 0.4113472949E-03 -0.1756773340E+05 -0.1193865456E+00 0.1499218343E+03 0.3381359947E-03 0.1725841822E+05 0.4472097872E-01 -0.3118534916E+03 0.3038443272E+01 0.4754503499E+04 -0.5212562452E+04 -0.7776315815E+01 0.6398968205E+02 0.1499218343E+03 0.3381359947E-03 -0.1634090027E+05 -0.1122496546E+00 0.1406235745E+03 0.2678228036E-03 0.1604969236E+05 0.3619872127E-01 -0.3043822398E+03 0.2989289493E+01 0.4838909153E+04 -0.5315861038E+04 -0.7278838734E+01 0.6056617904E+02 0.1406235745E+03 0.2678228036E-03 -0.1510767504E+05 -0.1056975087E+00 0.1308503961E+03 0.2009246737E-03 0.1483552504E+05 0.2825480665E-01 -0.2969018673E+03 0.2941875385E+01 0.4923306136E+04 -0.5419018480E+04 -0.6727998243E+01 0.5696512095E+02 0.1308503961E+03 0.2009246737E-03 -0.1386656266E+05 -0.9974727685E-01 0.1206025391E+03 0.1379780740E-03 0.1361442016E+05 0.2090534695E-01 -0.2894062409E+03 0.2896150803E+01 0.5007680952E+04 -0.5522031904E+04 -0.6109804507E+01 0.5317941674E+02 0.1206025391E+03 0.1379780740E-03 -0.1261670829E+05 -0.9441958013E-01 0.1098797157E+03 0.7947072631E-04 0.1238552292E+05 0.1416993880E-01 -0.2818699117E+03 0.2851845669E+01 0.5091987487E+04 -0.5624900625E+04 -0.5394960059E+01 0.4920309098E+02 0.1098797157E+03 0.7947072631E-04 -0.1135597844E+05 -0.8972907033E-01 0.9868060920E+02 0.2629279189E-04 0.1114670144E+05 0.8061874330E-02 -0.2742282191E+03 0.2808220848E+01 0.5176129997E+04 -0.5727620448E+04 -0.4540911826E+01 0.4502529898E+02 0.9868060920E+02 0.2629279189E-04 -0.1008237853E+05 -0.8575377256E-01 0.8700061771E+02 0.9895967047E+04 0.2636714590E-02 -0.2663661638E+03 0.2763970905E+01 0.5259951219E+04 -0.5830188381E+04 -0.3489743199E+01 0.4063427417E+02 0.8700061771E+02 -0.8792145612E+04 -0.8462047846E-01 0.7483346863E+02 0.8629567670E+04 0.5082965969E+04 -0.5893890293E+04 0.7483346863E+02 -0.7480962486E+04 -0.8614997680E-01 0.6216772803E+02 0.7343203814E+04 0.5175969994E+04 -0.6001067153E+04 0.6216772803E+02 -0.6139865977E+04 -0.1113312448E+00 0.4698041304E+02 0.2364926251E-01 0.6029946712E+04 0.5269178620E+04 -0.6108375801E+04 0.4698041304E+02 0.2364926251E-01 -0.4656818420E+04 -0.2376846576E+01 0.4609065822E+04 0.2259661695E+01 -0.2578163132E+03 0.2883539389E+01 0.5620698272E+04 -0.6239128977E+04 0.2024228322E+02 0.4898877407E+05 0.4889606997E+00 -0.9963719315E+05 -0.9562128870E+00 0.8287033371E+01 0.7317243957E-04 0.5064005522E+05 0.4576765380E+00 0.5980902994E+03 -0.8811895827E+03 -0.1495564173E+02 0.2203719781E+03 0.4782955430E+05 0.4655517390E+00 0.8287033371E+01 0.7317243957E-04 -0.9786739485E+05 -0.9167453577E+00 0.7987170254E+01 0.6883162919E-04 0.5002148431E+05 0.4416772413E+00 -0.1440956407E+02 0.1321143419E+00 0.5971594601E+03 -0.8691554446E+03 -0.2201376621E+02 0.2172528491E+03 0.4666860921E+05 0.4424407732E+00 0.7987170254E+01 0.6883162919E-04 -0.9607380369E+05 -0.8774477210E+00 0.7692850274E+01 0.6464109046E-04 0.4938943352E+05 0.4256269825E+00 -0.1390644349E+02 0.1276897215E+00 0.5882808557E+03 -0.8570336063E+03 -0.2122476322E+02 0.2139986027E+03 0.4550779749E+05 0.4198222937E+00 0.7692850274E+01 0.6464109046E-04 -0.9426858160E+05 -0.8386630026E+00 0.7404060374E+01 0.6060233782E-04 0.4874560738E+05 0.4095971069E+00 -0.1339956602E+02 0.1231908896E+00 0.5793595945E+03 -0.8448529227E+03 -0.2041345633E+02 0.2107036478E+03 0.4434522436E+05 0.3977021285E+00 0.7404060374E+01 0.6060233782E-04 -0.9244725658E+05 -0.8004061693E+00 0.7120786976E+01 0.5671493337E-04 0.4808742866E+05 0.3935962768E+00 -0.1289127701E+02 0.1186422273E+00 0.5705026459E+03 -0.8326391047E+03 -0.1965608680E+02 0.2073606603E+03 0.4318278672E+05 0.3761160471E+00 0.7120786976E+01 0.5671493337E-04 -0.9061330490E+05 -0.7627460448E+00 0.6843008523E+01 0.5297899237E-04 0.4741647678E+05 0.3776580216E+00 -0.1238493174E+02 0.1140847033E+00 0.5616976042E+03 -0.8203639141E+03 -0.1896536231E+02 0.2039744269E+03 0.4201867246E+05 0.3550632671E+00 0.6843008523E+01 0.5297899237E-04 -0.8876228053E+05 -0.7256874228E+00 0.6570714529E+01 0.4939318225E-04 0.4673011786E+05 0.3617874432E+00 -0.1188373881E+02 0.1095527374E+00 0.5529549306E+03 -0.8080518151E+03 -0.1832011975E+02 0.2005363455E+03 0.4085452734E+05 0.3345697215E+00 0.6570714529E+01 0.4939318225E-04 -0.8689738282E+05 -0.6892858712E+00 0.6303888358E+01 0.4595667575E-04 0.4602990551E+05 0.3460146536E+00 -0.1138977033E+02 0.1050723649E+00 0.5442538396E+03 -0.7956744899E+03 -0.1772595830E+02 0.1970511302E+03 0.3968870988E+05 0.3146313523E+00 0.6303888358E+01 0.4595667575E-04 -0.8501427947E+05 -0.6535405649E+00 0.6042511010E+01 0.4266732027E-04 0.4531314892E+05 0.3303424131E+00 -0.1090502634E+02 0.1006652813E+00 0.5356283610E+03 -0.7832565090E+03 -0.1718646681E+02 0.1935102817E+03 0.3852270123E+05 0.2952667684E+00 0.6042511010E+01 0.4266732027E-04 -0.8311585225E+05 -0.6184955949E+00 0.5786563814E+01 0.3952352176E-04 0.4458124880E+05 0.3147966826E+00 -0.1043133579E+02 0.9635399060E-01 0.5270272858E+03 -0.7707686767E+03 -0.1667705527E+02 0.1899176344E+03 0.3735496947E+05 0.2764694386E+00 0.5786563814E+01 0.3952352176E-04 -0.8119784463E+05 -0.5841462296E+00 0.5536026212E+01 0.3652261299E-04 0.4383148053E+05 0.2993787903E+00 -0.9969705264E+01 0.9215005623E-01 0.5184913461E+03 -0.7582355720E+03 -0.1620898605E+02 0.1862646928E+03 0.3618687118E+05 0.2582529041E+00 0.5536026212E+01 0.3652261299E-04 -0.7926287846E+05 -0.5505285856E+00 0.5290881978E+01 0.3366248029E-04 0.4306510945E+05 0.2841117917E+00 -0.9521306010E+01 0.8806782813E-01 0.5099719815E+03 -0.7456275752E+03 -0.1576097199E+02 0.1825548733E+03 0.3501691637E+05 0.2406089095E+00 0.5290881978E+01 0.3366248029E-04 -0.7730676457E+05 -0.5176360623E+00 0.5051115749E+01 0.3094008723E-04 0.4227943640E+05 0.2689968705E+00 -0.9086693630E+01 0.8411382397E-01 0.5014970942E+03 -0.7329687303E+03 -0.1533187664E+02 0.1787791378E+03 0.3384650251E+05 0.2235484501E+00 0.5051115749E+01 0.3094008723E-04 -0.7533193663E+05 -0.4854990187E+00 0.4816629387E+01 0.2835231537E-04 0.4147549768E+05 0.2540538724E+00 -0.8666417899E+01 0.8029567520E-01 0.4930418022E+03 -0.7202305342E+03 -0.1492471321E+02 0.1749420263E+03 0.3267477033E+05 0.2070659136E+00 0.4816629387E+01 0.2835231537E-04 -0.7333571885E+05 -0.4541176680E+00 0.4587556978E+01 0.2589718642E-04 0.4065147676E+05 0.2392883896E+00 -0.8260923918E+01 0.7661881504E-01 0.4846040933E+03 -0.7074218771E+03 -0.1452276224E+02 0.1710358723E+03 0.3150108063E+05 0.1911573307E+00 0.4587556978E+01 0.2589718642E-04 -0.7131557883E+05 -0.4234934950E+00 0.4363805759E+01 0.2357090215E-04 0.3980548037E+05 0.2247056441E+00 -0.7870620357E+01 0.7308826104E-01 0.4761999648E+03 -0.6945537983E+03 -0.1412733831E+02 0.1670551513E+03 0.3032650595E+05 0.1758286380E+00 0.4363805759E+01 0.2357090215E-04 -0.6927350228E+05 -0.3936504669E+00 0.4145355624E+01 0.2137044079E-04 0.3893842182E+05 0.2103241486E+00 -0.7495604011E+01 0.6970575773E-01 0.4678031801E+03 -0.6815957844E+03 -0.1374055236E+02 0.1630023983E+03 0.2914978019E+05 0.1610712842E+00 0.4145355624E+01 0.2137044079E-04 -0.6720520062E+05 -0.3645807151E+00 0.3932185038E+01 0.1929229615E-04 0.3804727866E+05 0.1961441163E+00 -0.7136141740E+01 0.6647563504E-01 0.4594280460E+03 -0.6685710935E+03 -0.1334791704E+02 0.1588677633E+03 0.2797186456E+05 0.1468894461E+00 0.3932185038E+01 0.1929229615E-04 -0.6511235283E+05 -0.3363051589E+00 0.3724279192E+01 0.1733328492E-04 0.3713276869E+05 0.1821827721E+00 -0.6792233761E+01 0.6339786612E-01 0.4510492936E+03 -0.6554485658E+03 -0.1295260746E+02 0.1546531362E+03 0.2679159632E+05 0.1332755828E+00 0.3724279192E+01 0.1733328492E-04 -0.6299071324E+05 -0.3088180475E+00 0.3521621032E+01 0.1548980838E-04 0.3619180903E+05 0.1684414366E+00 -0.6463983068E+01 0.6047492851E-01 0.4426983902E+03 -0.6422514826E+03 -0.1255744214E+02 0.1503486802E+03 0.2560974010E+05 0.1202322013E+00 0.3521621032E+01 0.1548980838E-04 -0.6084152501E+05 -0.2821375048E+00 0.3324191563E+01 0.1375850288E-04 0.3522487822E+05 0.1549362095E+00 -0.6151554312E+01 0.5770867783E-01 0.4343343128E+03 -0.6289476861E+03 -0.1214967456E+02 0.1459552837E+03 0.2442526674E+05 0.1077532312E+00 0.3324191563E+01 0.1375850288E-04 -0.5866044827E+05 -0.2562599289E+00 0.3131969902E+01 0.1213569495E-04 0.3422866560E+05 0.1416690902E+00 -0.5854951379E+01 0.5510068693E-01 0.4259884829E+03 -0.6155595994E+03 -0.1173215499E+02 0.1414622385E+03 0.2323878627E+05 0.9584061636E-01 0.3131969902E+01 0.1213569495E-04 -0.5644826527E+05 -0.2312023600E+00 0.2944941179E+01 0.1061791862E-04 0.3320334345E+05 0.1286556577E+00 -0.5574279168E+01 0.5265210575E-01 0.4176364381E+03 -0.6020541975E+03 -0.1130875180E+02 0.1368695628E+03 0.2204923177E+05 0.8448946343E-01 0.2944941179E+01 0.1061791862E-04 -0.5420047589E+05 -0.2069642553E+00 0.2763089793E+01 0.9201459375E-05 0.3214547857E+05 0.1158997938E+00 -0.5309743262E+01 0.5036628635E-01 0.4092948746E+03 -0.5884529006E+03 -0.1086736011E+02 0.1321655258E+03 0.2085709109E+05 0.7370217123E-01 0.2763089793E+01 0.9201459375E-05 -0.5191724394E+05 -0.1835625023E+00 0.2586347913E+01 0.7882578667E-05 0.3105474701E+05 0.1034164701E+00 -0.5061446817E+01 0.4824519386E-01 0.4009382635E+03 -0.5747221678E+03 -0.1041077189E+02 0.1273496215E+03 0.1966159911E+05 0.6347726586E-01 0.2586347913E+01 0.7882578667E-05 -0.4959487780E+05 -0.1610043369E+00 0.2414795226E+01 0.6657926205E-05 0.2992822226E+05 0.9121416539E-01 -0.4829553929E+01 0.4629154458E-01 0.3925807320E+03 -0.5608675219E+03 -0.9938583985E+01 0.1224107520E+03 0.1846199304E+05 0.5381516903E-01 0.2414795226E+01 0.6657926205E-05 -0.4722935019E+05 -0.1393001290E+00 0.2248366327E+01 0.5523480046E-05 0.2876263982E+05 0.7930259731E-01 -0.4614632519E+01 0.4451236144E-01 0.3842270708E+03 -0.5468947629E+03 -0.9440625192E+01 0.1173380741E+03 0.1725841822E+05 0.4472097872E-01 0.2248366327E+01 0.5523480046E-05 -0.4481977260E+05 -0.1184709269E+00 0.2087045743E+01 0.4475592241E-05 0.2755696592E+05 0.6769819917E-01 -0.4417018408E+01 0.4291260630E-01 0.3758457088E+03 -0.5327665374E+03 -0.8913370226E+01 0.1121272394E+03 0.1604969236E+05 0.3619872127E-01 0.2087045743E+01 0.4475592241E-05 -0.4236025999E+05 -0.9853356031E-01 0.1930812812E+01 0.3506884410E-05 0.2630649784E+05 0.5641330957E-01 -0.4237383285E+01 0.4150107097E-01 0.3674600172E+03 -0.5184999800E+03 -0.8350802639E+01 0.1067621479E+03 0.1483552504E+05 0.2825480665E-01 0.1930812812E+01 0.3506884410E-05 -0.3984839719E+05 -0.7946941507E-01 0.1779652014E+01 0.2617728682E-05 0.2500911088E+05 0.4542338878E-01 -0.4076693616E+01 0.4029001461E-01 0.3590266051E+03 -0.5040535481E+03 -0.7736886169E+01 0.1012342160E+03 0.1361442016E+05 0.2090534695E-01 0.1779652014E+01 0.2617728682E-05 -0.3727701685E+05 -0.6136737270E-01 0.1633547368E+01 0.1803652202E-05 0.2365913380E+05 0.3480073221E-01 -0.3936254056E+01 0.3929581370E-01 0.3505628245E+03 -0.4894406648E+03 -0.7058848336E+01 0.9552355771E+02 0.1238552292E+05 0.1416993880E-01 0.1633547368E+01 0.1803652202E-05 -0.3464144044E+05 -0.4427115749E-01 0.1492480149E+01 0.1042940268E-05 0.2225274291E+05 0.2456996935E-01 -0.3818052415E+01 0.3854330625E-01 0.3420126036E+03 -0.4746133086E+03 -0.6286832824E+01 0.8961502177E+02 0.1114670144E+05 0.8061874330E-02 0.1492480149E+01 0.1042940268E-05 -0.3193177247E+05 -0.2798593375E-01 0.1356429721E+01 0.3497273281E-06 0.2078217467E+05 0.1452251599E-01 -0.3724983639E+01 0.3806800739E-01 0.3333720556E+03 -0.4595765232E+03 -0.5385044652E+01 0.8348019939E+02 0.9895967047E+04 0.2636714590E-02 0.1356429721E+01 0.3497273281E-06 -0.2913890027E+05 -0.1286943086E-01 0.1225349117E+01 0.1924030511E+05 0.4960714434E-02 -0.3661596433E+01 0.3792593186E-01 0.3245613871E+03 -0.4442695875E+03 -0.4297087613E+01 0.7709104271E+02 0.8629567670E+04 0.1225349117E+01 -0.2624631902E+05 -0.5143374852E-02 0.1099214488E+01 0.1761438158E+05 0.3089591871E+03 -0.3582405255E+03 0.7343203814E+04 0.1099214488E+01 -0.2323489744E+05 -0.5014841787E-02 0.9780225310E+00 0.1588957229E+05 0.3013042066E+03 -0.3493256799E+03 0.6029946712E+04 0.9780225310E+00 -0.2007311150E+05 -0.5034271706E-02 0.8491420621E+00 0.1477181586E-03 0.1404129465E+05 0.2936684497E+03 -0.3404305776E+03 0.4609065822E+04 0.2259661695E+01 0.8491420621E+00 0.1477181586E-03 -0.1482740119E+05 -0.4327037448E+01 0.1021744460E+05 0.2062385807E+01 -0.2108492739E+02 -0.4543278842E+01 0.5078696293E-01 0.3116660989E+03 -0.3790647605E+03 0.4748251403E+02 0.5064005522E+05 0.4576765380E+00 -0.5236868717E+05 -0.5616552930E+00 0.1723156682E+04 0.1777432651E-01 0.6031541744E+01 0.5854530759E-04 0.8215298735E+04 -0.6022333554E+04 0.5002148431E+05 0.4416772413E+00 0.1723156682E+04 0.1777432651E-01 -0.5342810450E+05 -0.5623089082E+00 0.1675470517E+04 0.1680161914E-01 0.7240671149E+01 0.6836531522E-04 -0.2996510079E+04 0.2751040886E+02 0.8138564103E+04 -0.6004200646E+04 0.4938943352E+05 0.4256269825E+00 0.1675470517E+04 0.1680161914E-01 -0.5270203427E+05 -0.5441924925E+00 0.1628041461E+04 0.1585789873E-01 0.8337735846E+01 0.7655483035E-04 -0.2917661582E+04 0.2682651759E+02 0.8050931467E+04 -0.5992889403E+04 0.4874560738E+05 0.4095971069E+00 0.1628041461E+04 0.1585789873E-01 -0.5196465540E+05 -0.5261534053E+00 0.1580868761E+04 0.1494339322E-01 0.9388046349E+01 0.8379054050E-04 -0.2836228399E+04 0.2611068907E+02 0.7960693728E+04 -0.5981523826E+04 0.4808742866E+05 0.3935962768E+00 0.1580868761E+04 0.1494339322E-01 -0.5121336868E+05 -0.5082011107E+00 0.1533953234E+04 0.1405823808E-01 0.1036955137E+02 0.8991646072E-04 -0.2752904179E+04 0.2537011060E+02 0.7868579659E+04 -0.5970152137E+04 0.4741647678E+05 0.3776580216E+00 0.1533953234E+04 0.1405823808E-01 -0.5044973433E+05 -0.4903685497E+00 0.1487293709E+04 0.1320241348E-01 0.1126341373E+02 0.9482262896E-04 -0.2668357786E+04 0.2461309063E+02 0.7775222226E+04 -0.5958741110E+04 0.4673011786E+05 0.3617874432E+00 0.1487293709E+04 0.1320241348E-01 -0.4967117446E+05 -0.4726618568E+00 0.1440890320E+04 0.1237584927E-01 0.1212666279E+02 0.9903724096E-04 -0.2583249163E+04 0.2384646024E+02 0.7681316704E+04 -0.5947338746E+04 0.4602990551E+05 0.3460146536E+00 0.1440890320E+04 0.1237584927E-01 -0.4887922008E+05 -0.4551101503E+00 0.1394741673E+04 0.1157836840E-01 0.1293795143E+02 0.1024079467E-03 -0.2498009654E+04 0.2307575558E+02 0.7587258703E+04 -0.5935909152E+04 0.4531314892E+05 0.3303424131E+00 0.1394741673E+04 0.1157836840E-01 -0.4807115975E+05 -0.4377162696E+00 0.1348847402E+04 0.1080974485E-01 0.1367841043E+02 0.1048226632E-03 -0.2413071221E+04 0.2230544280E+02 0.7493515667E+04 -0.5924498061E+04 0.4458124880E+05 0.3147966826E+00 0.1348847402E+04 0.1080974485E-01 -0.4724844345E+05 -0.4205054929E+00 0.1303206173E+04 0.1006968972E-01 0.1439901847E+02 0.1067077431E-03 -0.2328847267E+04 0.2154068107E+02 0.7400465420E+04 -0.5913069303E+04 0.4383148053E+05 0.2993787903E+00 0.1303206173E+04 0.1006968972E-01 -0.4640830192E+05 -0.4034788379E+00 0.1257817245E+04 0.9357883724E-02 0.1505719747E+02 0.1077667701E-03 -0.2245577119E+04 0.2078400930E+02 0.7308382912E+04 -0.5901666775E+04 0.4306510945E+05 0.2841117917E+00 0.1257817245E+04 0.9357883724E-02 -0.4555204408E+05 -0.3866584453E+00 0.1212676996E+04 0.8673951454E-02 0.1570091037E+02 0.1083738439E-03 -0.2163550146E+04 0.2003902499E+02 0.7217522050E+04 -0.5890252822E+04 0.4227943640E+05 0.2689968705E+00 0.1212676996E+04 0.8673951454E-02 -0.4467695057E+05 -0.3700449557E+00 0.1167788778E+04 0.8017555313E-02 0.1631020737E+02 0.1084016087E-03 -0.2082916311E+04 0.1930730731E+02 0.7128050762E+04 -0.5878849801E+04 0.4147549768E+05 0.2540538724E+00 0.1167788778E+04 0.8017555313E-02 -0.4378403970E+05 -0.3536576618E+00 0.1123148985E+04 0.7388275629E-02 0.1686734045E+02 0.1077574316E-03 -0.2003841489E+04 0.1859105156E+02 0.7040152943E+04 -0.5867480720E+04 0.4065147676E+05 0.2392883896E+00 0.1123148985E+04 0.7388275629E-02 -0.4287153333E+05 -0.3375010356E+00 0.1078756324E+04 0.6785704803E-02 0.1741564057E+02 0.1067428431E-03 -0.1926493623E+04 0.1789213647E+02 0.6953961247E+04 -0.5856106317E+04 0.3980548037E+05 0.2247056441E+00 0.1078756324E+04 0.6785704803E-02 -0.4193751696E+05 -0.3215799688E+00 0.1034609557E+04 0.6209434854E-02 0.1793637231E+02 0.1052486245E-03 -0.1850946096E+04 0.1721149329E+02 0.6869585012E+04 -0.5844769095E+04 0.3893842182E+05 0.2103241486E+00 0.1034609557E+04 0.6209434854E-02 -0.4098288415E+05 -0.3059114648E+00 0.9907073361E+03 0.5659040146E-02 0.1841239179E+02 0.1031935902E-03 -0.1777292026E+04 0.1655031426E+02 0.6787082178E+04 -0.5833429178E+04 0.3804727866E+05 0.1961441163E+00 0.9907073361E+03 0.5659040146E-02 -0.4000464978E+05 -0.2904957360E+00 0.9470481529E+03 0.5134107654E-02 0.1888388327E+02 0.1008213677E-03 -0.1705636338E+04 0.1590993011E+02 0.6706593792E+04 -0.5822129572E+04 0.3713276869E+05 0.1821827721E+00 0.9470481529E+03 0.5134107654E-02 -0.3900351097E+05 -0.2753484886E+00 0.9036307378E+03 0.4634222134E-02 0.1933292123E+02 0.9803591150E-04 -0.1636019481E+04 0.1529084603E+02 0.6628125280E+04 -0.5810829815E+04 0.3619180903E+05 0.1684414366E+00 0.9036307378E+03 0.4634222134E-02 -0.3797636594E+05 -0.2604707466E+00 0.8604536386E+03 0.4158977514E-02 0.1974335762E+02 0.9476753332E-04 -0.1568501998E+04 0.1469390924E+02 0.6551773496E+04 -0.5799572556E+04 0.3522487822E+05 0.1549362095E+00 0.8604536386E+03 0.4158977514E-02 -0.3692372738E+05 -0.2458773995E+00 0.8175156394E+03 0.3707977417E-02 0.2015199562E+02 0.9120325409E-04 -0.1503156950E+04 0.1411999312E+02 0.6477576697E+04 -0.5788317838E+04 0.3422866560E+05 0.1416690902E+00 0.8175156394E+03 0.3707977417E-02 -0.3584226500E+05 -0.2315701818E+00 0.7748151093E+03 0.3280843152E-02 0.2054204764E+02 0.8725867080E-04 -0.1440013150E+04 0.1356964664E+02 0.6405600274E+04 -0.5777108184E+04 0.3320334345E+05 0.1286556577E+00 0.7748151093E+03 0.3280843152E-02 -0.3473213106E+05 -0.2175632645E+00 0.7323492554E+03 0.2877203884E-02 0.2089794029E+02 0.8287001548E-04 -0.1379116322E+04 0.1304341081E+02 0.6335855434E+04 -0.5765903492E+04 0.3214547857E+05 0.1158997938E+00 0.7323492554E+03 0.2877203884E-02 -0.3358992556E+05 -0.2038602697E+00 0.6901194246E+03 0.2496737212E-02 0.2125428748E+02 0.7817356283E-04 -0.1320521526E+04 0.1254203174E+02 0.6268416389E+04 -0.5754726049E+04 0.3105474701E+05 0.1034164701E+00 0.6901194246E+03 0.2496737212E-02 -0.3241530681E+05 -0.1904757517E+00 0.6481226735E+03 0.2139131772E-02 0.2159497492E+02 0.7308863119E-04 -0.1264249967E+04 0.1206591393E+02 0.6203323739E+04 -0.5743597961E+04 0.2992822226E+05 0.9121416539E-01 0.6481226735E+03 0.2139131772E-02 -0.3120532916E+05 -0.1774169529E+00 0.6063574354E+03 0.1804119997E-02 0.2190533891E+02 0.6755238978E-04 -0.1210333382E+04 0.1161551450E+02 0.6140575450E+04 -0.5732479520E+04 0.2876263982E+05 0.7930259731E-01 0.6063574354E+03 0.1804119997E-02 -0.2995675679E+05 -0.1646937820E+00 0.5648220359E+03 0.1491487378E-02 0.2221733921E+02 0.6164353924E-04 -0.1158809487E+04 0.1119135930E+02 0.6080247175E+04 -0.5721414102E+04 0.2755696592E+05 0.6769819917E-01 0.5648220359E+03 0.1491487378E-02 -0.2866853724E+05 -0.1523216304E+00 0.5235145725E+03 0.1201087575E-02 0.2251583366E+02 0.5527568784E-04 -0.1109683529E+04 0.1079369978E+02 0.6022311256E+04 -0.5710362352E+04 0.2630649784E+05 0.5641330957E-01 0.5235145725E+03 0.1201087575E-02 -0.2733594975E+05 -0.1403132845E+00 0.4824331335E+03 0.9329967874E-03 0.2278660683E+02 0.4837201090E-04 -0.1062964682E+04 0.1042272475E+02 0.5966815944E+04 -0.5699368041E+04 0.2500911088E+05 0.4542338878E-01 0.4824331335E+03 0.9329967874E-03 -0.2595689554E+05 -0.1286435329E+00 0.4415752542E+03 0.6870491202E-03 0.2305995311E+02 0.4094047979E-04 -0.1018658087E+04 0.1007867675E+02 0.5913734948E+04 -0.5688392757E+04 0.2365913380E+05 0.3480073221E-01 0.4415752542E+03 0.6870491202E-03 -0.2452566941E+05 -0.1173852053E+00 0.4009381574E+03 0.4634948564E-03 0.2330714506E+02 0.3284189186E-04 -0.9767319715E+03 0.9761268558E+01 0.5863077567E+04 -0.5677481079E+04 0.2225274291E+05 0.2456996935E-01 0.4009381574E+03 0.4634948564E-03 -0.2303846943E+05 -0.1065633913E+00 0.3605177844E+03 0.2632002922E-03 0.2355679342E+02 0.2401131613E-04 -0.9371512668E+03 0.9470343450E+01 0.5814779987E+04 -0.5666595925E+04 0.2078217467E+05 0.1452251599E-01 0.3605177844E+03 0.2632002922E-03 -0.2148750850E+05 -0.9597069205E-01 0.3203088103E+03 0.8604001561E-04 0.2379471349E+02 0.1427514157E-04 -0.8998393215E+03 0.9205093390E+01 0.5768810452E+04 -0.5655783814E+04 0.1924030511E+05 0.4960714434E-02 0.3203088103E+03 0.8604001561E-04 -0.1986563001E+05 -0.8597648424E-01 0.2802972706E+03 0.2400755527E+02 0.3425735382E-05 -0.8646999024E+03 0.8964712416E+01 0.5725049514E+04 -0.5645010580E+04 0.1761438158E+05 0.2802972706E+03 -0.1816008010E+05 -0.8076825562E-01 0.2404701291E+03 0.2422109402E+02 0.4851817578E+04 -0.5625579835E+04 0.1588957229E+05 0.2404701291E+03 -0.1635597226E+05 -0.8072842788E-01 0.2007997980E+03 0.1185040296E-03 0.2442123941E+02 0.4843365598E+04 -0.5615156137E+04 0.1404129465E+05 0.2007997980E+03 0.1185040296E-03 -0.1440440527E+05 -0.3960478729E+00 0.1370084946E+03 0.3154465295E+00 0.2459478708E+02 -0.7714653959E+03 0.8386127659E+01 0.5606518652E+04 -0.5613208481E+04 0.1021744460E+05 0.2062385807E+01 0.1370084946E+03 0.3154465295E+00 -0.1037987775E+05 -0.2521061201E+01 0.2476048491E+02 0.4847768201E-01 -0.2218339831E+02 -0.7818543661E+03 0.6186479152E+02 0.5631194603E+04 -0.5656784620E+04 0.1541355934E+00 0.6031541744E+01 0.5854530759E-04 -0.1203772281E+02 -0.3677502306E-02 0.2036022472E-02 0.1922381437E-07 0.5972951535E+01 0.5435117613E-04 -0.2364422108E+02 0.2427001799E+00 0.2368457293E+03 -0.2480351013E+03 0.7240671149E+01 0.6836531522E-04 0.2036022472E-02 0.1922381437E-07 -0.1443642734E+02 -0.3824835119E-02 0.2571766778E-02 0.2361326540E-07 0.7158825725E+01 0.6327989759E-04 -0.2789020645E+02 0.2858619184E+00 -0.3401450254E-02 0.3093748717E-04 0.2488114385E+03 -0.2570290219E+03 0.8337735846E+01 0.7655483035E-04 0.2571766778E-02 0.2361326540E-07 -0.1660823651E+02 -0.3969038833E-02 0.3135129689E-02 0.2798177613E-07 0.8231341617E+01 0.7071671235E-04 -0.3126414941E+02 0.3195853108E+00 -0.4215438174E-02 0.3819203882E-04 0.2599044690E+03 -0.2660147395E+03 0.9388046349E+01 0.8379054050E-04 0.3135129689E-02 0.2798177613E-07 -0.1868448009E+02 -0.4111438404E-02 0.3734099177E-02 0.3237912325E-07 0.9254982594E+01 0.7729503802E-04 -0.3399548866E+02 0.3461737353E+00 -0.5058321856E-02 0.4568548109E-04 0.2703569134E+03 -0.2749946057E+03 0.1036955137E+02 0.8991646072E-04 0.3734099177E-02 0.3237912325E-07 -0.2062197854E+02 -0.4251799466E-02 0.4358547812E-02 0.3669304635E-07 0.1020862200E+02 0.8287712983E-04 -0.3603364022E+02 0.3651300387E+00 -0.5956215137E-02 0.5368568944E-04 0.2801218405E+03 -0.2839723007E+03 0.1126341373E+02 0.9482262896E-04 0.4358547812E-02 0.3669304635E-07 -0.2238407840E+02 -0.4389793736E-02 0.5011604663E-02 0.4092927355E-07 0.1107445160E+02 0.8736362012E-04 -0.3737572380E+02 0.3764917089E+00 -0.6898801206E-02 0.6211757841E-04 0.2891893130E+03 -0.2929396409E+03 0.1212666279E+02 0.9903724096E-04 0.5011604663E-02 0.4092927355E-07 -0.2408345241E+02 -0.4526485356E-02 0.5700647521E-02 0.4512241451E-07 0.1190810371E+02 0.9123099807E-04 -0.3827297059E+02 0.3828613404E+00 -0.7891102467E-02 0.7102579053E-04 0.2978141679E+03 -0.3019033893E+03 0.1293795143E+02 0.1024079467E-03 0.5700647521E-02 0.4512241451E-07 -0.2567827581E+02 -0.4661578658E-02 0.6414586557E-02 0.4915732346E-07 0.1268910443E+02 0.9433603617E-04 -0.3872236989E+02 0.3842938874E+00 -0.8952354740E-02 0.8060654343E-04 0.3059934659E+03 -0.3108636345E+03 0.1367841043E+02 0.1048226632E-03 0.6414586557E-02 0.4915732346E-07 -0.2713177592E+02 -0.4794855118E-02 0.7157293758E-02 0.5304102258E-07 0.1339955748E+02 0.9657239919E-04 -0.3874122255E+02 0.3810680921E+00 -0.1006714903E-01 0.9072611383E-04 0.3137445390E+03 -0.3198206852E+03 0.1439901847E+02 0.1067077431E-03 0.7157293758E-02 0.5304102258E-07 -0.2854416825E+02 -0.4927121672E-02 0.7930650608E-02 0.5676093461E-07 0.1408869395E+02 0.9832068453E-04 -0.3853118785E+02 0.3752567681E+00 -0.1123808235E-01 0.1014027613E-03 0.3212690763E+03 -0.3287766316E+03 0.1505719747E+02 0.1077667701E-03 0.7930650608E-02 0.5676093461E-07 -0.2983213366E+02 -0.5057869271E-02 0.8732735937E-02 0.6027676987E-07 0.1471577228E+02 0.9930887924E-04 -0.3803351775E+02 0.3663812133E+00 -0.1247526919E-01 0.1127461432E-03 0.3285119369E+03 -0.3377351530E+03 0.1570091037E+02 0.1083738439E-03 0.8732735937E-02 0.6027676987E-07 -0.3108967868E+02 -0.5187687185E-02 0.9571040294E-02 0.6361146374E-07 0.1532683155E+02 0.9987103522E-04 -0.3741134668E+02 0.3560899975E+00 -0.1377026851E-01 0.1246703035E-03 0.3356291501E+03 -0.3466896446E+03 0.1631020737E+02 0.1084016087E-03 0.9571040294E-02 0.6361146374E-07 -0.3227778177E+02 -0.5316389651E-02 0.1043300225E-01 0.6665149904E-07 0.1590280453E+02 0.9988940373E-04 -0.3665144339E+02 0.3443244512E+00 -0.1514121944E-01 0.1373554923E-03 0.3426110907E+03 -0.3556441998E+03 0.1686734045E+02 0.1077574316E-03 0.1043300225E-01 0.6665149904E-07 -0.3336188427E+02 -0.5443798905E-02 0.1132352858E-01 0.6940345547E-07 0.1642688827E+02 0.9927896261E-04 -0.3574980851E+02 0.3311235990E+00 -0.1656994315E-01 0.1506452322E-03 0.3494537688E+03 -0.3645988752E+03 0.1741564057E+02 0.1067428431E-03 0.1132352858E-01 0.6940345547E-07 -0.3442652822E+02 -0.5570486466E-02 0.1225046225E-01 0.7188434087E-07 0.1694028106E+02 0.9830967714E-04 -0.3481852750E+02 0.3175724328E+00 -0.1806149021E-01 0.1645799435E-03 0.3562692946E+03 -0.3735547684E+03 0.1793637231E+02 0.1052486245E-03 0.1225046225E-01 0.7188434087E-07 -0.3543510286E+02 -0.5696244248E-02 0.1320034518E-01 0.7398229550E-07 0.1742511321E+02 0.9688277296E-04 -0.3383592323E+02 0.3035118899E+00 -0.1963721033E-01 0.1793780997E-03 0.3630360440E+03 -0.3825117409E+03 0.1841239179E+02 0.1031935902E-03 0.1320034518E-01 0.7398229550E-07 -0.3635423430E+02 -0.5820977945E-02 0.1417857967E-01 0.7569967331E-07 0.1786516220E+02 0.9492579817E-04 -0.3278754076E+02 0.2888605006E+00 -0.2128058572E-01 0.1949049795E-03 0.3697431425E+03 -0.3914738690E+03 0.1888388327E+02 0.1008213677E-03 0.1417857967E-01 0.7569967331E-07 -0.3726193120E+02 -0.5945030742E-02 0.1519326925E-01 0.7704402156E-07 0.1829823998E+02 0.9265717921E-04 -0.3175083366E+02 0.2743181666E+00 -0.2300156141E-01 0.2112576252E-03 0.3764609636E+03 -0.4004336033E+03 0.1933292123E+02 0.9803591150E-04 0.1519326925E-01 0.7704402156E-07 -0.3812314833E+02 -0.6068280603E-02 0.1623003329E-01 0.7790368035E-07 0.1870723260E+02 0.8999158983E-04 -0.3070051024E+02 0.2596821015E+00 -0.2482761591E-01 0.2287265241E-03 0.3831678535E+03 -0.4093949081E+03 0.1974335762E+02 0.9476753332E-04 0.1623003329E-01 0.7790368035E-07 -0.3890641921E+02 -0.6190596904E-02 0.1729485784E-01 0.7827251174E-07 0.1907682999E+02 0.8686821074E-04 -0.2961873073E+02 0.2448272846E+00 -0.2674686690E-01 0.2472347957E-03 0.3898460197E+03 -0.4183576962E+03 0.2015199562E+02 0.9120325409E-04 0.1729485784E-01 0.7827251174E-07 -0.3968268433E+02 -0.6312333666E-02 0.1839628078E-01 0.7814386553E-07 0.1944115494E+02 0.8345405252E-04 -0.2855984412E+02 0.2302020165E+00 -0.2877843775E-01 0.2669853436E-03 0.3965498957E+03 -0.4273224582E+03 0.2054204764E+02 0.8725867080E-04 0.1839628078E-01 0.7814386553E-07 -0.4041900373E+02 -0.6433332221E-02 0.1951900915E-01 0.7740191467E-07 0.1978406183E+02 0.7967497551E-04 -0.2750069278E+02 0.2156224848E+00 -0.3096100812E-01 0.2884026027E-03 0.4032564505E+03 -0.4362890671E+03 0.2089794029E+02 0.8287001548E-04 0.1951900915E-01 0.7740191467E-07 -0.4108485073E+02 -0.6553533001E-02 0.2066942863E-01 0.7602244393E-07 0.2009060573E+02 0.7547586610E-04 -0.2642485883E+02 0.2009789174E+00 -0.3329317384E-01 0.3115368379E-03 0.4099529382E+03 -0.4452616204E+03 0.2125428748E+02 0.7817356283E-04 0.2066942863E-01 0.7602244393E-07 -0.4174622938E+02 -0.6673073676E-02 0.2185632644E-01 0.7397318072E-07 0.2039216263E+02 0.7097707513E-04 -0.2537453497E+02 0.1865876157E+00 -0.3581079174E-01 0.3367893276E-03 0.4166745847E+03 -0.4542322420E+03 0.2159497492E+02 0.7308863119E-04 0.2185632644E-01 0.7397318072E-07 -0.4237111978E+02 -0.6791862160E-02 0.2306345747E-01 0.7112383312E-07 0.2067283382E+02 0.6610791021E-04 -0.2433257386E+02 0.1723321118E+00 -0.3857390673E-01 0.3648390065E-03 0.4234080313E+03 -0.4632050588E+03 0.2190533891E+02 0.6755238978E-04 0.2306345747E-01 0.7112383312E-07 -0.4293018450E+02 -0.6909781016E-02 0.2429772347E-01 0.6741570879E-07 0.2091795489E+02 0.6081395739E-04 -0.2328949463E+02 0.1581803386E+00 -0.4160438578E-01 0.3960202422E-03 0.4301440219E+03 -0.4721801696E+03 0.2221733921E+02 0.6164353924E-04 0.2429772347E-01 0.6741570879E-07 -0.4348294312E+02 -0.7026976357E-02 0.2556832631E-01 0.6276946459E-07 0.2115506952E+02 0.5516275918E-04 -0.2228344434E+02 0.1444133316E+00 -0.4497362170E-01 0.4311561654E-03 0.4369210221E+03 -0.4811580155E+03 0.2251583366E+02 0.5527568784E-04 0.2556832631E-01 0.6276946459E-07 -0.4399797623E+02 -0.7143285981E-02 0.2685802902E-01 0.5701493347E-07 0.2136790845E+02 0.4907875844E-04 -0.2130975258E+02 0.1310585011E+00 -0.4878893075E-01 0.4714952257E-03 0.4437347841E+03 -0.4901388281E+03 0.2278660683E+02 0.4837201090E-04 0.2685802902E-01 0.5701493347E-07 -0.4444497362E+02 -0.7258626221E-02 0.2817397812E-01 0.5001988409E-07 0.2154038639E+02 0.4249595546E-04 -0.2037325855E+02 0.1182503126E+00 -0.5312950657E-01 0.5180612036E-03 0.4505941927E+03 -0.4991271389E+03 0.2305995311E+02 0.4094047979E-04 0.2817397812E-01 0.5001988409E-07 -0.4487655916E+02 -0.7372891267E-02 0.2951668577E-01 0.4159170073E-07 0.2169482614E+02 0.3541981218E-04 -0.1952118181E+02 0.1063880472E+00 -0.5815183584E-01 0.5727077981E-03 0.4575399875E+03 -0.5081153921E+03 0.2330714506E+02 0.3284189186E-04 0.2951668577E-01 0.4159170073E-07 -0.4523091993E+02 -0.7485886548E-02 0.3088462558E-01 0.3148053707E-07 0.2179814262E+02 0.2773594035E-04 -0.1876287217E+02 0.9573994097E-01 -0.6406582972E-01 0.6379494066E-03 0.4645859491E+03 -0.5171084182E+03 0.2355679342E+02 0.2401131613E-04 0.3088462558E-01 0.3148053707E-07 -0.4554999001E+02 -0.7597497526E-02 0.3228717540E-01 0.1937001679E-07 0.2186365117E+02 0.1939533940E-04 -0.1816154832E+02 0.8690566732E-01 -0.7114058760E-01 0.7170423409E-03 0.4717964089E+03 -0.5261073635E+03 0.2379471349E+02 0.1427514157E-04 0.3228717540E-01 0.1937001679E-07 -0.4578680464E+02 -0.7707426890E-02 0.3370486689E-01 0.4809484089E-08 0.2185858164E+02 0.1027499323E-04 -0.1776098913E+02 0.8048840574E-01 -0.7979853812E-01 0.8150273122E-03 0.4792166953E+03 -0.5351135622E+03 0.2400755527E+02 0.3425735382E-05 0.3370486689E-01 0.4809484089E-08 -0.4587993138E+02 -0.7815374973E-02 0.3514370637E-01 0.2173486481E+02 0.2711859897E-06 -0.1761253506E+02 0.7718334409E-01 -0.9056150781E-01 0.9383058538E-03 0.4869001909E+03 -0.5441286949E+03 0.2422109402E+02 0.3514370637E-01 -0.4580025806E+02 -0.7940502106E-02 0.3661290261E-01 0.2143759773E+02 0.4770293728E+03 -0.5530760320E+03 0.2442123941E+02 0.3661290261E-01 -0.4533639058E+02 -0.8069398559E-02 0.3809077853E-01 0.2076948809E+02 0.4848792456E+03 -0.5621146642E+03 0.2459478708E+02 0.3809077853E-01 -0.4386517907E+02 -0.8198243656E-02 0.3957560803E-01 0.1912061422E+02 0.4927435844E+03 -0.5711607713E+03 0.2476048491E+02 0.4847768201E-01 0.3957560803E-01 -0.3771752825E+02 -0.5680483737E-01 0.1284419871E+02 0.5006445176E+03 -0.5802304490E+03 0.5972951535E+01 0.5435117613E-04 -0.7732369319E+03 -0.5694184199E-01 0.1108039409E+02 0.9794430404E-04 0.7557552390E+03 0.6882909885E-02 -0.2232697457E+02 0.2181273073E+00 0.3027958916E+04 -0.3476688120E+04 0.6553478020E+01 0.7158825725E+01 0.6327989759E-04 0.1108039409E+02 0.9794430404E-04 -0.7774248075E+03 -0.5584801741E-01 0.1056679315E+02 0.9078093300E-04 0.7481900295E+03 0.6619209181E-02 -0.2652813026E+02 0.2595987349E+00 -0.1815224254E+02 0.1654563199E+00 0.2975144362E+04 -0.3412059534E+04 0.6411633473E+01 0.8231341617E+01 0.7071671235E-04 0.1056679315E+02 0.9078093300E-04 -0.7696998277E+03 -0.5465890801E-01 0.1006569212E+02 0.8406585825E-04 0.7404153255E+03 0.6366431265E-02 -0.2985736657E+02 0.2920124378E+00 -0.1649157073E+02 0.1485397046E+00 0.2921505494E+04 -0.3347458840E+04 0.6280177400E+01 0.9254982594E+01 0.7729503802E-04 0.1006569212E+02 0.8406585825E-04 -0.7617219882E+03 -0.5347816160E-01 0.9576996288E+01 0.7774937349E-04 0.7324117357E+03 0.6122086061E-02 -0.3254680771E+02 0.3175880363E+00 -0.1512657454E+02 0.1349393197E+00 0.2867496784E+04 -0.3282842558E+04 0.6153288371E+01 0.1020862200E+02 0.8287712983E-04 0.9576996288E+01 0.7774937349E-04 -0.7534532217E+03 -0.5230346838E-01 0.9100562359E+01 0.7179209423E-04 0.7241625558E+03 0.5883971530E-02 -0.3454597731E+02 0.3358408336E+00 -0.1400502152E+02 0.1240610661E+00 0.2813026009E+04 -0.3218220621E+04 0.6031530759E+01 0.1107445160E+02 0.8736362012E-04 0.9100562359E+01 0.7179209423E-04 -0.7448509457E+03 -0.5113262269E-01 0.8636264287E+01 0.6616460769E-04 0.7156432824E+03 0.5650287913E-02 -0.3585208826E+02 0.3468092693E+00 -0.1306973407E+02 0.1152619279E+00 0.2758021591E+04 -0.3153577612E+04 0.5914932497E+01 0.1190810371E+02 0.9123099807E-04 0.8636264287E+01 0.6616460769E-04 -0.7359537490E+03 -0.4996493259E-01 0.8184079918E+01 0.6084382576E-04 0.7068370190E+03 0.5419800274E-02 -0.3671633745E+02 0.3530210793E+00 -0.1226749825E+02 0.1079294760E+00 0.2702690508E+04 -0.3088922304E+04 0.5800870690E+01 0.1268910443E+02 0.9433603617E-04 0.8184079918E+01 0.6084382576E-04 -0.7267209948E+03 -0.4879920440E-01 0.7743977036E+01 0.5581187608E-04 0.6977236567E+03 0.5191499169E-02 -0.3713579997E+02 0.3545422936E+00 -0.1156948738E+02 0.1017401517E+00 0.2647002488E+04 -0.3024255381E+04 0.5689330337E+01 0.1339955748E+02 0.9657239919E-04 0.7743977036E+01 0.5581187608E-04 -0.7171185097E+03 -0.4763461885E-01 0.7315883438E+01 0.5105531216E-04 0.6882870228E+03 0.4964702876E-02 -0.3712781210E+02 0.3516521184E+00 -0.1094703771E+02 0.9636304100E-01 0.2590947272E+04 -0.2959577281E+04 0.5580108757E+01 0.1408869395E+02 0.9832068453E-04 0.7315883438E+01 0.5105531216E-04 -0.7071641534E+03 -0.4647105650E-01 0.6899743264E+01 0.4656267829E-04 0.6784958738E+03 0.4738936312E-02 -0.3689405440E+02 0.3463744165E+00 -0.1037399233E+02 0.9150090654E-01 0.2534701016E+04 -0.2894887820E+04 0.5470887585E+01 0.1471577228E+02 0.9930887924E-04 0.6899743264E+01 0.4656267829E-04 -0.6967964757E+03 -0.4530806153E-01 0.6495541043E+01 0.4232553913E-04 0.6683295713E+03 0.4513916622E-02 -0.3637587039E+02 0.3382480645E+00 -0.9840576918E+01 0.8704030375E-01 0.2478202907E+04 -0.2830195545E+04 0.5362197660E+01 0.1532683155E+02 0.9987103522E-04 0.6495541043E+01 0.4232553913E-04 -0.6860404060E+03 -0.4414565651E-01 0.6103232457E+01 0.3833589540E-04 0.6577670674E+03 0.4289586545E-02 -0.3573647868E+02 0.3288871403E+00 -0.9331330059E+01 0.8280561384E-01 0.2421586671E+04 -0.2765483608E+04 0.5252154260E+01 0.1590280453E+02 0.9988940373E-04 0.6103232457E+01 0.3833589540E-04 -0.6748477925E+03 -0.4298377752E-01 0.5722824041E+01 0.3458695431E-04 0.6467793143E+03 0.4065895808E-02 -0.3496277470E+02 0.3182369552E+00 -0.8842819751E+01 0.7875562549E-01 0.2364843052E+04 -0.2700760272E+04 0.5140742045E+01 0.1642688827E+02 0.9927896261E-04 0.5722824041E+01 0.3458695431E-04 -0.6631777433E+03 -0.4182241099E-01 0.5354259127E+01 0.3107241753E-04 0.6353422731E+03 0.3842928974E-02 -0.3405085833E+02 0.3063316135E+00 -0.8370002880E+01 0.7483375833E-01 0.2307963164E+04 -0.2636025449E+04 0.5027858095E+01 0.1694028106E+02 0.9830967714E-04 0.5354259127E+01 0.3107241753E-04 -0.6510291796E+03 -0.4066191508E-01 0.4997488898E+01 0.2778579264E-04 0.6234137723E+03 0.3620787030E-02 -0.3311291861E+02 0.2942390425E+00 -0.7907460029E+01 0.7097705564E-01 0.2251053718E+04 -0.2571278591E+04 0.4911988155E+01 0.1742511321E+02 0.9688277296E-04 0.4997488898E+01 0.2778579264E-04 -0.6383542393E+03 -0.3950236973E-01 0.4652515865E+01 0.2472095003E-04 0.6109638657E+03 0.3399661311E-02 -0.3212746214E+02 0.2818004564E+00 -0.7456464589E+01 0.6720044889E-01 0.2194094465E+04 -0.2506519581E+04 0.4793176207E+01 0.1786516220E+02 0.9492579817E-04 0.4652515865E+01 0.2472095003E-04 -0.6250961979E+03 -0.3834399345E-01 0.4319304008E+01 0.2187174974E-04 0.5979520838E+03 0.3179736168E-02 -0.3108013857E+02 0.2689250575E+00 -0.7016434803E+01 0.6349761767E-01 0.2137077551E+04 -0.2441756461E+04 0.4671318825E+01 0.1829823998E+02 0.9265717921E-04 0.4319304008E+01 0.2187174974E-04 -0.6112542924E+03 -0.3718703273E-01 0.3997816414E+01 0.1923159147E-04 0.5843399268E+03 0.2961290196E-02 -0.3004856596E+02 0.2563126775E+00 -0.6585808720E+01 0.5985109854E-01 0.2080064693E+04 -0.2376972189E+04 0.4545292116E+01 0.1870723260E+02 0.8999158983E-04 0.3997816414E+01 0.1923159147E-04 -0.5967624471E+03 -0.3603173308E-01 0.3688052927E+01 0.1679390963E-04 0.5700784689E+03 0.2744548514E-02 -0.2900762792E+02 0.2437555121E+00 -0.6166993759E+01 0.5628873955E-01 0.2023040281E+04 -0.2312174786E+04 0.4415041416E+01 0.1907682999E+02 0.8686821074E-04 0.3688052927E+01 0.1679390963E-04 -0.5815588910E+03 -0.3487830052E-01 0.3389959135E+01 0.1455190438E-04 0.5551213037E+03 0.2529791328E-02 -0.2793960346E+02 0.2311175203E+00 -0.5760661206E+01 0.5281881990E-01 0.1965987259E+04 -0.2247364030E+04 0.4280476827E+01 0.1944115494E+02 0.8345405252E-04 0.3389959135E+01 0.1455190438E-04 -0.5656076824E+03 -0.3372713327E-01 0.3103488921E+01 0.1249846497E-04 0.5393984673E+03 0.2317263776E-02 -0.2689896362E+02 0.2188582603E+00 -0.5366433146E+01 0.4943730956E-01 0.1908959711E+04 -0.2182539272E+04 0.4140496616E+01 0.1978406183E+02 0.7967497551E-04 0.3103488921E+01 0.1249846497E-04 -0.5488333388E+03 -0.3257845992E-01 0.2828635697E+01 0.1062654516E-04 0.5228506755E+03 0.2107282754E-02 -0.2586272689E+02 0.2067869013E+00 -0.4986286909E+01 0.4616809110E-01 0.1851936696E+04 -0.2117700248E+04 0.3994965228E+01 0.2009060573E+02 0.7547586610E-04 0.2828635697E+01 0.1062654516E-04 -0.5311458126E+03 -0.3143263980E-01 0.2565362116E+01 0.8929013707E-05 0.5054028686E+03 0.1900157983E-02 -0.2481454560E+02 0.1947783333E+00 -0.4620831440E+01 0.4301836531E-01 0.1794909710E+04 -0.2052854869E+04 0.3843565891E+01 0.2039216263E+02 0.7097707513E-04 0.2565362116E+01 0.8929013707E-05 -0.5124978943E+03 -0.3028993362E-01 0.2313649569E+01 0.7398624654E-05 0.4869765190E+03 0.1696282023E-02 -0.2379672236E+02 0.1831739235E+00 -0.4269798295E+01 0.3998570490E-01 0.1737906646E+04 -0.1987985984E+04 0.3685282268E+01 0.2067283382E+02 0.6610791021E-04 0.2313649569E+01 0.7398624654E-05 -0.4927851822E+03 -0.2915079373E-01 0.2073448828E+01 0.6028057205E-05 0.4674831904E+03 0.1496073570E-02 -0.2279221390E+02 0.1718467995E+00 -0.3934329765E+01 0.3708386260E-01 0.1680918938E+04 -0.1923101491E+04 0.3519718816E+01 0.2091795489E+02 0.6081395739E-04 0.2073448828E+01 0.6028057205E-05 -0.4718729695E+03 -0.2801558439E-01 0.1844713830E+01 0.4810171133E-05 0.4468029358E+03 0.1299965801E-02 -0.2179153932E+02 0.1607484785E+00 -0.3614416042E+01 0.3431343257E-01 0.1623937354E+04 -0.1858200790E+04 0.3346153668E+01 0.2115506952E+02 0.5516275918E-04 0.1844713830E+01 0.4810171133E-05 -0.4496737267E+03 -0.2688498140E-01 0.1627426308E+01 0.3737944818E-05 0.4248207463E+03 0.1108581110E-02 -0.2083281276E+02 0.1501963899E+00 -0.3309391206E+01 0.3166696132E-01 0.1566999650E+04 -0.1793283174E+04 0.3163371852E+01 0.2136790845E+02 0.4907875844E-04 0.1627426308E+01 0.3737944818E-05 -0.4260304833E+03 -0.2575961775E-01 0.1421552863E+01 0.2804510842E-05 0.4013959723E+03 0.9226419754E-03 -0.1991133652E+02 0.1402071215E+00 -0.3019349007E+01 0.2914635141E-01 0.1510101632E+04 -0.1728348026E+04 0.2970474488E+01 0.2154038639E+02 0.4249595546E-04 0.1421552863E+01 0.2804510842E-05 -0.4007620511E+03 -0.2464045299E-01 0.1227066519E+01 0.2003356254E-05 0.3763635700E+03 0.7430684239E-03 -0.1903172150E+02 0.1309008305E+00 -0.2743473894E+01 0.2674222448E-01 0.1453254741E+04 -0.1663402879E+04 0.2766272672E+01 0.2169482614E+02 0.3541981218E-04 0.1227066519E+01 0.2003356254E-05 -0.3737107108E+03 -0.2352848798E-01 0.1043899305E+01 0.1328256694E-05 0.3495435943E+03 0.5711065222E-03 -0.1824088751E+02 0.1227307092E+00 -0.2480315736E+01 0.2443830986E-01 0.1396490784E+04 -0.1598430219E+04 0.2548981796E+01 0.2179814262E+02 0.2773594035E-04 0.1043899305E+01 0.1328256694E-05 -0.3445978639E+03 -0.2242531063E-01 0.8719937159E+00 0.7735493924E-06 0.3206906562E+03 0.4083514660E-03 -0.1754767276E+02 0.1159400854E+00 -0.2228481659E+01 0.2221831239E-01 0.1339825140E+04 -0.1533437247E+04 0.2316782595E+01 0.2186365117E+02 0.1939533940E-04 0.8719937159E+00 0.7735493924E-06 -0.3131704786E+03 -0.2133310001E-01 0.7112922920E+00 0.3343548819E-06 0.2895385231E+03 0.2570421887E-03 -0.1701441961E+02 0.1112062599E+00 -0.1985261074E+01 0.2005094327E-01 0.1283318426E+04 -0.1468422666E+04 0.2067096194E+01 0.2185858164E+02 0.1027499323E-04 0.7112922920E+00 0.3343548819E-06 -0.2790596682E+03 -0.2025485525E-01 0.5616905302E+00 0.7008214852E-08 0.2557512405E+03 0.1203095252E-03 -0.1668368027E+02 0.1091674560E+00 -0.1747391434E+01 0.1789757757E-01 0.1227011221E+04 -0.1403385039E+04 0.1797055047E+01 0.2173486481E+02 0.2711859897E-06 0.5616905302E+00 0.7008214852E-08 -0.2417958430E+03 -0.1919525777E-01 0.4230002612E+00 0.2189075802E+03 0.2733340842E-05 -0.1660454366E+02 0.1105953560E+00 -0.1509642673E+01 0.1569666967E-01 0.1170949049E+04 -0.1338322575E+04 0.1503083950E+01 0.2143759773E+02 0.4230002612E+00 -0.2007804937E+03 -0.1826062332E-01 0.2948139486E+00 0.1784645302E+03 0.1097092197E+04 -0.1271930831E+04 0.2076948809E+02 0.2948139486E+00 -0.1550748078E+03 -0.1732882368E-01 0.1758986759E+00 0.1336822123E+03 0.1041340607E+04 -0.1207159015E+04 0.1912061422E+02 0.1758986759E+00 -0.1030275347E+03 -0.1639696622E-01 0.5969185226E-01 0.8352709172E+02 0.9855901897E+03 -0.1142387934E+04 0.1284419871E+02 0.5969185226E-01 -0.3856475105E+02 -0.1546873128E-01 0.2552478733E+02 0.9298544361E+03 -0.1077626278E+04 0.7557552390E+03 0.6882909885E-02 -0.9155588882E+03 -0.6533719064E-01 0.1594240808E+03 0.1413853771E-02 -0.4450228392E+01 0.3697273476E+04 -0.3968850638E+04 0.7481900295E+03 0.6619209181E-02 0.1594240808E+03 0.1413853771E-02 -0.1066796744E+04 -0.6759895331E-01 0.1586731142E+03 0.1367458011E-02 -0.8975522141E+01 -0.2621706966E+03 0.2400497555E+01 0.3753554063E+04 -0.4048761128E+04 0.7404153255E+03 0.6366431265E-02 0.1586731142E+03 0.1367458011E-02 -0.1057386141E+04 -0.6841208237E-01 0.1577779796E+03 0.1321657279E-02 -0.1245301099E+02 -0.2484281454E+03 0.2247859135E+01 0.3812996459E+04 -0.4129336964E+04 0.7324117357E+03 0.6122086061E-02 0.1577779796E+03 0.1321657279E-02 -0.1047457139E+04 -0.6923453894E-01 0.1567374988E+03 0.1276085091E-02 -0.1538347781E+02 -0.2377877767E+03 0.2131158078E+01 0.3875001994E+04 -0.4209953870E+04 0.7241625558E+03 0.5883971530E-02 0.1567374988E+03 0.1276085091E-02 -0.1036991842E+04 -0.7006324483E-01 0.1555516598E+03 0.1230469380E-02 -0.1771291270E+02 -0.2297686340E+03 0.2044910411E+01 0.3939024513E+04 -0.4290591797E+04 0.7156432824E+03 0.5650287913E-02 0.1555516598E+03 0.1230469380E-02 -0.1025965694E+04 -0.7089642011E-01 0.1542204167E+03 0.1184626831E-02 -0.1942751811E+02 -0.2238324106E+03 0.1983110795E+01 0.4004542951E+04 -0.4371279465E+04 0.7068370190E+03 0.5419800274E-02 0.1542204167E+03 0.1184626831E-02 -0.1014361321E+04 -0.7173227716E-01 0.1527433416E+03 0.1138425666E-02 -0.2074824400E+02 -0.2194238695E+03 0.1939332482E+01 0.4071210897E+04 -0.4451995277E+04 0.6977236567E+03 0.5191499169E-02 0.1527433416E+03 0.1138425666E-02 -0.1002158171E+04 -0.7256960403E-01 0.1511204168E+03 0.1091795273E-02 -0.2166689314E+02 -0.2162051543E+03 0.1909808679E+01 0.4138684101E+04 -0.4532736630E+04 0.6882870228E+03 0.4964702876E-02 0.1511204168E+03 0.1091795273E-02 -0.9893402584E+03 -0.7340763665E-01 0.1493518483E+03 0.1044723839E-02 -0.2219420164E+02 -0.2138252783E+03 0.1890463933E+01 0.4206623801E+04 -0.4613500409E+04 0.6784958738E+03 0.4738936312E-02 0.1493518483E+03 0.1044723839E-02 -0.9758765818E+03 -0.7424590341E-01 0.1474376714E+03 0.9972267329E-03 -0.2251231431E+02 -0.2119399789E+03 0.1877392151E+01 0.4274868969E+04 -0.4694283410E+04 0.6683295713E+03 0.4513916622E-02 0.1474376714E+03 0.9972267329E-03 -0.9617467061E+03 -0.7508419163E-01 0.1453780542E+03 0.9493586672E-03 -0.2256553460E+02 -0.2103831328E+03 0.1868644227E+01 0.4343198742E+04 -0.4775084301E+04 0.6577670674E+03 0.4289586545E-02 0.1453780542E+03 0.9493586672E-03 -0.9469303147E+03 -0.7592233269E-01 0.1431735618E+03 0.9011914469E-03 -0.2250315467E+02 -0.2089291398E+03 0.1861672977E+01 0.4411523230E+04 -0.4855884422E+04 0.6467793143E+03 0.4065895808E-02 0.1431735618E+03 0.9011914469E-03 -0.9313994300E+03 -0.7676091194E-01 0.1408246949E+03 0.8528132908E-03 -0.2231197764E+02 -0.2074989117E+03 0.1855503112E+01 0.4479779245E+04 -0.4936716267E+04 0.6353422731E+03 0.3842928974E-02 0.1408246949E+03 0.8528132908E-03 -0.9151307090E+03 -0.7759996873E-01 0.1383316510E+03 0.8043285590E-03 -0.2198712963E+02 -0.2059979710E+03 0.1849078096E+01 0.4547853691E+04 -0.5017562561E+04 0.6234137723E+03 0.3620787030E-02 0.1383316510E+03 0.8043285590E-03 -0.8980826170E+03 -0.7843981520E-01 0.1356948690E+03 0.7558440268E-03 -0.2163306941E+02 -0.2043257172E+03 0.1841212100E+01 0.4615750789E+04 -0.5098422352E+04 0.6109638657E+03 0.3399661311E-02 0.1356948690E+03 0.7558440268E-03 -0.8802259128E+03 -0.7928085952E-01 0.1329146152E+03 0.7074697254E-03 -0.2122923704E+02 -0.2024854995E+03 0.1831931108E+01 0.4683453738E+04 -0.5179295928E+04 0.5979520838E+03 0.3179736168E-02 0.1329146152E+03 0.7074697254E-03 -0.8615208958E+03 -0.8012351399E-01 0.1299913919E+03 0.6593235483E-03 -0.2076139995E+02 -0.2004608460E+03 0.1821041946E+01 0.4750932245E+04 -0.5260183361E+04 0.5843399268E+03 0.2961290196E-02 0.1299913919E+03 0.6593235483E-03 -0.8419298078E+03 -0.8096828568E-01 0.1269254386E+03 0.6115161312E-03 -0.2030254193E+02 -0.1982221627E+03 0.1808210066E+01 0.4818230088E+04 -0.5341084563E+04 0.5700784689E+03 0.2744548514E-02 0.1269254386E+03 0.6115161312E-03 -0.8214044843E+03 -0.8181538266E-01 0.1237172789E+03 0.5641575423E-03 -0.1982850586E+02 -0.1958147084E+03 0.1793938111E+01 0.4885354641E+04 -0.5421983831E+04 0.5551213037E+03 0.2529791328E-02 0.1237172789E+03 0.5641575423E-03 -0.7998995862E+03 -0.8266578151E-01 0.1203674522E+03 0.5173584835E-03 -0.1932185872E+02 -0.1932624758E+03 0.1778502856E+01 0.4952341617E+04 -0.5502914947E+04 0.5393984673E+03 0.2317263776E-02 0.1203674522E+03 0.5173584835E-03 -0.7773458539E+03 -0.8351970101E-01 0.1168761257E+03 0.4712196659E-03 -0.1883393149E+02 -0.1905748084E+03 0.1762010558E+01 0.5019238175E+04 -0.5583861947E+04 0.5228506755E+03 0.2107282754E-02 0.1168761257E+03 0.4712196659E-03 -0.7536845215E+03 -0.8437765599E-01 0.1132436501E+03 0.4258383375E-03 -0.1834227357E+02 -0.1878158306E+03 0.1745218075E+01 0.5086086973E+04 -0.5664826219E+04 0.5054028686E+03 0.1900157983E-02 0.1132436501E+03 0.4258383375E-03 -0.7288412189E+03 -0.8524014885E-01 0.1094703641E+03 0.3813098863E-03 -0.1783048458E+02 -0.1850309295E+03 0.1728644435E+01 0.5152918237E+04 -0.5745809082E+04 0.4869765190E+03 0.1696282023E-02 0.1094703641E+03 0.3813098863E-03 -0.7027380512E+03 -0.8610775450E-01 0.1055565616E+03 0.3377212967E-03 -0.1733853635E+02 -0.1822528701E+03 0.1712688271E+01 0.5219806201E+04 -0.5826811896E+04 0.4674831904E+03 0.1496073570E-02 0.1055565616E+03 0.3377212967E-03 -0.6752871568E+03 -0.8698106084E-01 0.1015025229E+03 0.2951547772E-03 -0.1684945190E+02 -0.1795579312E+03 0.1698240961E+01 0.5286812111E+04 -0.5907836806E+04 0.4468029358E+03 0.1299965801E-02 0.1015025229E+03 0.2951547772E-03 -0.6463690172E+03 -0.8786066282E-01 0.9730839584E+02 0.2536898769E-03 -0.1635326429E+02 -0.1770086981E+03 0.1686052484E+01 0.5353991024E+04 -0.5988886130E+04 0.4248207463E+03 0.1108581110E-02 0.9730839584E+02 0.2536898769E-03 -0.6158691523E+03 -0.8874709790E-01 0.9297456303E+02 0.2133999435E-03 -0.1588605129E+02 -0.1746607995E+03 0.1676780388E+01 0.5421423407E+04 -0.6069945923E+04 0.4013959723E+03 0.9226419754E-03 0.9297456303E+02 0.2133999435E-03 -0.5836475772E+03 -0.8964170691E-01 0.8850130193E+02 0.1743542739E-03 -0.1544263459E+02 -0.1726084059E+03 0.1671562479E+01 0.5489230682E+04 -0.6151052940E+04 0.3763635700E+03 0.7430684239E-03 0.8850130193E+02 0.1743542739E-03 -0.5495394886E+03 -0.9054530854E-01 0.8388857673E+02 0.1366199693E-03 -0.1502669047E+02 -0.1709416600E+03 0.1671470783E+01 0.5557497359E+04 -0.6232194891E+04 0.3495435943E+03 0.5711065222E-03 0.8388857673E+02 0.1366199693E-03 -0.5133650841E+03 -0.9145927905E-01 0.7913656497E+02 0.1002602363E-03 -0.1468331636E+02 -0.1697547101E+03 0.1677673273E+01 0.5626368998E+04 -0.6313377012E+04 0.3206906562E+03 0.4083514660E-03 0.7913656497E+02 0.1002602363E-03 -0.4748792985E+03 -0.9238534165E-01 0.7424541168E+02 0.6533966145E-04 -0.1442058205E+02 -0.1691852417E+03 0.1691807276E+01 0.5695999644E+04 -0.6394606279E+04 0.2895385231E+03 0.2570421887E-03 0.7424541168E+02 0.6533966145E-04 -0.4338158291E+03 -0.9332586048E-01 0.6921489974E+02 0.3191860960E-04 -0.1429883805E+02 -0.1693747212E+03 0.1715625513E+01 0.5766601966E+04 -0.6475891434E+04 0.2557512405E+03 0.1203095252E-03 0.6921489974E+02 0.3191860960E-04 -0.3898384174E+03 -0.9428409739E-01 0.6404494041E+02 0.6790334142E-07 -0.1435950988E+02 -0.1705171113E+03 0.1751478115E+01 0.5838425940E+04 -0.6557244224E+04 0.2189075802E+03 0.2733340842E-05 0.6404494041E+02 0.6790334142E-07 -0.3425230882E+03 -0.9529467837E-01 0.5873287423E+02 -0.1465061185E+02 -0.1728353616E+03 0.1802134417E+01 0.5911748061E+04 -0.6638663612E+04 0.1784645302E+03 0.5873287423E+02 -0.2913263343E+03 -0.9645226214E-01 0.5328085680E+02 0.5795122761E+04 -0.6718332833E+04 0.1336822123E+03 0.5328085680E+02 -0.2355097213E+03 -0.9761271829E-01 0.4768817260E+02 0.5866155628E+04 -0.6799915084E+04 0.8352709172E+02 0.4768817260E+02 -0.1726569559E+03 -0.1152951474E+00 0.4057277226E+02 0.1652034807E-01 0.5937415063E+04 -0.6881643236E+04 0.2552478733E+02 0.4057277226E+02 0.1652034807E-01 -0.6696541686E+02 -0.1204083520E+00 -0.8248617596E+01 -0.2042749315E+03 0.2280972617E+01 0.6221553050E+04 -0.6965880969E+04 itsol-1.0.0/TESTS_HB/MATRICES/SHERMAN50000640000265600020320000217056511062577476015610 0ustar tilleaadmin1U FULLY IMPLICIT BLACK OIL SIMULATOR 16 BY 23 BY 3 GRID, THREE UNK SHERMAN5 7234 332 2080 4159 663 RUA 3312 3312 20793 0 (10I8) (10I8) (5E16.8) (5E16.8) F 1 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 27 28 29 30 31 32 33 34 35 36 37 38 39 40 41 42 43 44 45 46 47 48 49 50 51 52 53 54 55 56 57 58 59 60 61 62 63 64 65 66 67 68 69 70 71 72 73 74 75 76 77 78 79 80 81 82 83 84 85 86 87 88 89 90 91 92 93 94 95 96 97 98 99 100 101 102 103 104 105 106 107 108 109 110 111 112 118 124 131 137 144 153 154 155 156 157 158 159 165 171 178 186 194 204 212 220 230 240 249 260 270 279 290 300 309 320 328 336 346 347 348 349 350 351 352 353 354 355 356 357 358 359 360 361 371 380 391 403 413 425 435 443 452 462 471 482 494 504 516 528 538 550 562 572 584 596 606 618 630 640 652 664 674 686 696 705 716 717 718 719 720 721 722 723 724 725 726 727 728 729 730 731 741 750 761 773 783 795 807 816 826 838 848 860 872 882 894 906 916 928 940 950 962 974 984 996 1008 1018 1030 1042 1052 1064 1074 1083 1094 1095 1096 1097 1098 1099 1100 1101 1102 1103 1104 1105 1106 1107 1108 1109 1119 1128 1139 1151 1161 1173 1185 1195 1207 1219 1228 1238 1250 1260 1272 1284 1294 1306 1318 1328 1340 1352 1362 1374 1386 1396 1408 1420 1430 1442 1450 1457 1465 1466 1467 1468 1469 1470 1471 1472 1473 1474 1475 1476 1477 1478 1479 1480 1490 1499 1510 1522 1532 1544 1556 1566 1578 1590 1600 1612 1624 1633 1643 1655 1665 1677 1689 1699 1711 1723 1733 1745 1757 1767 1779 1789 1798 1809 1810 1811 1812 1813 1814 1815 1816 1817 1818 1819 1820 1821 1822 1823 1824 1825 1826 1827 1837 1846 1857 1869 1879 1891 1903 1913 1925 1937 1947 1959 1971 1980 1990 2002 2012 2024 2036 2046 2058 2070 2080 2092 2104 2114 2126 2136 2145 2156 2157 2158 2159 2160 2161 2162 2163 2164 2165 2166 2167 2168 2169 2170 2171 2179 2186 2194 2206 2217 2231 2243 2253 2265 2277 2287 2299 2311 2321 2333 2345 2354 2364 2376 2386 2398 2410 2420 2432 2444 2454 2466 2478 2488 2500 2510 2519 2530 2531 2532 2533 2534 2535 2536 2537 2538 2539 2540 2541 2542 2543 2544 2545 2555 2564 2575 2587 2597 2609 2621 2631 2643 2655 2665 2677 2689 2699 2711 2723 2732 2742 2754 2764 2776 2788 2798 2810 2822 2832 2844 2856 2866 2878 2886 2893 2901 2902 2903 2904 2905 2906 2907 2908 2909 2910 2911 2912 2913 2914 2915 2916 2926 2935 2946 2958 2968 2980 2992 3002 3014 3026 3036 3048 3060 3070 3082 3094 3103 3113 3125 3135 3147 3159 3169 3181 3193 3203 3215 3225 3234 3245 3246 3247 3248 3249 3250 3251 3252 3253 3254 3255 3256 3257 3258 3259 3260 3261 3262 3263 3273 3282 3293 3305 3315 3327 3339 3349 3361 3373 3383 3395 3407 3417 3429 3441 3450 3460 3472 3482 3494 3506 3516 3528 3540 3550 3562 3572 3581 3592 3593 3594 3595 3596 3597 3598 3599 3600 3601 3602 3603 3604 3605 3606 3607 3615 3622 3630 3642 3652 3664 3676 3686 3698 3710 3720 3732 3744 3753 3763 3775 3784 3794 3806 3814 3822 3834 3843 3853 3865 3875 3887 3899 3909 3921 3929 3936 3944 3945 3946 3947 3948 3949 3950 3951 3952 3953 3954 3955 3956 3957 3958 3959 3969 3978 3989 4001 4010 4020 4032 4041 4051 4063 4072 4082 4094 4104 4116 4128 4138 4150 4162 4171 4181 4193 4203 4215 4227 4236 4246 4256 4265 4276 4277 4278 4279 4280 4281 4282 4283 4284 4285 4286 4287 4288 4289 4290 4291 4299 4306 4314 4326 4336 4348 4360 4370 4382 4394 4404 4416 4428 4438 4450 4462 4472 4484 4496 4506 4518 4530 4539 4549 4561 4571 4583 4593 4602 4613 4621 4628 4636 4637 4638 4639 4640 4641 4642 4643 4644 4645 4646 4647 4648 4649 4650 4651 4661 4670 4681 4693 4703 4715 4727 4737 4749 4761 4771 4783 4795 4805 4817 4829 4839 4851 4863 4873 4885 4897 4907 4919 4929 4937 4946 4947 4948 4949 4950 4951 4952 4953 4954 4955 4956 4957 4958 4959 4960 4961 4962 4963 4964 4972 4979 4987 4999 5009 5021 5033 5043 5055 5067 5077 5089 5101 5111 5123 5135 5145 5157 5169 5179 5191 5203 5213 5225 5235 5244 5255 5263 5270 5278 5279 5280 5281 5282 5283 5284 5285 5286 5287 5288 5289 5290 5291 5292 5293 5294 5295 5296 5306 5315 5326 5338 5348 5360 5372 5382 5394 5406 5416 5428 5440 5450 5462 5474 5484 5496 5508 5518 5530 5540 5548 5557 5558 5559 5560 5561 5562 5563 5564 5565 5566 5567 5568 5569 5570 5571 5572 5573 5574 5575 5576 5577 5578 5579 5580 5581 5591 5600 5611 5623 5633 5645 5657 5667 5679 5691 5701 5713 5725 5735 5747 5759 5769 5781 5791 5800 5811 5819 5826 5834 5835 5836 5837 5838 5839 5840 5841 5842 5843 5844 5845 5846 5847 5848 5849 5850 5851 5852 5853 5854 5855 5856 5857 5858 5866 5874 5884 5896 5906 5918 5930 5940 5952 5964 5974 5986 5998 6008 6020 6030 6038 6047 6048 6049 6050 6051 6052 6053 6054 6055 6056 6057 6058 6059 6060 6061 6062 6063 6064 6065 6066 6067 6068 6069 6070 6071 6072 6073 6074 6075 6076 6077 6078 6079 6080 6088 6096 6106 6118 6128 6140 6152 6162 6174 6186 6196 6208 6216 6223 6231 6232 6233 6234 6235 6236 6237 6238 6239 6240 6241 6242 6243 6244 6245 6246 6247 6248 6249 6250 6251 6252 6253 6254 6255 6256 6257 6258 6259 6260 6261 6262 6263 6264 6265 6266 6267 6277 6286 6297 6309 6319 6331 6339 6346 6354 6355 6356 6357 6358 6359 6360 6361 6362 6363 6364 6365 6366 6367 6368 6369 6370 6371 6372 6373 6374 6375 6376 6377 6378 6379 6380 6381 6382 6383 6384 6385 6386 6387 6388 6389 6390 6391 6392 6393 6401 6409 6419 6427 6434 6442 6443 6444 6445 6446 6447 6448 6449 6450 6451 6452 6453 6454 6455 6456 6457 6458 6459 6460 6461 6462 6463 6464 6465 6466 6467 6468 6469 6470 6471 6472 6473 6474 6475 6476 6477 6478 6479 6480 6481 6482 6483 6484 6485 6486 6487 6488 6489 6490 6491 6492 6493 6494 6495 6496 6497 6498 6499 6500 6501 6502 6503 6504 6505 6506 6507 6508 6509 6510 6511 6512 6513 6514 6515 6516 6517 6518 6519 6520 6521 6522 6523 6524 6525 6526 6527 6528 6529 6530 6531 6532 6533 6534 6535 6536 6537 6538 6539 6540 6541 6542 6543 6544 6545 6546 6547 6548 6549 6550 6551 6552 6553 6554 6555 6556 6557 6558 6559 6560 6561 6562 6563 6564 6565 6566 6567 6568 6569 6570 6571 6572 6573 6574 6575 6576 6577 6578 6579 6580 6581 6582 6583 6584 6585 6586 6587 6588 6589 6590 6591 6592 6593 6594 6595 6596 6597 6598 6599 6600 6601 6602 6603 6604 6605 6606 6607 6615 6623 6633 6645 6656 6670 6682 6693 6707 6717 6727 6740 6741 6742 6743 6744 6745 6746 6747 6748 6749 6750 6751 6752 6753 6754 6755 6765 6774 6785 6795 6805 6818 6828 6838 6851 6861 6871 6884 6894 6904 6917 6929 6940 6954 6966 6978 6994 7008 7019 7032 7046 7058 7073 7087 7099 7114 7126 7137 7151 7152 7153 7154 7155 7156 7157 7158 7159 7160 7161 7162 7163 7164 7165 7166 7178 7189 7203 7217 7229 7244 7258 7269 7282 7296 7308 7323 7337 7349 7364 7378 7390 7405 7419 7431 7446 7460 7472 7487 7501 7513 7528 7542 7554 7569 7581 7592 7606 7607 7608 7609 7610 7611 7612 7613 7614 7615 7616 7617 7618 7619 7620 7621 7633 7644 7658 7672 7684 7699 7713 7725 7740 7754 7765 7778 7792 7804 7819 7833 7845 7860 7874 7886 7901 7915 7927 7942 7956 7968 7983 7997 8009 8024 8034 8043 8054 8055 8056 8057 8058 8059 8060 8061 8062 8063 8064 8065 8066 8067 8068 8069 8081 8092 8106 8120 8132 8147 8161 8173 8188 8202 8214 8229 8243 8254 8267 8281 8293 8308 8322 8334 8349 8363 8375 8390 8404 8416 8431 8443 8454 8468 8469 8470 8471 8472 8473 8474 8475 8476 8477 8478 8479 8480 8481 8482 8483 8484 8485 8486 8498 8509 8523 8537 8549 8564 8578 8590 8605 8619 8631 8646 8660 8671 8684 8698 8710 8725 8739 8751 8766 8780 8792 8807 8821 8833 8848 8860 8871 8885 8886 8887 8888 8889 8890 8891 8892 8893 8894 8895 8896 8897 8898 8899 8900 8910 8919 8930 8944 8957 8974 8988 9000 9015 9029 9041 9056 9070 9082 9097 9111 9122 9135 9149 9161 9176 9190 9202 9217 9231 9243 9258 9272 9284 9299 9311 9322 9336 9337 9338 9339 9340 9341 9342 9343 9344 9345 9346 9347 9348 9349 9350 9351 9363 9374 9388 9402 9414 9429 9443 9455 9470 9484 9496 9511 9525 9537 9552 9566 9577 9590 9604 9616 9631 9645 9657 9672 9686 9698 9713 9727 9739 9754 9764 9773 9784 9785 9786 9787 9788 9789 9790 9791 9792 9793 9794 9795 9796 9797 9798 9799 9811 9822 9836 9850 9862 9877 9891 9903 9918 9932 9944 9959 9973 9985 10000 10014 10025 10038 10052 10064 10079 10093 10105 10120 10134 10146 10161 10173 10184 10198 10199 10200 10201 10202 10203 10204 10205 10206 10207 10208 10209 10210 10211 10212 10213 10214 10215 10216 10228 10239 10253 10267 10279 10294 10308 10320 10335 10349 10361 10376 10390 10402 10417 10431 10442 10455 10469 10481 10496 10510 10522 10537 10551 10563 10578 10590 10601 10615 10616 10617 10618 10619 10620 10621 10622 10623 10624 10625 10626 10627 10628 10629 10630 10640 10649 10660 10674 10686 10701 10715 10727 10742 10756 10768 10783 10797 10809 10824 10838 10849 10862 10876 10886 10897 10911 10922 10935 10949 10961 10976 10990 11002 11017 11027 11036 11047 11048 11049 11050 11051 11052 11053 11054 11055 11056 11057 11058 11059 11060 11061 11062 11074 11085 11099 11113 11124 11137 11151 11162 11175 11189 11200 11213 11227 11238 11251 11265 11277 11292 11306 11317 11330 11344 11356 11371 11385 11396 11409 11421 11432 11446 11447 11448 11449 11450 11451 11452 11453 11454 11455 11456 11457 11458 11459 11460 11461 11471 11480 11491 11505 11517 11532 11546 11558 11573 11587 11599 11614 11628 11640 11655 11669 11681 11696 11710 11722 11737 11751 11762 11775 11789 11801 11816 11828 11839 11853 11863 11872 11883 11884 11885 11886 11887 11888 11889 11890 11891 11892 11893 11894 11895 11896 11897 11898 11910 11921 11935 11949 11961 11976 11990 12002 12017 12031 12043 12058 12072 12084 12099 12113 12125 12140 12154 12166 12181 12195 12207 12222 12234 12244 12256 12257 12258 12259 12260 12261 12262 12263 12264 12265 12266 12267 12268 12269 12270 12271 12272 12273 12274 12284 12293 12304 12318 12330 12345 12359 12371 12386 12400 12412 12427 12441 12453 12468 12482 12494 12509 12523 12535 12550 12564 12576 12591 12603 12614 12628 12638 12647 12658 12659 12660 12661 12662 12663 12664 12665 12666 12667 12668 12669 12670 12671 12672 12673 12674 12675 12676 12688 12699 12713 12727 12739 12754 12768 12780 12795 12809 12821 12836 12850 12862 12877 12891 12903 12918 12932 12944 12959 12971 12981 12993 12994 12995 12996 12997 12998 12999 13000 13001 13002 13003 13004 13005 13006 13007 13008 13009 13010 13011 13012 13013 13014 13015 13016 13017 13029 13040 13054 13068 13080 13095 13109 13121 13136 13150 13162 13177 13191 13203 13218 13232 13244 13259 13271 13282 13296 13306 13315 13326 13327 13328 13329 13330 13331 13332 13333 13334 13335 13336 13337 13338 13339 13340 13341 13342 13343 13344 13345 13346 13347 13348 13349 13350 13360 13370 13383 13397 13409 13424 13438 13450 13465 13479 13491 13506 13520 13532 13547 13559 13569 13581 13582 13583 13584 13585 13586 13587 13588 13589 13590 13591 13592 13593 13594 13595 13596 13597 13598 13599 13600 13601 13602 13603 13604 13605 13606 13607 13608 13609 13610 13611 13612 13613 13614 13624 13634 13647 13661 13673 13688 13702 13714 13729 13743 13755 13770 13780 13789 13800 13801 13802 13803 13804 13805 13806 13807 13808 13809 13810 13811 13812 13813 13814 13815 13816 13817 13818 13819 13820 13821 13822 13823 13824 13825 13826 13827 13828 13829 13830 13831 13832 13833 13834 13835 13836 13848 13859 13873 13887 13899 13914 13924 13933 13944 13945 13946 13947 13948 13949 13950 13951 13952 13953 13954 13955 13956 13957 13958 13959 13960 13961 13962 13963 13964 13965 13966 13967 13968 13969 13970 13971 13972 13973 13974 13975 13976 13977 13978 13979 13980 13981 13982 13983 13993 14003 14016 14026 14035 14046 14047 14048 14049 14050 14051 14052 14053 14054 14055 14056 14057 14058 14059 14060 14061 14062 14063 14064 14065 14066 14067 14068 14069 14070 14071 14072 14073 14074 14075 14076 14077 14078 14079 14080 14081 14082 14083 14084 14085 14086 14087 14088 14089 14090 14091 14092 14093 14094 14095 14096 14097 14098 14099 14100 14101 14102 14103 14104 14105 14106 14107 14108 14109 14110 14111 14112 14113 14114 14115 14116 14117 14118 14119 14120 14121 14122 14123 14124 14125 14126 14127 14128 14129 14130 14131 14132 14133 14134 14135 14136 14137 14138 14139 14140 14141 14142 14143 14144 14145 14146 14147 14148 14149 14150 14151 14152 14153 14154 14155 14156 14157 14158 14159 14160 14161 14162 14163 14164 14165 14166 14167 14168 14169 14170 14171 14172 14173 14174 14175 14176 14177 14178 14179 14180 14181 14182 14183 14184 14185 14186 14187 14188 14189 14190 14191 14192 14193 14194 14195 14196 14197 14198 14199 14200 14201 14202 14203 14204 14205 14206 14207 14208 14209 14210 14211 14212 14213 14214 14222 14231 14243 14253 14263 14276 14284 14292 14302 14303 14304 14305 14306 14307 14308 14309 14310 14311 14312 14313 14314 14315 14316 14317 14323 14330 14339 14340 14341 14342 14343 14344 14345 14346 14347 14348 14349 14350 14351 14359 14368 14380 14390 14400 14413 14423 14433 14446 14458 14468 14480 14492 14503 14517 14527 14537 14550 14551 14552 14553 14554 14555 14556 14557 14558 14559 14560 14561 14562 14563 14564 14565 14575 14584 14595 14605 14615 14628 14638 14648 14661 14671 14681 14694 14704 14715 14730 14742 14752 14764 14776 14787 14801 14813 14824 14838 14850 14861 14875 14887 14898 14912 14922 14932 14945 14946 14947 14948 14949 14950 14951 14952 14953 14954 14955 14956 14957 14958 14959 14960 14970 14980 14993 15005 15016 15030 15042 15053 15067 15079 15089 15101 15113 15124 15138 15150 15161 15175 15187 15198 15212 15224 15235 15249 15261 15272 15286 15298 15309 15323 15331 15339 15349 15350 15351 15352 15353 15354 15355 15356 15357 15358 15359 15360 15361 15362 15363 15364 15374 15384 15397 15409 15420 15434 15446 15457 15471 15483 15494 15508 15520 15530 15542 15554 15565 15579 15591 15602 15616 15628 15639 15653 15665 15676 15690 15700 15710 15723 15724 15725 15726 15727 15728 15729 15730 15731 15732 15733 15734 15735 15736 15737 15738 15739 15740 15741 15751 15761 15774 15786 15797 15811 15823 15834 15848 15860 15871 15885 15897 15907 15919 15931 15942 15956 15968 15979 15993 16005 16016 16030 16042 16053 16067 16077 16087 16100 16101 16102 16103 16104 16105 16106 16107 16108 16109 16110 16111 16112 16113 16114 16115 16123 16131 16141 16153 16165 16181 16193 16204 16218 16230 16241 16255 16267 16278 16292 16304 16314 16326 16338 16349 16363 16375 16386 16400 16412 16423 16437 16449 16460 16474 16484 16494 16507 16508 16509 16510 16511 16512 16513 16514 16515 16516 16517 16518 16519 16520 16521 16522 16532 16542 16555 16567 16578 16592 16604 16615 16629 16641 16652 16666 16678 16689 16703 16715 16725 16737 16749 16760 16774 16786 16797 16811 16823 16834 16848 16860 16871 16885 16893 16901 16911 16912 16913 16914 16915 16916 16917 16918 16919 16920 16921 16922 16923 16924 16925 16926 16936 16946 16959 16971 16982 16996 17008 17019 17033 17045 17056 17070 17082 17093 17107 17119 17129 17141 17153 17164 17178 17190 17201 17215 17227 17238 17252 17262 17272 17285 17286 17287 17288 17289 17290 17291 17292 17293 17294 17295 17296 17297 17298 17299 17300 17301 17302 17303 17313 17323 17336 17348 17359 17373 17385 17396 17410 17422 17433 17447 17459 17470 17484 17496 17506 17518 17530 17541 17555 17567 17578 17592 17604 17615 17629 17639 17649 17662 17663 17664 17665 17666 17667 17668 17669 17670 17671 17672 17673 17674 17675 17676 17677 17685 17693 17703 17715 17726 17740 17752 17763 17777 17789 17800 17814 17826 17837 17851 17863 17873 17885 17897 17906 17916 17928 17938 17950 17962 17973 17987 17999 18010 18024 18032 18040 18050 18051 18052 18053 18054 18055 18056 18057 18058 18059 18060 18061 18062 18063 18064 18065 18075 18085 18098 18110 18120 18132 18144 18154 18166 18178 18188 18200 18212 18222 18234 18246 18257 18271 18283 18293 18305 18317 18328 18342 18354 18365 18379 18389 18399 18412 18413 18414 18415 18416 18417 18418 18419 18420 18421 18422 18423 18424 18425 18426 18427 18435 18443 18453 18465 18476 18490 18502 18513 18527 18539 18550 18564 18576 18587 18601 18613 18624 18638 18650 18661 18675 18687 18697 18709 18721 18732 18746 18756 18765 18776 18784 18792 18802 18803 18804 18805 18806 18807 18808 18809 18810 18811 18812 18813 18814 18815 18816 18817 18827 18837 18850 18862 18873 18887 18899 18910 18924 18936 18947 18961 18973 18984 18998 19010 19021 19035 19047 19058 19072 19084 19095 19109 19119 19128 19139 19140 19141 19142 19143 19144 19145 19146 19147 19148 19149 19150 19151 19152 19153 19154 19155 19156 19157 19165 19173 19183 19195 19206 19220 19232 19243 19257 19269 19280 19294 19306 19317 19331 19343 19354 19368 19380 19391 19405 19417 19428 19442 19452 19462 19475 19483 19491 19501 19502 19503 19504 19505 19506 19507 19508 19509 19510 19511 19512 19513 19514 19515 19516 19517 19518 19519 19529 19539 19552 19564 19575 19589 19601 19612 19626 19638 19649 19663 19675 19686 19700 19712 19723 19737 19749 19760 19774 19784 19793 19804 19805 19806 19807 19808 19809 19810 19811 19812 19813 19814 19815 19816 19817 19818 19819 19820 19821 19822 19823 19824 19825 19826 19827 19828 19838 19848 19861 19873 19884 19898 19910 19921 19935 19947 19958 19972 19984 19995 20009 20021 20032 20046 20056 20066 20079 20087 20095 20105 20106 20107 20108 20109 20110 20111 20112 20113 20114 20115 20116 20117 20118 20119 20120 20121 20122 20123 20124 20125 20126 20127 20128 20129 20137 20146 20158 20170 20181 20195 20207 20218 20232 20244 20255 20269 20281 20292 20306 20316 20325 20336 20337 20338 20339 20340 20341 20342 20343 20344 20345 20346 20347 20348 20349 20350 20351 20352 20353 20354 20355 20356 20357 20358 20359 20360 20361 20362 20363 20364 20365 20366 20367 20368 20369 20377 20386 20398 20410 20421 20435 20447 20458 20472 20484 20495 20509 20517 20525 20535 20536 20537 20538 20539 20540 20541 20542 20543 20544 20545 20546 20547 20548 20549 20550 20551 20552 20553 20554 20555 20556 20557 20558 20559 20560 20561 20562 20563 20564 20565 20566 20567 20568 20569 20570 20571 20581 20591 20604 20616 20627 20641 20649 20657 20667 20668 20669 20670 20671 20672 20673 20674 20675 20676 20677 20678 20679 20680 20681 20682 20683 20684 20685 20686 20687 20688 20689 20690 20691 20692 20693 20694 20695 20696 20697 20698 20699 20700 20701 20702 20703 20704 20705 20706 20714 20723 20735 20743 20751 20761 20762 20763 20764 20765 20766 20767 20768 20769 20770 20771 20772 20773 20774 20775 20776 20777 20778 20779 20780 20781 20782 20783 20784 20785 20786 20787 20788 20789 20790 20791 20792 20793 20794 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 27 28 29 30 31 32 33 34 35 36 37 38 39 40 41 42 43 44 45 46 47 48 49 50 51 52 53 54 55 56 57 58 59 60 61 62 63 64 65 66 67 68 69 70 71 72 73 74 75 76 77 78 79 80 81 82 83 84 85 86 87 88 89 90 91 92 93 94 95 96 97 98 99 100 101 102 103 104 105 106 107 108 109 110 111 112 114 115 117 160 162 112 113 114 117 160 162 112 113 114 117 160 161 162 112 114 115 117 163 165 112 114 115 116 117 163 165 112 113 114 115 116 117 163 164 165 118 119 120 121 122 123 124 126 127 129 172 174 124 125 126 129 172 174 124 125 126 129 172 173 174 124 126 127 129 130 132 175 177 124 126 127 128 129 132 175 177 124 125 126 127 128 129 132 175 176 177 127 129 130 132 133 135 178 180 127 129 130 131 132 135 178 180 127 128 129 130 131 132 135 178 179 180 130 132 133 135 136 138 181 183 1237 1239 130 132 133 134 135 138 181 183 1239 130 131 132 133 134 135 138 181 182 183 1239 133 135 136 138 139 141 184 186 1240 1242 133 135 136 137 138 141 184 186 1242 133 134 135 136 137 138 141 184 185 186 1242 136 138 139 141 142 144 187 189 1243 1245 136 138 139 140 141 144 187 189 1245 136 137 138 139 140 141 144 187 188 189 1245 139 141 142 144 190 192 1246 1248 139 141 142 143 144 190 192 1248 139 140 141 142 143 144 190 191 192 1248 145 146 147 148 149 150 151 152 153 154 155 156 157 158 159 112 114 160 162 163 165 208 210 1264 1266 114 160 161 162 163 165 208 210 1266 114 160 161 162 163 164 165 208 209 210 1266 115 117 160 162 163 165 166 168 211 213 1267 1269 117 162 163 164 165 166 168 211 213 1269 117 162 163 164 165 166 167 168 211 212 213 1269 163 165 166 168 169 171 214 216 1270 1272 165 166 167 168 171 214 216 1272 165 166 167 168 171 214 215 216 1272 166 168 169 171 172 174 217 219 1273 1275 166 168 169 170 171 174 217 219 1275 166 167 168 169 170 171 174 217 218 219 1275 124 126 169 171 172 174 175 177 220 222 1276 1278 126 169 171 172 173 174 177 220 222 1278 126 169 170 171 172 173 174 177 220 221 222 1278 127 129 172 174 175 177 178 180 223 225 1279 1281 129 172 174 175 176 177 180 223 225 1281 129 172 173 174 175 176 177 180 223 224 225 1281 130 132 175 177 178 180 181 183 226 228 1282 1284 132 175 177 178 179 180 183 226 228 1284 132 175 176 177 178 179 180 183 226 227 228 1284 133 135 178 180 181 183 184 186 229 231 1285 1287 135 178 180 181 182 183 186 229 231 1287 135 178 179 180 181 182 183 186 229 230 231 1287 136 138 181 183 184 186 187 189 232 234 1288 1290 138 181 183 184 185 186 189 232 234 1290 138 181 182 183 184 185 186 189 232 233 234 1290 139 141 184 186 187 189 190 192 235 237 1291 1293 141 184 186 187 188 189 192 235 237 1293 141 184 185 186 187 188 189 192 235 236 237 1293 142 144 187 189 190 192 238 240 1294 1296 144 187 189 190 191 192 238 240 1296 144 187 188 189 190 191 192 238 239 240 1296 193 194 195 196 197 198 199 200 201 202 203 204 205 206 207 160 162 208 210 211 213 256 258 1312 1314 162 208 209 210 211 213 256 258 1314 162 208 209 210 211 212 213 256 257 258 1314 163 165 208 210 211 213 214 216 259 261 1315 1317 165 210 211 212 213 214 216 259 261 1317 165 210 211 212 213 214 215 216 259 260 261 1317 166 168 211 213 214 216 217 219 262 264 1318 1320 168 213 214 215 216 219 262 264 1320 168 213 214 215 216 219 262 263 264 1320 169 171 214 216 217 219 220 222 265 267 1321 1323 171 214 216 217 218 219 222 265 267 1323 171 214 215 216 217 218 219 222 265 266 267 1323 172 174 217 219 220 222 223 225 268 270 1324 1326 174 217 219 220 221 222 225 268 270 1326 174 217 218 219 220 221 222 225 268 269 270 1326 175 177 220 222 223 225 226 228 271 273 1327 1329 177 220 222 223 224 225 228 271 273 1329 177 220 221 222 223 224 225 228 271 272 273 1329 178 180 223 225 226 228 229 231 274 276 1330 1332 180 223 225 226 227 228 231 274 276 1332 180 223 224 225 226 227 228 231 274 275 276 1332 181 183 226 228 229 231 232 234 277 279 1333 1335 183 226 228 229 230 231 234 277 279 1335 183 226 227 228 229 230 231 234 277 278 279 1335 184 186 229 231 232 234 235 237 280 282 1336 1338 186 229 231 232 233 234 237 280 282 1338 186 229 230 231 232 233 234 237 280 281 282 1338 187 189 232 234 235 237 238 240 283 285 1339 1341 189 232 234 235 236 237 240 283 285 1341 189 232 233 234 235 236 237 240 283 284 285 1341 190 192 235 237 238 240 286 288 1342 1344 192 235 237 238 239 240 286 288 1344 192 235 236 237 238 239 240 286 287 288 1344 241 242 243 244 245 246 247 248 249 250 251 252 253 254 255 208 210 256 258 259 261 304 306 1360 1362 210 256 257 258 259 261 304 306 1362 210 256 257 258 259 260 261 304 305 306 1362 211 213 256 258 259 261 262 264 307 309 1363 1365 213 258 259 260 261 262 264 307 309 1365 213 258 259 260 261 262 263 264 307 308 309 1365 214 216 259 261 262 264 265 267 310 312 1366 1368 216 261 262 263 264 265 267 310 312 1368 216 261 262 263 264 265 266 267 310 311 312 1368 217 219 262 264 265 267 268 270 313 315 1369 1371 219 264 265 266 267 270 313 315 1371 219 264 265 266 267 270 313 314 315 1371 220 222 265 267 268 270 271 273 316 318 1372 1374 222 265 267 268 269 270 273 316 318 1374 222 265 266 267 268 269 270 273 316 317 318 1374 223 225 268 270 271 273 274 276 319 321 1375 1377 225 268 270 271 272 273 276 319 321 1377 225 268 269 270 271 272 273 276 319 320 321 1377 226 228 271 273 274 276 277 279 322 324 1378 1380 228 271 273 274 275 276 279 322 324 1380 228 271 272 273 274 275 276 279 322 323 324 1380 229 231 274 276 277 279 280 282 325 327 1381 1383 231 274 276 277 278 279 282 325 327 1383 231 274 275 276 277 278 279 282 325 326 327 1383 232 234 277 279 280 282 283 285 328 330 1384 1386 234 277 279 280 281 282 285 328 330 1386 234 277 278 279 280 281 282 285 328 329 330 1386 235 237 280 282 283 285 286 288 331 333 1387 1389 237 280 282 283 284 285 288 331 333 1389 237 280 281 282 283 284 285 288 331 332 333 1389 238 240 283 285 286 288 1390 1392 240 283 285 286 287 288 1392 240 283 284 285 286 287 288 1392 289 290 291 292 293 294 295 296 297 298 299 300 301 302 303 256 258 304 306 307 309 352 354 1408 1410 258 304 305 306 307 309 352 354 1410 258 304 305 306 307 308 309 352 353 354 1410 259 261 304 306 307 309 310 312 355 357 1411 1413 261 306 307 308 309 310 312 355 357 1413 261 306 307 308 309 310 311 312 355 356 357 1413 262 264 307 309 310 312 313 315 358 360 1414 1416 264 309 310 311 312 313 315 358 360 1416 264 309 310 311 312 313 314 315 358 359 360 1416 265 267 310 312 313 315 316 318 361 363 1417 1419 267 312 313 314 315 316 318 361 363 1419 267 312 313 314 315 316 317 318 361 362 363 1419 268 270 313 315 316 318 319 321 364 366 1420 1422 270 315 316 317 318 321 364 366 1422 270 315 316 317 318 321 364 365 366 1422 271 273 316 318 319 321 322 324 367 369 1423 1425 273 316 318 319 320 321 324 367 369 1425 273 316 317 318 319 320 321 324 367 368 369 1425 274 276 319 321 322 324 325 327 370 372 1426 1428 276 319 321 322 323 324 327 370 372 1428 276 319 320 321 322 323 324 327 370 371 372 1428 277 279 322 324 325 327 328 330 373 375 1429 1431 279 322 324 325 326 327 330 373 375 1431 279 322 323 324 325 326 327 330 373 374 375 1431 280 282 325 327 328 330 331 333 376 378 1432 1434 282 325 327 328 329 330 333 376 378 1434 282 325 326 327 328 329 330 333 376 377 378 1434 283 285 328 330 331 333 379 381 1435 1437 285 328 330 331 332 333 379 381 1437 285 328 329 330 331 332 333 379 380 381 1437 334 335 336 337 338 339 340 341 342 343 344 345 346 347 348 349 350 351 304 306 352 354 355 357 400 402 1456 1458 306 352 353 354 355 357 400 402 1458 306 352 353 354 355 356 357 400 401 402 1458 307 309 352 354 355 357 358 360 403 405 1459 1461 309 354 355 356 357 358 360 403 405 1461 309 354 355 356 357 358 359 360 403 404 405 1461 310 312 355 357 358 360 361 363 406 408 1462 1464 312 357 358 359 360 361 363 406 408 1464 312 357 358 359 360 361 362 363 406 407 408 1464 313 315 358 360 361 363 364 366 409 411 1465 1467 315 360 361 362 363 364 366 409 411 1467 315 360 361 362 363 364 365 366 409 410 411 1467 316 318 361 363 364 366 367 369 412 414 1468 1470 318 363 364 365 366 369 412 414 1470 318 363 364 365 366 369 412 413 414 1470 319 321 364 366 367 369 370 372 415 417 1471 1473 321 364 366 367 368 369 372 415 417 1473 321 364 365 366 367 368 369 372 415 416 417 1473 322 324 367 369 370 372 373 375 418 420 1474 1476 324 367 369 370 371 372 375 418 420 1476 324 367 368 369 370 371 372 375 418 419 420 1476 325 327 370 372 373 375 376 378 421 423 1477 1479 327 370 372 373 374 375 378 421 423 1479 327 370 371 372 373 374 375 378 421 422 423 1479 328 330 373 375 376 378 379 381 424 426 1480 1482 330 373 375 376 377 378 381 424 426 1482 330 373 374 375 376 377 378 381 424 425 426 1482 331 333 376 378 379 381 427 429 1483 1485 333 376 378 379 380 381 427 429 1485 333 376 377 378 379 380 381 427 428 429 1485 382 383 384 385 386 387 388 389 390 391 392 393 394 395 396 397 399 400 402 445 447 1501 1503 397 398 399 402 445 447 1503 397 398 399 402 445 446 447 1503 352 354 397 399 400 402 403 405 448 450 1504 1506 354 397 399 400 401 402 403 405 448 450 1506 354 397 398 399 400 401 402 403 404 405 448 449 450 1506 355 357 400 402 403 405 406 408 451 453 1507 1509 357 402 403 404 405 406 408 451 453 1509 357 402 403 404 405 406 407 408 451 452 453 1509 358 360 403 405 406 408 409 411 454 456 1510 1512 360 405 406 407 408 409 411 454 456 1512 360 405 406 407 408 409 410 411 454 455 456 1512 361 363 406 408 409 411 412 414 457 459 1513 1515 363 408 409 410 411 412 414 457 459 1515 363 408 409 410 411 412 413 414 457 458 459 1515 364 366 409 411 412 414 415 417 460 462 1516 1518 366 411 412 413 414 417 460 462 1518 366 411 412 413 414 417 460 461 462 1518 367 369 412 414 415 417 418 420 463 465 1519 1521 369 412 414 415 416 417 420 463 465 1521 369 412 413 414 415 416 417 420 463 464 465 1521 370 372 415 417 418 420 421 423 466 468 1522 1524 372 415 417 418 419 420 423 466 468 1524 372 415 416 417 418 419 420 423 466 467 468 1524 373 375 418 420 421 423 424 426 469 471 1525 1527 375 418 420 421 422 423 426 469 471 1527 375 418 419 420 421 422 423 426 469 470 471 1527 376 378 421 423 424 426 427 429 472 474 1528 1530 378 421 423 424 425 426 429 472 474 1530 378 421 422 423 424 425 426 429 472 473 474 1530 379 381 424 426 427 429 475 477 1531 1533 381 424 426 427 428 429 475 477 1533 381 424 425 426 427 428 429 475 476 477 1533 430 431 432 433 434 435 436 437 438 439 440 441 442 443 444 397 399 445 447 448 450 493 495 1549 1551 399 445 446 447 448 450 493 495 1551 399 445 446 447 448 449 450 493 494 495 1551 400 402 445 447 448 450 451 453 496 498 1552 1554 402 447 448 449 450 451 453 496 498 1554 402 447 448 449 450 451 452 453 496 497 498 1554 403 405 448 450 451 453 454 456 499 501 1555 1557 405 450 451 452 453 454 456 499 501 1557 405 450 451 452 453 454 455 456 499 500 501 1557 406 408 451 453 454 456 457 459 502 504 1558 1560 408 453 454 455 456 457 459 502 504 1560 408 453 454 455 456 457 458 459 502 503 504 1560 409 411 454 456 457 459 460 462 505 507 1561 1563 411 456 457 458 459 460 462 505 507 1563 411 456 457 458 459 460 461 462 505 506 507 1563 412 414 457 459 460 462 463 465 508 510 1564 1566 414 459 460 461 462 465 508 510 1566 414 459 460 461 462 465 508 509 510 1566 415 417 460 462 463 465 466 468 511 513 1567 1569 417 460 462 463 464 465 468 511 513 1569 417 460 461 462 463 464 465 468 511 512 513 1569 418 420 463 465 466 468 469 471 514 516 1570 1572 420 463 465 466 467 468 471 514 516 1572 420 463 464 465 466 467 468 471 514 515 516 1572 421 423 466 468 469 471 472 474 517 519 1573 1575 423 466 468 469 470 471 474 517 519 1575 423 466 467 468 469 470 471 474 517 518 519 1575 424 426 469 471 472 474 475 477 520 522 1576 1578 426 469 471 472 473 474 477 520 522 1578 426 469 470 471 472 473 474 477 520 521 522 1578 427 429 472 474 475 477 1579 1581 429 472 474 475 476 477 1581 429 472 473 474 475 476 477 1581 478 479 480 481 482 483 484 485 486 487 488 489 490 491 492 445 447 493 495 496 498 541 543 1597 1599 447 493 494 495 496 498 541 543 1599 447 493 494 495 496 497 498 541 542 543 1599 448 450 493 495 496 498 499 501 544 546 1600 1602 450 495 496 497 498 499 501 544 546 1602 450 495 496 497 498 499 500 501 544 545 546 1602 451 453 496 498 499 501 502 504 547 549 1603 1605 453 498 499 500 501 502 504 547 549 1605 453 498 499 500 501 502 503 504 547 548 549 1605 454 456 499 501 502 504 505 507 550 552 1606 1608 456 501 502 503 504 505 507 550 552 1608 456 501 502 503 504 505 506 507 550 551 552 1608 457 459 502 504 505 507 508 510 553 555 1609 1611 459 504 505 506 507 508 510 553 555 1611 459 504 505 506 507 508 509 510 553 554 555 1611 460 462 505 507 508 510 511 513 556 558 1612 1614 462 507 508 509 510 513 556 558 1614 462 507 508 509 510 513 556 557 558 1614 463 465 508 510 511 513 514 516 559 561 1615 1617 465 508 510 511 512 513 516 559 561 1617 465 508 509 510 511 512 513 516 559 560 561 1617 466 468 511 513 514 516 517 519 562 564 1618 1620 468 511 513 514 515 516 519 562 564 1620 468 511 512 513 514 515 516 519 562 563 564 1620 469 471 514 516 517 519 520 522 565 567 1621 1623 471 514 516 517 518 519 522 565 567 1623 471 514 515 516 517 518 519 522 565 566 567 1623 472 474 517 519 520 522 568 570 1624 1626 474 517 519 520 521 522 568 570 1626 474 517 518 519 520 521 522 568 569 570 1626 523 524 525 526 527 528 529 530 531 532 533 534 535 536 537 538 539 540 493 495 541 543 544 546 589 591 1645 1647 495 541 542 543 544 546 589 591 1647 495 541 542 543 544 545 546 589 590 591 1647 496 498 541 543 544 546 547 549 592 594 1648 1650 498 543 544 545 546 547 549 592 594 1650 498 543 544 545 546 547 548 549 592 593 594 1650 499 501 544 546 547 549 550 552 595 597 1651 1653 501 546 547 548 549 550 552 595 597 1653 501 546 547 548 549 550 551 552 595 596 597 1653 502 504 547 549 550 552 553 555 598 600 1654 1656 504 549 550 551 552 553 555 598 600 1656 504 549 550 551 552 553 554 555 598 599 600 1656 505 507 550 552 553 555 556 558 601 603 1657 1659 507 552 553 554 555 556 558 601 603 1659 507 552 553 554 555 556 557 558 601 602 603 1659 508 510 553 555 556 558 559 561 604 606 1660 1662 510 555 556 557 558 561 604 606 1662 510 555 556 557 558 561 604 605 606 1662 511 513 556 558 559 561 562 564 607 609 1663 1665 513 556 558 559 560 561 564 607 609 1665 513 556 557 558 559 560 561 564 607 608 609 1665 514 516 559 561 562 564 565 567 610 612 1666 1668 516 559 561 562 563 564 567 610 612 1668 516 559 560 561 562 563 564 567 610 611 612 1668 517 519 562 564 565 567 568 570 613 615 1669 1671 519 562 564 565 566 567 570 613 615 1671 519 562 563 564 565 566 567 570 613 614 615 1671 520 522 565 567 568 570 616 618 1672 1674 522 565 567 568 569 570 616 618 1674 522 565 566 567 568 569 570 616 617 618 1674 571 572 573 574 575 576 577 578 579 580 581 582 583 584 585 586 588 589 591 634 636 1690 1692 586 587 588 589 591 636 1692 586 587 588 589 590 591 636 1692 541 543 586 588 589 591 592 594 637 639 1693 1695 543 588 589 590 591 592 594 637 639 1695 543 588 589 590 591 592 593 594 637 638 639 1695 544 546 589 591 592 594 595 597 640 642 1696 1698 546 591 592 593 594 595 597 640 642 1698 546 591 592 593 594 595 596 597 640 641 642 1698 547 549 592 594 595 597 598 600 643 645 1699 1701 549 594 595 596 597 598 600 643 645 1701 549 594 595 596 597 598 599 600 643 644 645 1701 550 552 595 597 598 600 601 603 646 648 1702 1704 552 597 598 599 600 601 603 648 1704 552 597 598 599 600 601 602 603 648 1704 553 555 598 600 601 603 604 606 649 651 1705 1707 555 600 601 602 603 604 606 651 1707 555 600 601 602 603 604 605 606 651 1707 556 558 601 603 604 606 607 609 652 654 1708 1710 558 603 604 605 606 609 654 1710 558 603 604 605 606 609 654 1710 559 561 604 606 607 609 610 612 655 657 1711 1713 561 604 606 607 608 609 612 657 1713 561 604 605 606 607 608 609 612 657 1713 562 564 607 609 610 612 613 615 658 660 1714 1716 564 607 609 610 611 612 615 658 660 1716 564 607 608 609 610 611 612 615 658 659 660 1716 565 567 610 612 613 615 616 618 661 663 1717 1719 567 610 612 613 614 615 618 661 663 1719 567 610 611 612 613 614 615 618 661 662 663 1719 568 570 613 615 616 618 1720 1722 570 613 615 616 617 618 1722 570 613 614 615 616 617 618 1722 619 620 621 622 623 624 625 626 627 628 629 630 631 632 633 586 588 634 636 637 639 682 684 1738 1740 586 588 634 635 636 637 639 684 1740 586 587 588 634 635 636 637 638 639 684 1740 589 591 634 636 637 639 640 642 685 687 1741 1743 591 636 637 638 639 640 642 687 1743 591 636 637 638 639 640 641 642 687 1743 592 594 637 639 640 642 643 645 688 690 1744 1746 594 639 640 641 642 643 645 690 1746 594 639 640 641 642 643 644 645 690 1746 595 597 640 642 643 645 646 648 691 693 1747 1749 597 642 643 644 645 646 648 693 1749 597 642 643 644 645 646 647 648 693 1749 598 600 643 645 646 648 649 651 694 696 1750 1752 598 600 645 646 647 648 649 651 696 1752 598 599 600 645 646 647 648 649 650 651 696 1752 601 603 646 648 649 651 652 654 697 699 1753 1755 601 603 648 649 650 651 652 654 699 1755 601 602 603 648 649 650 651 652 653 654 699 1755 604 606 649 651 652 654 655 657 700 702 1756 1758 604 606 651 652 653 654 657 702 1758 604 605 606 651 652 653 654 657 702 1758 607 609 652 654 655 657 658 660 703 705 1759 1761 607 609 652 654 655 656 657 660 705 1761 607 608 609 652 653 654 655 656 657 660 705 1761 610 612 655 657 658 660 661 663 706 708 1762 1764 612 655 657 658 659 660 663 708 1764 612 655 656 657 658 659 660 663 708 1764 613 615 658 660 661 663 709 711 1765 1767 615 658 660 661 662 663 709 711 1767 615 658 659 660 661 662 663 709 710 711 1767 664 665 666 667 668 669 670 671 672 673 674 675 676 677 678 679 681 682 684 727 729 1783 1785 679 680 681 682 684 729 1785 679 680 681 682 683 684 729 1785 634 636 679 681 682 684 685 687 730 732 1786 1788 634 636 681 682 683 684 685 687 732 1788 634 635 636 681 682 683 684 685 686 687 732 1788 637 639 682 684 685 687 688 690 733 735 1789 1791 637 639 684 685 686 687 688 690 735 1791 637 638 639 684 685 686 687 688 689 690 735 1791 640 642 685 687 688 690 691 693 736 738 1792 1794 640 642 687 688 689 690 691 693 738 1794 640 641 642 687 688 689 690 691 692 693 738 1794 643 645 688 690 691 693 694 696 739 741 1795 1797 643 645 690 691 692 693 694 696 741 1797 643 644 645 690 691 692 693 694 695 696 741 1797 646 648 691 693 694 696 697 699 742 744 1798 1800 646 648 693 694 695 696 697 699 744 1800 646 647 648 693 694 695 696 697 698 699 744 1800 649 651 694 696 697 699 700 702 745 747 1801 1803 649 651 696 697 698 699 700 702 747 1803 649 650 651 696 697 698 699 700 701 702 747 1803 652 654 697 699 700 702 703 705 748 750 1804 1806 652 654 699 700 701 702 705 750 1806 652 653 654 699 700 701 702 705 750 1806 655 657 700 702 703 705 706 708 751 753 1807 1809 655 657 700 702 703 704 705 708 753 1809 655 656 657 700 701 702 703 704 705 708 753 1809 658 660 703 705 706 708 709 711 1810 1812 658 660 703 705 706 707 708 711 1812 658 659 660 703 704 705 706 707 708 711 1812 661 663 706 708 709 711 1813 1815 663 706 708 709 710 711 1815 663 706 707 708 709 710 711 1815 712 713 714 715 716 717 718 719 720 721 722 723 724 725 726 679 681 727 729 730 732 775 777 1831 1833 679 681 727 728 729 730 732 777 1833 679 680 681 727 728 729 730 731 732 777 1833 682 684 727 729 730 732 733 735 778 780 1834 1836 682 684 729 730 731 732 733 735 780 1836 682 683 684 729 730 731 732 733 734 735 780 1836 685 687 730 732 733 735 736 738 781 783 1837 1839 685 687 732 733 734 735 736 738 783 1839 685 686 687 732 733 734 735 736 737 738 783 1839 688 690 733 735 736 738 739 741 784 786 1840 1842 688 690 735 736 737 738 739 741 786 1842 688 689 690 735 736 737 738 739 740 741 786 1842 691 693 736 738 739 741 742 744 787 789 1843 1845 691 693 738 739 740 741 742 744 789 1845 691 692 693 738 739 740 741 742 743 744 789 1845 694 696 739 741 742 744 745 747 790 792 1846 1848 694 696 741 742 743 744 745 747 792 1848 694 695 696 741 742 743 744 745 746 747 792 1848 697 699 742 744 745 747 748 750 793 795 1849 1851 697 699 744 745 746 747 748 750 795 1851 697 698 699 744 745 746 747 748 749 750 795 1851 700 702 745 747 748 750 751 753 796 798 1852 1854 700 702 747 748 749 750 751 753 798 1854 700 701 702 747 748 749 750 751 752 753 798 1854 703 705 748 750 751 753 799 801 1855 1857 703 705 750 751 752 753 801 1857 703 704 705 750 751 752 753 801 1857 754 755 756 757 758 759 760 761 762 763 764 765 766 767 768 769 770 771 772 774 775 777 820 822 1876 1878 772 773 774 775 777 822 1878 772 773 774 775 776 777 822 1878 727 729 772 774 775 777 778 780 823 825 1879 1881 727 729 774 775 776 777 778 780 825 1881 727 728 729 774 775 776 777 778 779 780 825 1881 730 732 775 777 778 780 781 783 826 828 1882 1884 730 732 777 778 779 780 781 783 828 1884 730 731 732 777 778 779 780 781 782 783 828 1884 733 735 778 780 781 783 784 786 829 831 1885 1887 733 735 780 781 782 783 784 786 831 1887 733 734 735 780 781 782 783 784 785 786 831 1887 736 738 781 783 784 786 787 789 832 834 1888 1890 736 738 783 784 785 786 787 789 834 1890 736 737 738 783 784 785 786 787 788 789 834 1890 739 741 784 786 787 789 790 792 835 837 1891 1893 739 741 786 787 788 789 790 792 837 1893 739 740 741 786 787 788 789 790 791 792 837 1893 742 744 787 789 790 792 793 795 838 840 1894 1896 742 744 789 790 791 792 793 795 840 1896 742 743 744 789 790 791 792 793 794 795 840 1896 745 747 790 792 793 795 796 798 841 843 1897 1899 745 747 792 793 794 795 796 798 843 1899 745 746 747 792 793 794 795 796 797 798 843 1899 748 750 793 795 796 798 799 801 1900 1902 748 750 795 796 797 798 799 801 1902 748 749 750 795 796 797 798 799 800 801 1902 751 753 796 798 799 801 1903 1905 751 753 798 799 800 801 1905 751 752 753 798 799 800 801 1905 802 803 804 805 806 807 808 809 810 811 812 813 814 815 816 817 818 819 772 774 820 822 823 825 868 870 1924 1926 772 774 820 821 822 823 825 870 1926 772 773 774 820 821 822 823 824 825 870 1926 775 777 820 822 823 825 826 828 871 873 1927 1929 775 777 822 823 824 825 826 828 873 1929 775 776 777 822 823 824 825 826 827 828 873 1929 778 780 823 825 826 828 829 831 874 876 1930 1932 778 780 825 826 827 828 829 831 876 1932 778 779 780 825 826 827 828 829 830 831 876 1932 781 783 826 828 829 831 832 834 877 879 1933 1935 781 783 828 829 830 831 832 834 879 1935 781 782 783 828 829 830 831 832 833 834 879 1935 784 786 829 831 832 834 835 837 880 882 1936 1938 784 786 831 832 833 834 835 837 882 1938 784 785 786 831 832 833 834 835 836 837 882 1938 787 789 832 834 835 837 838 840 883 885 1939 1941 787 789 834 835 836 837 838 840 885 1941 787 788 789 834 835 836 837 838 839 840 885 1941 790 792 835 837 838 840 841 843 886 888 1942 1944 790 792 837 838 839 840 841 843 888 1944 790 791 792 837 838 839 840 841 842 843 888 1944 793 795 838 840 841 843 889 891 1945 1947 793 795 840 841 842 843 891 1947 793 794 795 840 841 842 843 891 1947 844 845 846 847 848 849 850 851 852 853 854 855 856 857 858 859 860 861 862 863 864 865 866 867 820 822 868 870 871 873 916 918 1972 1974 820 822 868 869 870 871 873 918 1974 820 821 822 868 869 870 871 872 873 918 1974 823 825 868 870 871 873 874 876 919 921 1975 1977 823 825 870 871 872 873 874 876 921 1977 823 824 825 870 871 872 873 874 875 876 921 1977 826 828 871 873 874 876 877 879 922 924 1978 1980 826 828 873 874 875 876 877 879 924 1980 826 827 828 873 874 875 876 877 878 879 924 1980 829 831 874 876 877 879 880 882 925 927 1981 1983 829 831 876 877 878 879 880 882 927 1983 829 830 831 876 877 878 879 880 881 882 927 1983 832 834 877 879 880 882 883 885 928 930 1984 1986 832 834 879 880 881 882 883 885 930 1986 832 833 834 879 880 881 882 883 884 885 930 1986 835 837 880 882 883 885 886 888 931 933 1987 1989 835 837 882 883 884 885 886 888 933 1989 835 836 837 882 883 884 885 886 887 888 933 1989 838 840 883 885 886 888 889 891 1990 1992 838 840 885 886 887 888 889 891 1992 838 839 840 885 886 887 888 889 890 891 1992 841 843 886 888 889 891 1993 1995 841 843 888 889 890 891 1995 841 842 843 888 889 890 891 1995 892 893 894 895 896 897 898 899 900 901 902 903 904 905 906 907 908 909 910 911 912 913 914 915 868 870 916 918 919 921 2020 2022 868 870 916 917 918 919 921 2022 868 869 870 916 917 918 919 920 921 2022 871 873 916 918 919 921 922 924 967 969 2023 2025 871 873 918 919 920 921 922 924 969 2025 871 872 873 918 919 920 921 922 923 924 969 2025 874 876 919 921 922 924 925 927 970 972 2026 2028 874 876 921 922 923 924 925 927 972 2028 874 875 876 921 922 923 924 925 926 927 972 2028 877 879 922 924 925 927 928 930 973 975 2029 2031 877 879 924 925 926 927 928 930 975 2031 877 878 879 924 925 926 927 928 929 930 975 2031 880 882 925 927 928 930 931 933 976 978 2032 2034 880 882 927 928 929 930 931 933 978 2034 880 881 882 927 928 929 930 931 932 933 978 2034 883 885 928 930 931 933 979 981 2035 2037 883 885 930 931 932 933 981 2037 883 884 885 930 931 932 933 981 2037 934 935 936 937 938 939 940 941 942 943 944 945 946 947 948 949 950 951 952 953 954 955 956 957 958 959 960 961 962 963 964 965 966 919 921 967 969 970 972 2071 2073 919 921 967 968 969 970 972 2073 919 920 921 967 968 969 970 971 972 2073 922 924 967 969 970 972 973 975 1018 1020 2074 2076 922 924 969 970 971 972 973 975 1020 2076 922 923 924 969 970 971 972 973 974 975 1020 2076 925 927 970 972 973 975 976 978 1021 1023 2077 2079 925 927 972 973 974 975 976 978 1023 2079 925 926 927 972 973 974 975 976 977 978 1023 2079 928 930 973 975 976 978 979 981 1024 1026 2080 2082 928 930 975 976 977 978 979 981 1026 2082 928 929 930 975 976 977 978 979 980 981 1026 2082 931 933 976 978 979 981 2083 2085 931 933 978 979 980 981 2085 931 932 933 978 979 980 981 2085 982 983 984 985 986 987 988 989 990 991 992 993 994 995 996 997 998 999 1000 1001 1002 1003 1004 1005 1006 1007 1008 1009 1010 1011 1012 1013 1014 1015 1016 1017 970 972 1018 1020 1021 1023 1066 1068 2122 2124 970 972 1018 1019 1020 1021 1023 1068 2124 970 971 972 1018 1019 1020 1021 1022 1023 1068 2124 973 975 1018 1020 1021 1023 1024 1026 1069 1071 2125 2127 973 975 1020 1021 1022 1023 1024 1026 1071 2127 973 974 975 1020 1021 1022 1023 1024 1025 1026 1071 2127 976 978 1021 1023 1024 1026 2128 2130 976 978 1023 1024 1025 1026 2130 976 977 978 1023 1024 1025 1026 2130 1027 1028 1029 1030 1031 1032 1033 1034 1035 1036 1037 1038 1039 1040 1041 1042 1043 1044 1045 1046 1047 1048 1049 1050 1051 1052 1053 1054 1055 1056 1057 1058 1059 1060 1061 1062 1063 1064 1065 1018 1020 1066 1068 1069 1071 2170 2172 1018 1020 1066 1067 1068 1069 1071 2172 1018 1019 1020 1066 1067 1068 1069 1070 1071 2172 1021 1023 1066 1068 1069 1071 2173 2175 1021 1023 1068 1069 1070 1071 2175 1021 1022 1023 1068 1069 1070 1071 2175 1072 1073 1074 1075 1076 1077 1078 1079 1080 1081 1082 1083 1084 1085 1086 1087 1088 1089 1090 1091 1092 1093 1094 1095 1096 1097 1098 1099 1100 1101 1102 1103 1104 1105 1106 1107 1108 1109 1110 1111 1112 1113 1114 1115 1116 1117 1118 1119 1120 1121 1122 1123 1124 1125 1126 1127 1128 1129 1130 1131 1132 1133 1134 1135 1136 1137 1138 1139 1140 1141 1142 1143 1144 1145 1146 1147 1148 1149 1150 1151 1152 1153 1154 1155 1156 1157 1158 1159 1160 1161 1162 1163 1164 1165 1166 1167 1168 1169 1170 1171 1172 1173 1174 1175 1176 1177 1178 1179 1180 1181 1182 1183 1184 1185 1186 1187 1188 1189 1190 1191 1192 1193 1194 1195 1196 1197 1198 1199 1200 1201 1202 1203 1204 1205 1206 1207 1208 1209 1210 1211 1212 1213 1214 1215 1216 1217 1218 1219 1220 1221 1222 1223 1224 1225 1226 1227 1228 1229 1230 1231 1232 1233 1234 1235 1236 133 135 1237 1239 1240 1242 1285 1287 133 135 1237 1238 1239 1242 1285 1287 133 134 135 1237 1238 1239 1242 1285 1286 1287 136 138 1237 1239 1240 1242 1243 1245 1288 1290 2344 2346 136 138 1237 1239 1240 1241 1242 1245 1288 1290 2346 136 137 138 1237 1238 1239 1240 1241 1242 1245 1288 1289 1290 2346 139 141 1240 1242 1243 1245 1246 1248 1291 1293 2347 2349 139 141 1240 1242 1243 1244 1245 1248 1291 1293 2349 139 140 141 1240 1241 1242 1243 1244 1245 1248 1291 1292 1293 2349 142 144 1243 1245 1246 1248 1294 1296 2350 2352 142 144 1243 1245 1246 1247 1248 1294 1296 2352 142 143 144 1243 1244 1245 1246 1247 1248 1294 1295 1296 2352 1249 1250 1251 1252 1253 1254 1255 1256 1257 1258 1259 1260 1261 1262 1263 160 162 1264 1266 1267 1269 1312 1314 2368 2370 160 162 1264 1265 1266 1269 1312 1314 2370 160 161 162 1264 1265 1266 1269 1312 1313 1314 2370 163 165 1264 1266 1267 1269 1270 1272 1315 1317 163 165 1264 1266 1267 1268 1269 1272 1315 1317 163 164 165 1264 1265 1266 1267 1268 1269 1272 1315 1316 1317 166 168 1267 1269 1270 1272 1273 1275 1318 1320 166 168 1267 1269 1270 1271 1272 1275 1318 1320 166 167 168 1267 1268 1269 1270 1271 1272 1275 1318 1319 1320 169 171 1270 1272 1273 1275 1276 1278 1321 1323 169 171 1270 1272 1273 1274 1275 1278 1321 1323 169 170 171 1270 1271 1272 1273 1274 1275 1278 1321 1322 1323 172 174 1273 1275 1276 1278 1279 1281 1324 1326 172 174 1273 1275 1276 1277 1278 1281 1324 1326 172 173 174 1273 1274 1275 1276 1277 1278 1281 1324 1325 1326 175 177 1276 1278 1279 1281 1282 1284 1327 1329 2383 2385 175 177 1276 1278 1279 1280 1281 1284 1327 1329 2385 175 176 177 1276 1277 1278 1279 1280 1281 1284 1327 1328 1329 2385 178 180 1279 1281 1282 1284 1285 1287 1330 1332 2386 2388 178 180 1279 1281 1282 1283 1284 1285 1287 1330 1332 2388 178 179 180 1279 1280 1281 1282 1283 1284 1285 1286 1287 1330 1331 1332 2388 181 183 1237 1239 1282 1284 1285 1287 1288 1290 1333 1335 2389 2391 181 183 1239 1284 1285 1286 1287 1290 1333 1335 2391 181 182 183 1239 1284 1285 1286 1287 1290 1333 1334 1335 2391 184 186 1240 1242 1285 1287 1288 1290 1291 1293 1336 1338 2392 2394 184 186 1242 1285 1287 1288 1289 1290 1293 1336 1338 2394 184 185 186 1242 1285 1286 1287 1288 1289 1290 1293 1336 1337 1338 2394 187 189 1243 1245 1288 1290 1291 1293 1294 1296 1339 1341 2395 2397 187 189 1245 1288 1290 1291 1292 1293 1296 1339 1341 2397 187 188 189 1245 1288 1289 1290 1291 1292 1293 1296 1339 1340 1341 2397 190 192 1246 1248 1291 1293 1294 1296 1342 1344 2398 2400 190 192 1248 1291 1293 1294 1295 1296 1342 1344 2400 190 191 192 1248 1291 1292 1293 1294 1295 1296 1342 1343 1344 2400 1297 1298 1299 1300 1301 1302 1303 1304 1305 1306 1307 1308 1309 1310 1311 208 210 1264 1266 1312 1314 1315 1317 1360 1362 2416 2418 208 210 1266 1312 1313 1314 1315 1317 1360 1362 2418 208 209 210 1266 1312 1313 1314 1315 1316 1317 1360 1361 1362 2418 211 213 1267 1269 1312 1314 1315 1317 1318 1320 1363 1365 2419 2421 211 213 1269 1314 1315 1316 1317 1318 1320 1363 1365 2421 211 212 213 1269 1314 1315 1316 1317 1318 1319 1320 1363 1364 1365 2421 214 216 1270 1272 1315 1317 1318 1320 1321 1323 1366 1368 2422 2424 214 216 1272 1317 1318 1319 1320 1323 1366 1368 2424 214 215 216 1272 1317 1318 1319 1320 1323 1366 1367 1368 2424 217 219 1273 1275 1318 1320 1321 1323 1324 1326 1369 1371 2425 2427 217 219 1275 1318 1320 1321 1322 1323 1326 1369 1371 2427 217 218 219 1275 1318 1319 1320 1321 1322 1323 1326 1369 1370 1371 2427 220 222 1276 1278 1321 1323 1324 1326 1327 1329 1372 1374 2428 2430 220 222 1278 1321 1323 1324 1325 1326 1329 1372 1374 2430 220 221 222 1278 1321 1322 1323 1324 1325 1326 1329 1372 1373 1374 2430 223 225 1279 1281 1324 1326 1327 1329 1330 1332 1375 1377 2431 2433 223 225 1281 1324 1326 1327 1328 1329 1332 1375 1377 2433 223 224 225 1281 1324 1325 1326 1327 1328 1329 1332 1375 1376 1377 2433 226 228 1282 1284 1327 1329 1330 1332 1333 1335 1378 1380 2434 2436 226 228 1284 1327 1329 1330 1331 1332 1335 1378 1380 2436 226 227 228 1284 1327 1328 1329 1330 1331 1332 1335 1378 1379 1380 2436 229 231 1285 1287 1330 1332 1333 1335 1336 1338 1381 1383 2437 2439 229 231 1287 1330 1332 1333 1334 1335 1338 1381 1383 2439 229 230 231 1287 1330 1331 1332 1333 1334 1335 1338 1381 1382 1383 2439 232 234 1288 1290 1333 1335 1336 1338 1339 1341 1384 1386 2440 2442 232 234 1290 1333 1335 1336 1337 1338 1341 1384 1386 2442 232 233 234 1290 1333 1334 1335 1336 1337 1338 1341 1384 1385 1386 2442 235 237 1291 1293 1336 1338 1339 1341 1342 1344 1387 1389 2443 2445 235 237 1293 1336 1338 1339 1340 1341 1344 1387 1389 2445 235 236 237 1293 1336 1337 1338 1339 1340 1341 1344 1387 1388 1389 2445 238 240 1294 1296 1339 1341 1342 1344 1390 1392 2446 2448 238 240 1296 1339 1341 1342 1343 1344 1390 1392 2448 238 239 240 1296 1339 1340 1341 1342 1343 1344 1390 1391 1392 2448 1345 1346 1347 1348 1349 1350 1351 1352 1353 1354 1355 1356 1357 1358 1359 256 258 1312 1314 1360 1362 1363 1365 1408 1410 2464 2466 256 258 1314 1360 1361 1362 1363 1365 1408 1410 2466 256 257 258 1314 1360 1361 1362 1363 1364 1365 1408 1409 1410 2466 259 261 1315 1317 1360 1362 1363 1365 1366 1368 1411 1413 2467 2469 259 261 1317 1362 1363 1364 1365 1366 1368 1411 1413 2469 259 260 261 1317 1362 1363 1364 1365 1366 1367 1368 1411 1412 1413 2469 262 264 1318 1320 1363 1365 1366 1368 1369 1371 1414 1416 2470 2472 262 264 1320 1365 1366 1367 1368 1369 1371 1414 1416 2472 262 263 264 1320 1365 1366 1367 1368 1369 1370 1371 1414 1415 1416 2472 265 267 1321 1323 1366 1368 1369 1371 1372 1374 1417 1419 2473 2475 265 267 1323 1368 1369 1370 1371 1374 1417 1419 2475 265 266 267 1323 1368 1369 1370 1371 1374 1417 1418 1419 2475 268 270 1324 1326 1369 1371 1372 1374 1375 1377 1420 1422 2476 2478 268 270 1326 1369 1371 1372 1373 1374 1377 1420 1422 2478 268 269 270 1326 1369 1370 1371 1372 1373 1374 1377 1420 1421 1422 2478 271 273 1327 1329 1372 1374 1375 1377 1378 1380 1423 1425 2479 2481 271 273 1329 1372 1374 1375 1376 1377 1380 1423 1425 2481 271 272 273 1329 1372 1373 1374 1375 1376 1377 1380 1423 1424 1425 2481 274 276 1330 1332 1375 1377 1378 1380 1381 1383 1426 1428 2482 2484 274 276 1332 1375 1377 1378 1379 1380 1383 1426 1428 2484 274 275 276 1332 1375 1376 1377 1378 1379 1380 1383 1426 1427 1428 2484 277 279 1333 1335 1378 1380 1381 1383 1384 1386 1429 1431 2485 2487 277 279 1335 1378 1380 1381 1382 1383 1386 1429 1431 2487 277 278 279 1335 1378 1379 1380 1381 1382 1383 1386 1429 1430 1431 2487 280 282 1336 1338 1381 1383 1384 1386 1387 1389 1432 1434 2488 2490 280 282 1338 1381 1383 1384 1385 1386 1389 1432 1434 2490 280 281 282 1338 1381 1382 1383 1384 1385 1386 1389 1432 1433 1434 2490 283 285 1339 1341 1384 1386 1387 1389 1390 1392 1435 1437 2491 2493 283 285 1341 1384 1386 1387 1388 1389 1392 1435 1437 2493 283 284 285 1341 1384 1385 1386 1387 1388 1389 1392 1435 1436 1437 2493 286 288 1342 1344 1387 1389 1390 1392 2494 2496 286 288 1344 1387 1389 1390 1391 1392 2496 286 287 288 1344 1387 1388 1389 1390 1391 1392 2496 1393 1394 1395 1396 1397 1398 1399 1400 1401 1402 1403 1404 1405 1406 1407 304 306 1360 1362 1408 1410 1411 1413 1456 1458 2512 2514 304 306 1362 1408 1409 1410 1411 1413 1456 1458 2514 304 305 306 1362 1408 1409 1410 1411 1412 1413 1456 1457 1458 2514 307 309 1363 1365 1408 1410 1411 1413 1414 1416 1459 1461 2515 2517 307 309 1365 1410 1411 1412 1413 1414 1416 1459 1461 2517 307 308 309 1365 1410 1411 1412 1413 1414 1415 1416 1459 1460 1461 2517 310 312 1366 1368 1411 1413 1414 1416 1417 1419 1462 1464 2518 2520 310 312 1368 1413 1414 1415 1416 1417 1419 1462 1464 2520 310 311 312 1368 1413 1414 1415 1416 1417 1418 1419 1462 1463 1464 2520 313 315 1369 1371 1414 1416 1417 1419 1420 1422 1465 1467 2521 2523 313 315 1371 1416 1417 1418 1419 1420 1422 1465 1467 2523 313 314 315 1371 1416 1417 1418 1419 1420 1421 1422 1465 1466 1467 2523 316 318 1372 1374 1417 1419 1420 1422 1423 1425 1468 1470 2524 2526 316 318 1374 1419 1420 1421 1422 1425 1468 1470 2526 316 317 318 1374 1419 1420 1421 1422 1425 1468 1469 1470 2526 319 321 1375 1377 1420 1422 1423 1425 1426 1428 1471 1473 2527 2529 319 321 1377 1420 1422 1423 1424 1425 1428 1471 1473 2529 319 320 321 1377 1420 1421 1422 1423 1424 1425 1428 1471 1472 1473 2529 322 324 1378 1380 1423 1425 1426 1428 1429 1431 1474 1476 2530 2532 322 324 1380 1423 1425 1426 1427 1428 1431 1474 1476 2532 322 323 324 1380 1423 1424 1425 1426 1427 1428 1431 1474 1475 1476 2532 325 327 1381 1383 1426 1428 1429 1431 1432 1434 1477 1479 2533 2535 325 327 1383 1426 1428 1429 1430 1431 1434 1477 1479 2535 325 326 327 1383 1426 1427 1428 1429 1430 1431 1434 1477 1478 1479 2535 328 330 1384 1386 1429 1431 1432 1434 1435 1437 1480 1482 2536 2538 328 330 1386 1429 1431 1432 1433 1434 1437 1480 1482 2538 328 329 330 1386 1429 1430 1431 1432 1433 1434 1437 1480 1481 1482 2538 331 333 1387 1389 1432 1434 1435 1437 1483 1485 2539 2541 331 333 1389 1432 1434 1435 1436 1437 1483 1485 2541 331 332 333 1389 1432 1433 1434 1435 1436 1437 1483 1484 1485 2541 1438 1439 1440 1441 1442 1443 1444 1445 1446 1447 1448 1449 1450 1451 1452 1453 1454 1455 352 354 1408 1410 1456 1458 1459 1461 1504 1506 2560 2562 352 354 1410 1456 1457 1458 1459 1461 1504 1506 2562 352 353 354 1410 1456 1457 1458 1459 1460 1461 1504 1505 1506 2562 355 357 1411 1413 1456 1458 1459 1461 1462 1464 1507 1509 2563 2565 355 357 1413 1458 1459 1460 1461 1462 1464 1507 1509 2565 355 356 357 1413 1458 1459 1460 1461 1462 1463 1464 1507 1508 1509 2565 358 360 1414 1416 1459 1461 1462 1464 1465 1467 1510 1512 2566 2568 358 360 1416 1461 1462 1463 1464 1465 1467 1510 1512 2568 358 359 360 1416 1461 1462 1463 1464 1465 1466 1467 1510 1511 1512 2568 361 363 1417 1419 1462 1464 1465 1467 1468 1470 1513 1515 2569 2571 361 363 1419 1464 1465 1466 1467 1468 1470 1513 1515 2571 361 362 363 1419 1464 1465 1466 1467 1468 1469 1470 1513 1514 1515 2571 364 366 1420 1422 1465 1467 1468 1470 1471 1473 1516 1518 2572 2574 364 366 1422 1467 1468 1469 1470 1473 1516 1518 2574 364 365 366 1422 1467 1468 1469 1470 1473 1516 1517 1518 2574 367 369 1423 1425 1468 1470 1471 1473 1474 1476 1519 1521 2575 2577 367 369 1425 1468 1470 1471 1472 1473 1476 1519 1521 2577 367 368 369 1425 1468 1469 1470 1471 1472 1473 1476 1519 1520 1521 2577 370 372 1426 1428 1471 1473 1474 1476 1477 1479 1522 1524 2578 2580 370 372 1428 1471 1473 1474 1475 1476 1479 1522 1524 2580 370 371 372 1428 1471 1472 1473 1474 1475 1476 1479 1522 1523 1524 2580 373 375 1429 1431 1474 1476 1477 1479 1480 1482 1525 1527 2581 2583 373 375 1431 1474 1476 1477 1478 1479 1482 1525 1527 2583 373 374 375 1431 1474 1475 1476 1477 1478 1479 1482 1525 1526 1527 2583 376 378 1432 1434 1477 1479 1480 1482 1483 1485 1528 1530 2584 2586 376 378 1434 1477 1479 1480 1481 1482 1485 1528 1530 2586 376 377 378 1434 1477 1478 1479 1480 1481 1482 1485 1528 1529 1530 2586 379 381 1435 1437 1480 1482 1483 1485 1531 1533 2587 2589 379 381 1437 1480 1482 1483 1484 1485 1531 1533 2589 379 380 381 1437 1480 1481 1482 1483 1484 1485 1531 1532 1533 2589 1486 1487 1488 1489 1490 1491 1492 1493 1494 1495 1496 1497 1498 1499 1500 397 399 1501 1503 1504 1506 1549 1551 2605 2607 397 399 1501 1502 1503 1506 1549 1551 2607 397 398 399 1501 1502 1503 1506 1549 1550 1551 2607 400 402 1456 1458 1501 1503 1504 1506 1507 1509 1552 1554 2608 2610 400 402 1458 1501 1503 1504 1505 1506 1507 1509 1552 1554 2610 400 401 402 1458 1501 1502 1503 1504 1505 1506 1507 1508 1509 1552 1553 1554 2610 403 405 1459 1461 1504 1506 1507 1509 1510 1512 1555 1557 2611 2613 403 405 1461 1506 1507 1508 1509 1510 1512 1555 1557 2613 403 404 405 1461 1506 1507 1508 1509 1510 1511 1512 1555 1556 1557 2613 406 408 1462 1464 1507 1509 1510 1512 1513 1515 1558 1560 2614 2616 406 408 1464 1509 1510 1511 1512 1513 1515 1558 1560 2616 406 407 408 1464 1509 1510 1511 1512 1513 1514 1515 1558 1559 1560 2616 409 411 1465 1467 1510 1512 1513 1515 1516 1518 1561 1563 2617 2619 409 411 1467 1512 1513 1514 1515 1516 1518 1561 1563 2619 409 410 411 1467 1512 1513 1514 1515 1516 1517 1518 1561 1562 1563 2619 412 414 1468 1470 1513 1515 1516 1518 1519 1521 1564 1566 2620 2622 412 414 1470 1515 1516 1517 1518 1521 1564 1566 2622 412 413 414 1470 1515 1516 1517 1518 1521 1564 1565 1566 2622 415 417 1471 1473 1516 1518 1519 1521 1522 1524 1567 1569 2623 2625 415 417 1473 1516 1518 1519 1520 1521 1524 1567 1569 2625 415 416 417 1473 1516 1517 1518 1519 1520 1521 1524 1567 1568 1569 2625 418 420 1474 1476 1519 1521 1522 1524 1525 1527 1570 1572 2626 2628 418 420 1476 1519 1521 1522 1523 1524 1527 1570 1572 2628 418 419 420 1476 1519 1520 1521 1522 1523 1524 1527 1570 1571 1572 2628 421 423 1477 1479 1522 1524 1525 1527 1528 1530 1573 1575 2629 2631 421 423 1479 1522 1524 1525 1526 1527 1530 1573 1575 2631 421 422 423 1479 1522 1523 1524 1525 1526 1527 1530 1573 1574 1575 2631 424 426 1480 1482 1525 1527 1528 1530 1531 1533 1576 1578 2632 2634 424 426 1482 1525 1527 1528 1529 1530 1533 1576 1578 2634 424 425 426 1482 1525 1526 1527 1528 1529 1530 1533 1576 1577 1578 2634 427 429 1483 1485 1528 1530 1531 1533 1579 1581 2635 2637 427 429 1485 1528 1530 1531 1532 1533 1579 1581 2637 427 428 429 1485 1528 1529 1530 1531 1532 1533 1579 1580 1581 2637 1534 1535 1536 1537 1538 1539 1540 1541 1542 1543 1544 1545 1546 1547 1548 445 447 1501 1503 1549 1551 1552 1554 1597 1599 2653 2655 445 447 1503 1549 1550 1551 1552 1554 1597 1599 2655 445 446 447 1503 1549 1550 1551 1552 1553 1554 1597 1598 1599 2655 448 450 1504 1506 1549 1551 1552 1554 1555 1557 1600 1602 2656 2658 448 450 1506 1551 1552 1553 1554 1555 1557 1600 1602 2658 448 449 450 1506 1551 1552 1553 1554 1555 1556 1557 1600 1601 1602 2658 451 453 1507 1509 1552 1554 1555 1557 1558 1560 1603 1605 2659 2661 451 453 1509 1554 1555 1556 1557 1558 1560 1603 1605 2661 451 452 453 1509 1554 1555 1556 1557 1558 1559 1560 1603 1604 1605 2661 454 456 1510 1512 1555 1557 1558 1560 1561 1563 1606 1608 2662 2664 454 456 1512 1557 1558 1559 1560 1561 1563 1606 1608 2664 454 455 456 1512 1557 1558 1559 1560 1561 1562 1563 1606 1607 1608 2664 457 459 1513 1515 1558 1560 1561 1563 1564 1566 1609 1611 2665 2667 457 459 1515 1560 1561 1562 1563 1564 1566 1609 1611 2667 457 458 459 1515 1560 1561 1562 1563 1564 1565 1566 1609 1610 1611 2667 460 462 1516 1518 1561 1563 1564 1566 1567 1569 1612 1614 2668 2670 460 462 1518 1563 1564 1565 1566 1569 1612 1614 2670 460 461 462 1518 1563 1564 1565 1566 1569 1612 1613 1614 2670 463 465 1519 1521 1564 1566 1567 1569 1570 1572 1615 1617 2671 2673 463 465 1521 1564 1566 1567 1568 1569 1572 1615 1617 2673 463 464 465 1521 1564 1565 1566 1567 1568 1569 1572 1615 1616 1617 2673 466 468 1522 1524 1567 1569 1570 1572 1573 1575 1618 1620 2674 2676 466 468 1524 1567 1569 1570 1571 1572 1575 1618 1620 2676 466 467 468 1524 1567 1568 1569 1570 1571 1572 1575 1618 1619 1620 2676 469 471 1525 1527 1570 1572 1573 1575 1576 1578 1621 1623 2677 2679 469 471 1527 1570 1572 1573 1574 1575 1578 1621 1623 2679 469 470 471 1527 1570 1571 1572 1573 1574 1575 1578 1621 1622 1623 2679 472 474 1528 1530 1573 1575 1576 1578 1579 1581 1624 1626 2680 2682 472 474 1530 1573 1575 1576 1577 1578 1581 1624 1626 2682 472 473 474 1530 1573 1574 1575 1576 1577 1578 1581 1624 1625 1626 2682 475 477 1531 1533 1576 1578 1579 1581 2683 2685 475 477 1533 1576 1578 1579 1580 1581 2685 475 476 477 1533 1576 1577 1578 1579 1580 1581 2685 1582 1583 1584 1585 1586 1587 1588 1589 1590 1591 1592 1593 1594 1595 1596 493 495 1549 1551 1597 1599 1600 1602 1645 1647 2701 2703 493 495 1551 1597 1598 1599 1600 1602 1645 1647 2703 493 494 495 1551 1597 1598 1599 1600 1601 1602 1645 1646 1647 2703 496 498 1552 1554 1597 1599 1600 1602 1603 1605 1648 1650 2704 2706 496 498 1554 1599 1600 1601 1602 1603 1605 1648 1650 2706 496 497 498 1554 1599 1600 1601 1602 1603 1604 1605 1648 1649 1650 2706 499 501 1555 1557 1600 1602 1603 1605 1606 1608 1651 1653 2707 2709 499 501 1557 1602 1603 1604 1605 1606 1608 1651 1653 2709 499 500 501 1557 1602 1603 1604 1605 1606 1607 1608 1651 1652 1653 2709 502 504 1558 1560 1603 1605 1606 1608 1609 1611 1654 1656 2710 2712 502 504 1560 1605 1606 1607 1608 1609 1611 1654 1656 2712 502 503 504 1560 1605 1606 1607 1608 1609 1610 1611 1654 1655 1656 2712 505 507 1561 1563 1606 1608 1609 1611 1612 1614 1657 1659 2713 2715 505 507 1563 1608 1609 1610 1611 1612 1614 1657 1659 2715 505 506 507 1563 1608 1609 1610 1611 1612 1613 1614 1657 1658 1659 2715 508 510 1564 1566 1609 1611 1612 1614 1615 1617 1660 1662 2716 2718 508 510 1566 1611 1612 1613 1614 1617 1660 1662 2718 508 509 510 1566 1611 1612 1613 1614 1617 1660 1661 1662 2718 511 513 1567 1569 1612 1614 1615 1617 1618 1620 1663 1665 2719 2721 511 513 1569 1612 1614 1615 1616 1617 1620 1663 1665 2721 511 512 513 1569 1612 1613 1614 1615 1616 1617 1620 1663 1664 1665 2721 514 516 1570 1572 1615 1617 1618 1620 1621 1623 1666 1668 2722 2724 514 516 1572 1615 1617 1618 1619 1620 1623 1666 1668 2724 514 515 516 1572 1615 1616 1617 1618 1619 1620 1623 1666 1667 1668 2724 517 519 1573 1575 1618 1620 1621 1623 1624 1626 1669 1671 2725 2727 517 519 1575 1618 1620 1621 1622 1623 1626 1669 1671 2727 517 518 519 1575 1618 1619 1620 1621 1622 1623 1626 1669 1670 1671 2727 520 522 1576 1578 1621 1623 1624 1626 1672 1674 2728 2730 520 522 1578 1621 1623 1624 1625 1626 1672 1674 2730 520 521 522 1578 1621 1622 1623 1624 1625 1626 1672 1673 1674 2730 1627 1628 1629 1630 1631 1632 1633 1634 1635 1636 1637 1638 1639 1640 1641 1642 1643 1644 541 543 1597 1599 1645 1647 1648 1650 1693 1695 2749 2751 541 543 1599 1645 1646 1647 1648 1650 1693 1695 2751 541 542 543 1599 1645 1646 1647 1648 1649 1650 1693 1694 1695 2751 544 546 1600 1602 1645 1647 1648 1650 1651 1653 1696 1698 2752 2754 544 546 1602 1647 1648 1649 1650 1651 1653 1696 1698 2754 544 545 546 1602 1647 1648 1649 1650 1651 1652 1653 1696 1697 1698 2754 547 549 1603 1605 1648 1650 1651 1653 1654 1656 1699 1701 2755 2757 547 549 1605 1650 1651 1652 1653 1654 1656 1699 1701 2757 547 548 549 1605 1650 1651 1652 1653 1654 1655 1656 1699 1700 1701 2757 550 552 1606 1608 1651 1653 1654 1656 1657 1659 1702 1704 2758 2760 550 552 1608 1653 1654 1655 1656 1657 1659 1702 1704 2760 550 551 552 1608 1653 1654 1655 1656 1657 1658 1659 1702 1703 1704 2760 553 555 1609 1611 1654 1656 1657 1659 1660 1662 1705 1707 2761 2763 553 555 1611 1656 1657 1658 1659 1660 1662 1705 1707 2763 553 554 555 1611 1656 1657 1658 1659 1660 1661 1662 1705 1706 1707 2763 556 558 1612 1614 1657 1659 1660 1662 1663 1665 1708 1710 2764 2766 556 558 1614 1659 1660 1661 1662 1665 1708 1710 2766 556 557 558 1614 1659 1660 1661 1662 1665 1708 1709 1710 2766 559 561 1615 1617 1660 1662 1663 1665 1666 1668 1711 1713 2767 2769 559 561 1617 1660 1662 1663 1664 1665 1668 1711 1713 2769 559 560 561 1617 1660 1661 1662 1663 1664 1665 1668 1711 1712 1713 2769 562 564 1618 1620 1663 1665 1666 1668 1669 1671 1714 1716 2770 2772 562 564 1620 1663 1665 1666 1667 1668 1671 1714 1716 2772 562 563 564 1620 1663 1664 1665 1666 1667 1668 1671 1714 1715 1716 2772 565 567 1621 1623 1666 1668 1669 1671 1672 1674 1717 1719 2773 2775 565 567 1623 1666 1668 1669 1670 1671 1674 1717 1719 2775 565 566 567 1623 1666 1667 1668 1669 1670 1671 1674 1717 1718 1719 2775 568 570 1624 1626 1669 1671 1672 1674 1720 1722 2776 2778 568 570 1626 1669 1671 1672 1673 1674 1720 1722 2778 568 569 570 1626 1669 1670 1671 1672 1673 1674 1720 1721 1722 2778 1675 1676 1677 1678 1679 1680 1681 1682 1683 1684 1685 1686 1687 1688 1689 586 588 1690 1692 1693 1695 1738 1740 2794 2796 586 588 1690 1691 1692 1693 1695 1740 2796 586 587 588 1690 1691 1692 1693 1694 1695 1740 2796 589 591 1645 1647 1690 1692 1693 1695 1696 1698 1741 1743 2797 2799 589 591 1647 1692 1693 1694 1695 1696 1698 1741 1743 2799 589 590 591 1647 1692 1693 1694 1695 1696 1697 1698 1741 1742 1743 2799 592 594 1648 1650 1693 1695 1696 1698 1699 1701 1744 1746 2800 2802 592 594 1650 1695 1696 1697 1698 1699 1701 1744 1746 2802 592 593 594 1650 1695 1696 1697 1698 1699 1700 1701 1744 1745 1746 2802 595 597 1651 1653 1696 1698 1699 1701 1702 1704 1747 1749 2803 2805 595 597 1653 1698 1699 1700 1701 1702 1704 1747 1749 2805 595 596 597 1653 1698 1699 1700 1701 1702 1703 1704 1747 1748 1749 2805 598 600 1654 1656 1699 1701 1702 1704 1705 1707 1750 1752 2806 2808 598 600 1656 1701 1702 1703 1704 1705 1707 1750 1752 2808 598 599 600 1656 1701 1702 1703 1704 1705 1706 1707 1750 1751 1752 2808 601 603 1657 1659 1702 1704 1705 1707 1708 1710 1753 1755 2809 2811 601 603 1659 1704 1705 1706 1707 1708 1710 1755 2811 601 602 603 1659 1704 1705 1706 1707 1708 1709 1710 1755 2811 604 606 1660 1662 1705 1707 1708 1710 1711 1713 1756 1758 2812 2814 604 606 1662 1707 1708 1709 1710 1713 1758 2814 604 605 606 1662 1707 1708 1709 1710 1713 1758 2814 607 609 1663 1665 1708 1710 1711 1713 1714 1716 1759 1761 2815 2817 607 609 1665 1708 1710 1711 1712 1713 1716 1761 2817 607 608 609 1665 1708 1709 1710 1711 1712 1713 1716 1761 2817 610 612 1666 1668 1711 1713 1714 1716 1717 1719 1762 1764 2818 2820 610 612 1668 1711 1713 1714 1715 1716 1719 1762 1764 2820 610 611 612 1668 1711 1712 1713 1714 1715 1716 1719 1762 1763 1764 2820 613 615 1669 1671 1714 1716 1717 1719 1720 1722 1765 1767 2821 2823 613 615 1671 1714 1716 1717 1718 1719 1722 1765 1767 2823 613 614 615 1671 1714 1715 1716 1717 1718 1719 1722 1765 1766 1767 2823 616 618 1672 1674 1717 1719 1720 1722 2824 2826 616 618 1674 1717 1719 1720 1721 1722 2826 616 617 618 1674 1717 1718 1719 1720 1721 1722 2826 1723 1724 1725 1726 1727 1728 1729 1730 1731 1732 1733 1734 1735 1736 1737 634 636 1690 1692 1738 1740 1741 1743 1786 1788 2842 2844 634 636 1690 1692 1738 1739 1740 1741 1743 1788 2844 634 635 636 1690 1691 1692 1738 1739 1740 1741 1742 1743 1788 2844 637 639 1693 1695 1738 1740 1741 1743 1744 1746 1789 1791 2845 2847 637 639 1695 1740 1741 1742 1743 1744 1746 1791 2847 637 638 639 1695 1740 1741 1742 1743 1744 1745 1746 1791 2847 640 642 1696 1698 1741 1743 1744 1746 1747 1749 1792 1794 2848 2850 640 642 1698 1743 1744 1745 1746 1747 1749 1794 2850 640 641 642 1698 1743 1744 1745 1746 1747 1748 1749 1794 2850 643 645 1699 1701 1744 1746 1747 1749 1750 1752 1795 1797 2851 2853 643 645 1701 1746 1747 1748 1749 1750 1752 1797 2853 643 644 645 1701 1746 1747 1748 1749 1750 1751 1752 1797 2853 646 648 1702 1704 1747 1749 1750 1752 1753 1755 1798 1800 2854 2856 646 648 1704 1749 1750 1751 1752 1753 1755 1800 2856 646 647 648 1704 1749 1750 1751 1752 1753 1754 1755 1800 2856 649 651 1705 1707 1750 1752 1753 1755 1756 1758 1801 1803 2857 2859 649 651 1705 1707 1752 1753 1754 1755 1756 1758 1803 2859 649 650 651 1705 1706 1707 1752 1753 1754 1755 1756 1757 1758 1803 2859 652 654 1708 1710 1753 1755 1756 1758 1759 1761 1804 1806 2860 2862 652 654 1708 1710 1755 1756 1757 1758 1761 1806 2862 652 653 654 1708 1709 1710 1755 1756 1757 1758 1761 1806 2862 655 657 1711 1713 1756 1758 1759 1761 1762 1764 1807 1809 2863 2865 655 657 1711 1713 1756 1758 1759 1760 1761 1764 1809 2865 655 656 657 1711 1712 1713 1756 1757 1758 1759 1760 1761 1764 1809 2865 658 660 1714 1716 1759 1761 1762 1764 1765 1767 1810 1812 2866 2868 658 660 1716 1759 1761 1762 1763 1764 1767 1812 2868 658 659 660 1716 1759 1760 1761 1762 1763 1764 1767 1812 2868 661 663 1717 1719 1762 1764 1765 1767 1813 1815 2869 2871 661 663 1719 1762 1764 1765 1766 1767 1813 1815 2871 661 662 663 1719 1762 1763 1764 1765 1766 1767 1813 1814 1815 2871 1768 1769 1770 1771 1772 1773 1774 1775 1776 1777 1778 1779 1780 1781 1782 679 681 1783 1785 1786 1788 1831 1833 2887 2889 679 681 1783 1784 1785 1786 1788 1833 2889 679 680 681 1783 1784 1785 1786 1787 1788 1833 2889 682 684 1738 1740 1783 1785 1786 1788 1789 1791 1834 1836 2890 2892 682 684 1738 1740 1785 1786 1787 1788 1789 1791 1836 2892 682 683 684 1738 1739 1740 1785 1786 1787 1788 1789 1790 1791 1836 2892 685 687 1741 1743 1786 1788 1789 1791 1792 1794 1837 1839 2893 2895 685 687 1741 1743 1788 1789 1790 1791 1792 1794 1839 2895 685 686 687 1741 1742 1743 1788 1789 1790 1791 1792 1793 1794 1839 2895 688 690 1744 1746 1789 1791 1792 1794 1795 1797 1840 1842 2896 2898 688 690 1744 1746 1791 1792 1793 1794 1795 1797 1842 2898 688 689 690 1744 1745 1746 1791 1792 1793 1794 1795 1796 1797 1842 2898 691 693 1747 1749 1792 1794 1795 1797 1798 1800 1843 1845 2899 2901 691 693 1747 1749 1794 1795 1796 1797 1798 1800 1845 2901 691 692 693 1747 1748 1749 1794 1795 1796 1797 1798 1799 1800 1845 2901 694 696 1750 1752 1795 1797 1798 1800 1801 1803 1846 1848 2902 2904 694 696 1750 1752 1797 1798 1799 1800 1801 1803 1848 2904 694 695 696 1750 1751 1752 1797 1798 1799 1800 1801 1802 1803 1848 2904 697 699 1753 1755 1798 1800 1801 1803 1804 1806 1849 1851 2905 2907 697 699 1753 1755 1800 1801 1802 1803 1804 1806 1851 2907 697 698 699 1753 1754 1755 1800 1801 1802 1803 1804 1805 1806 1851 2907 700 702 1756 1758 1801 1803 1804 1806 1807 1809 1852 1854 2908 2910 700 702 1756 1758 1803 1804 1805 1806 1809 1854 2910 700 701 702 1756 1757 1758 1803 1804 1805 1806 1809 1854 2910 703 705 1759 1761 1804 1806 1807 1809 1810 1812 1855 1857 2911 2913 703 705 1759 1761 1804 1806 1807 1808 1809 1812 1857 2913 703 704 705 1759 1760 1761 1804 1805 1806 1807 1808 1809 1812 1857 2913 706 708 1762 1764 1807 1809 1810 1812 1813 1815 2914 2916 706 708 1762 1764 1807 1809 1810 1811 1812 1815 2916 706 707 708 1762 1763 1764 1807 1808 1809 1810 1811 1812 1815 2916 709 711 1765 1767 1810 1812 1813 1815 2917 2919 709 711 1767 1810 1812 1813 1814 1815 2919 709 710 711 1767 1810 1811 1812 1813 1814 1815 2919 1816 1817 1818 1819 1820 1821 1822 1823 1824 1825 1826 1827 1828 1829 1830 727 729 1783 1785 1831 1833 1834 1836 1879 1881 2935 2937 727 729 1783 1785 1831 1832 1833 1834 1836 1881 2937 727 728 729 1783 1784 1785 1831 1832 1833 1834 1835 1836 1881 2937 730 732 1786 1788 1831 1833 1834 1836 1837 1839 1882 1884 2938 2940 730 732 1786 1788 1833 1834 1835 1836 1837 1839 1884 2940 730 731 732 1786 1787 1788 1833 1834 1835 1836 1837 1838 1839 1884 2940 733 735 1789 1791 1834 1836 1837 1839 1840 1842 1885 1887 2941 2943 733 735 1789 1791 1836 1837 1838 1839 1840 1842 1887 2943 733 734 735 1789 1790 1791 1836 1837 1838 1839 1840 1841 1842 1887 2943 736 738 1792 1794 1837 1839 1840 1842 1843 1845 1888 1890 2944 2946 736 738 1792 1794 1839 1840 1841 1842 1843 1845 1890 2946 736 737 738 1792 1793 1794 1839 1840 1841 1842 1843 1844 1845 1890 2946 739 741 1795 1797 1840 1842 1843 1845 1846 1848 1891 1893 2947 2949 739 741 1795 1797 1842 1843 1844 1845 1846 1848 1893 2949 739 740 741 1795 1796 1797 1842 1843 1844 1845 1846 1847 1848 1893 2949 742 744 1798 1800 1843 1845 1846 1848 1849 1851 1894 1896 2950 2952 742 744 1798 1800 1845 1846 1847 1848 1849 1851 1896 2952 742 743 744 1798 1799 1800 1845 1846 1847 1848 1849 1850 1851 1896 2952 745 747 1801 1803 1846 1848 1849 1851 1852 1854 1897 1899 2953 2955 745 747 1801 1803 1848 1849 1850 1851 1852 1854 1899 2955 745 746 747 1801 1802 1803 1848 1849 1850 1851 1852 1853 1854 1899 2955 748 750 1804 1806 1849 1851 1852 1854 1855 1857 1900 1902 2956 2958 748 750 1804 1806 1851 1852 1853 1854 1855 1857 1902 2958 748 749 750 1804 1805 1806 1851 1852 1853 1854 1855 1856 1857 1902 2958 751 753 1807 1809 1852 1854 1855 1857 1903 1905 2959 2961 751 753 1807 1809 1854 1855 1856 1857 1905 2961 751 752 753 1807 1808 1809 1854 1855 1856 1857 1905 2961 1858 1859 1860 1861 1862 1863 1864 1865 1866 1867 1868 1869 1870 1871 1872 1873 1874 1875 772 774 1876 1878 1879 1881 1924 1926 2980 2982 772 774 1876 1877 1878 1879 1881 1926 2982 772 773 774 1876 1877 1878 1879 1880 1881 1926 2982 775 777 1831 1833 1876 1878 1879 1881 1882 1884 1927 1929 2983 2985 775 777 1831 1833 1878 1879 1880 1881 1882 1884 1929 2985 775 776 777 1831 1832 1833 1878 1879 1880 1881 1882 1883 1884 1929 2985 778 780 1834 1836 1879 1881 1882 1884 1885 1887 1930 1932 2986 2988 778 780 1834 1836 1881 1882 1883 1884 1885 1887 1932 2988 778 779 780 1834 1835 1836 1881 1882 1883 1884 1885 1886 1887 1932 2988 781 783 1837 1839 1882 1884 1885 1887 1888 1890 1933 1935 2989 2991 781 783 1837 1839 1884 1885 1886 1887 1888 1890 1935 2991 781 782 783 1837 1838 1839 1884 1885 1886 1887 1888 1889 1890 1935 2991 784 786 1840 1842 1885 1887 1888 1890 1891 1893 1936 1938 2992 2994 784 786 1840 1842 1887 1888 1889 1890 1891 1893 1938 2994 784 785 786 1840 1841 1842 1887 1888 1889 1890 1891 1892 1893 1938 2994 787 789 1843 1845 1888 1890 1891 1893 1894 1896 1939 1941 2995 2997 787 789 1843 1845 1890 1891 1892 1893 1894 1896 1941 2997 787 788 789 1843 1844 1845 1890 1891 1892 1893 1894 1895 1896 1941 2997 790 792 1846 1848 1891 1893 1894 1896 1897 1899 1942 1944 2998 3000 790 792 1846 1848 1893 1894 1895 1896 1897 1899 1944 3000 790 791 792 1846 1847 1848 1893 1894 1895 1896 1897 1898 1899 1944 3000 793 795 1849 1851 1894 1896 1897 1899 1900 1902 1945 1947 3001 3003 793 795 1849 1851 1896 1897 1898 1899 1900 1902 1947 3003 793 794 795 1849 1850 1851 1896 1897 1898 1899 1900 1901 1902 1947 3003 796 798 1852 1854 1897 1899 1900 1902 1903 1905 3004 3006 796 798 1852 1854 1899 1900 1901 1902 1903 1905 3006 796 797 798 1852 1853 1854 1899 1900 1901 1902 1903 1904 1905 3006 799 801 1855 1857 1900 1902 1903 1905 3007 3009 799 801 1855 1857 1902 1903 1904 1905 3009 799 800 801 1855 1856 1857 1902 1903 1904 1905 3009 1906 1907 1908 1909 1910 1911 1912 1913 1914 1915 1916 1917 1918 1919 1920 1921 1922 1923 820 822 1876 1878 1924 1926 1927 1929 1972 1974 3028 3030 820 822 1876 1878 1924 1925 1926 1927 1929 1974 3030 820 821 822 1876 1877 1878 1924 1925 1926 1927 1928 1929 1974 3030 823 825 1879 1881 1924 1926 1927 1929 1930 1932 1975 1977 3031 3033 823 825 1879 1881 1926 1927 1928 1929 1930 1932 1977 3033 823 824 825 1879 1880 1881 1926 1927 1928 1929 1930 1931 1932 1977 3033 826 828 1882 1884 1927 1929 1930 1932 1933 1935 1978 1980 3034 3036 826 828 1882 1884 1929 1930 1931 1932 1933 1935 1980 3036 826 827 828 1882 1883 1884 1929 1930 1931 1932 1933 1934 1935 1980 3036 829 831 1885 1887 1930 1932 1933 1935 1936 1938 1981 1983 3037 3039 829 831 1885 1887 1932 1933 1934 1935 1936 1938 1983 3039 829 830 831 1885 1886 1887 1932 1933 1934 1935 1936 1937 1938 1983 3039 832 834 1888 1890 1933 1935 1936 1938 1939 1941 1984 1986 3040 3042 832 834 1888 1890 1935 1936 1937 1938 1939 1941 1986 3042 832 833 834 1888 1889 1890 1935 1936 1937 1938 1939 1940 1941 1986 3042 835 837 1891 1893 1936 1938 1939 1941 1942 1944 1987 1989 3043 3045 835 837 1891 1893 1938 1939 1940 1941 1942 1944 1989 3045 835 836 837 1891 1892 1893 1938 1939 1940 1941 1942 1943 1944 1989 3045 838 840 1894 1896 1939 1941 1942 1944 1945 1947 1990 1992 3046 3048 838 840 1894 1896 1941 1942 1943 1944 1945 1947 1992 3048 838 839 840 1894 1895 1896 1941 1942 1943 1944 1945 1946 1947 1992 3048 841 843 1897 1899 1942 1944 1945 1947 1993 1995 3049 3051 841 843 1897 1899 1944 1945 1946 1947 1995 3051 841 842 843 1897 1898 1899 1944 1945 1946 1947 1995 3051 1948 1949 1950 1951 1952 1953 1954 1955 1956 1957 1958 1959 1960 1961 1962 1963 1964 1965 1966 1967 1968 1969 1970 1971 868 870 1924 1926 1972 1974 1975 1977 2020 2022 3076 3078 868 870 1924 1926 1972 1973 1974 1975 1977 2022 3078 868 869 870 1924 1925 1926 1972 1973 1974 1975 1976 1977 2022 3078 871 873 1927 1929 1972 1974 1975 1977 1978 1980 2023 2025 3079 3081 871 873 1927 1929 1974 1975 1976 1977 1978 1980 2025 3081 871 872 873 1927 1928 1929 1974 1975 1976 1977 1978 1979 1980 2025 3081 874 876 1930 1932 1975 1977 1978 1980 1981 1983 2026 2028 3082 3084 874 876 1930 1932 1977 1978 1979 1980 1981 1983 2028 3084 874 875 876 1930 1931 1932 1977 1978 1979 1980 1981 1982 1983 2028 3084 877 879 1933 1935 1978 1980 1981 1983 1984 1986 2029 2031 3085 3087 877 879 1933 1935 1980 1981 1982 1983 1984 1986 2031 3087 877 878 879 1933 1934 1935 1980 1981 1982 1983 1984 1985 1986 2031 3087 880 882 1936 1938 1981 1983 1984 1986 1987 1989 2032 2034 3088 3090 880 882 1936 1938 1983 1984 1985 1986 1987 1989 2034 3090 880 881 882 1936 1937 1938 1983 1984 1985 1986 1987 1988 1989 2034 3090 883 885 1939 1941 1984 1986 1987 1989 1990 1992 2035 2037 3091 3093 883 885 1939 1941 1986 1987 1988 1989 1990 1992 2037 3093 883 884 885 1939 1940 1941 1986 1987 1988 1989 1990 1991 1992 2037 3093 886 888 1942 1944 1987 1989 1990 1992 1993 1995 3094 3096 886 888 1942 1944 1989 1990 1991 1992 1993 1995 3096 886 887 888 1942 1943 1944 1989 1990 1991 1992 1993 1994 1995 3096 889 891 1945 1947 1990 1992 1993 1995 3097 3099 889 891 1945 1947 1992 1993 1994 1995 3099 889 890 891 1945 1946 1947 1992 1993 1994 1995 3099 1996 1997 1998 1999 2000 2001 2002 2003 2004 2005 2006 2007 2008 2009 2010 2011 2012 2013 2014 2015 2016 2017 2018 2019 916 918 1972 1974 2020 2022 2023 2025 3124 3126 916 918 1972 1974 2020 2021 2022 2023 2025 3126 916 917 918 1972 1973 1974 2020 2021 2022 2023 2024 2025 3126 919 921 1975 1977 2020 2022 2023 2025 2026 2028 2071 2073 3127 3129 919 921 1975 1977 2022 2023 2024 2025 2026 2028 2073 3129 919 920 921 1975 1976 1977 2022 2023 2024 2025 2026 2027 2028 2073 3129 922 924 1978 1980 2023 2025 2026 2028 2029 2031 2074 2076 3130 3132 922 924 1978 1980 2025 2026 2027 2028 2029 2031 2076 3132 922 923 924 1978 1979 1980 2025 2026 2027 2028 2029 2030 2031 2076 3132 925 927 1981 1983 2026 2028 2029 2031 2032 2034 2077 2079 3133 3135 925 927 1981 1983 2028 2029 2030 2031 2032 2034 2079 3135 925 926 927 1981 1982 1983 2028 2029 2030 2031 2032 2033 2034 2079 3135 928 930 1984 1986 2029 2031 2032 2034 2035 2037 2080 2082 3136 3138 928 930 1984 1986 2031 2032 2033 2034 2035 2037 2082 3138 928 929 930 1984 1985 1986 2031 2032 2033 2034 2035 2036 2037 2082 3138 931 933 1987 1989 2032 2034 2035 2037 2083 2085 3139 3141 931 933 1987 1989 2034 2035 2036 2037 2085 3141 931 932 933 1987 1988 1989 2034 2035 2036 2037 2085 3141 2038 2039 2040 2041 2042 2043 2044 2045 2046 2047 2048 2049 2050 2051 2052 2053 2054 2055 2056 2057 2058 2059 2060 2061 2062 2063 2064 2065 2066 2067 2068 2069 2070 967 969 2023 2025 2071 2073 2074 2076 3175 3177 967 969 2023 2025 2071 2072 2073 2074 2076 3177 967 968 969 2023 2024 2025 2071 2072 2073 2074 2075 2076 3177 970 972 2026 2028 2071 2073 2074 2076 2077 2079 2122 2124 3178 3180 970 972 2026 2028 2073 2074 2075 2076 2077 2079 2124 3180 970 971 972 2026 2027 2028 2073 2074 2075 2076 2077 2078 2079 2124 3180 973 975 2029 2031 2074 2076 2077 2079 2080 2082 2125 2127 3181 3183 973 975 2029 2031 2076 2077 2078 2079 2080 2082 2127 3183 973 974 975 2029 2030 2031 2076 2077 2078 2079 2080 2081 2082 2127 3183 976 978 2032 2034 2077 2079 2080 2082 2083 2085 2128 2130 3184 3186 976 978 2032 2034 2079 2080 2081 2082 2083 2085 2130 3186 976 977 978 2032 2033 2034 2079 2080 2081 2082 2083 2084 2085 2130 3186 979 981 2035 2037 2080 2082 2083 2085 3187 3189 979 981 2035 2037 2082 2083 2084 2085 3189 979 980 981 2035 2036 2037 2082 2083 2084 2085 3189 2086 2087 2088 2089 2090 2091 2092 2093 2094 2095 2096 2097 2098 2099 2100 2101 2102 2103 2104 2105 2106 2107 2108 2109 2110 2111 2112 2113 2114 2115 2116 2117 2118 2119 2120 2121 1018 1020 2074 2076 2122 2124 2125 2127 2170 2172 3226 3228 1018 1020 2074 2076 2122 2123 2124 2125 2127 2172 3228 1018 1019 1020 2074 2075 2076 2122 2123 2124 2125 2126 2127 2172 3228 1021 1023 2077 2079 2122 2124 2125 2127 2128 2130 2173 2175 3229 3231 1021 1023 2077 2079 2124 2125 2126 2127 2128 2130 2175 3231 1021 1022 1023 2077 2078 2079 2124 2125 2126 2127 2128 2129 2130 2175 3231 1024 1026 2080 2082 2125 2127 2128 2130 3232 3234 1024 1026 2080 2082 2127 2128 2129 2130 3234 1024 1025 1026 2080 2081 2082 2127 2128 2129 2130 3234 2131 2132 2133 2134 2135 2136 2137 2138 2139 2140 2141 2142 2143 2144 2145 2146 2147 2148 2149 2150 2151 2152 2153 2154 2155 2156 2157 2158 2159 2160 2161 2162 2163 2164 2165 2166 2167 2168 2169 1066 1068 2122 2124 2170 2172 2173 2175 3274 3276 1066 1068 2122 2124 2170 2171 2172 2173 2175 3276 1066 1067 1068 2122 2123 2124 2170 2171 2172 2173 2174 2175 3276 1069 1071 2125 2127 2170 2172 2173 2175 3277 3279 1069 1071 2125 2127 2172 2173 2174 2175 3279 1069 1070 1071 2125 2126 2127 2172 2173 2174 2175 3279 2176 2177 2178 2179 2180 2181 2182 2183 2184 2185 2186 2187 2188 2189 2190 2191 2192 2193 2194 2195 2196 2197 2198 2199 2200 2201 2202 2203 2204 2205 2206 2207 2208 2209 2210 2211 2212 2213 2214 2215 2216 2217 2218 2219 2220 2221 2222 2223 2224 2225 2226 2227 2228 2229 2230 2231 2232 2233 2234 2235 2236 2237 2238 2239 2240 2241 2242 2243 2244 2245 2246 2247 2248 2249 2250 2251 2252 2253 2254 2255 2256 2257 2258 2259 2260 2261 2262 2263 2264 2265 2266 2267 2268 2269 2270 2271 2272 2273 2274 2275 2276 2277 2278 2279 2280 2281 2282 2283 2284 2285 2286 2287 2288 2289 2290 2291 2292 2293 2294 2295 2296 2297 2298 2299 2300 2301 2302 2303 2304 2305 2306 2307 2308 2309 2310 2311 2312 2313 2314 2315 2316 2317 2318 2319 2320 2321 2322 2323 2324 2325 2326 2327 2328 2329 2330 2331 2332 2333 2334 2335 2336 2337 2338 2339 2340 2341 2342 2343 1240 1242 2344 2346 2347 2349 2392 2394 1240 1242 2344 2345 2346 2347 2349 2392 2394 1240 1241 1242 2344 2345 2346 2347 2348 2349 2392 2393 2394 1243 1245 2344 2346 2347 2349 2350 2352 2395 2397 1243 1245 2346 2347 2348 2349 2350 2352 2395 2397 1243 1244 1245 2346 2347 2348 2349 2350 2351 2352 2395 2396 2397 1246 1248 2347 2349 2350 2352 2398 2400 1246 1248 2349 2350 2351 2352 2398 2400 1246 1247 1248 2349 2350 2351 2352 2398 2399 2400 2353 2354 2355 2356 2357 2358 2359 2360 2361 2362 2363 2364 2365 2366 2367 1264 1266 2368 2370 2416 2418 1264 1266 2368 2369 2370 2416 2418 1264 1265 1266 2368 2369 2370 2416 2417 2418 2371 2372 2373 2374 2375 2376 2377 2378 2379 2380 2381 2382 1279 1281 2383 2385 2386 2388 2431 2433 1279 1281 2383 2384 2385 2386 2388 2431 2433 1279 1280 1281 2383 2384 2385 2386 2387 2388 2431 2432 2433 1282 1284 2383 2385 2386 2388 2389 2391 2434 2436 1282 1284 2385 2386 2387 2388 2389 2391 2434 2436 1282 1283 1284 2385 2386 2387 2388 2389 2390 2391 2434 2435 2436 1285 1287 2386 2388 2389 2391 2392 2394 2437 2439 1285 1287 2388 2389 2390 2391 2392 2394 2437 2439 1285 1286 1287 2388 2389 2390 2391 2392 2393 2394 2437 2438 2439 1288 1290 2344 2346 2389 2391 2392 2394 2395 2397 2440 2442 1288 1290 2346 2391 2392 2393 2394 2397 2440 2442 1288 1289 1290 2346 2391 2392 2393 2394 2397 2440 2441 2442 1291 1293 2347 2349 2392 2394 2395 2397 2398 2400 2443 2445 1291 1293 2349 2392 2394 2395 2396 2397 2400 2443 2445 1291 1292 1293 2349 2392 2393 2394 2395 2396 2397 2400 2443 2444 2445 1294 1296 2350 2352 2395 2397 2398 2400 2446 2448 1294 1296 2352 2395 2397 2398 2399 2400 2446 2448 1294 1295 1296 2352 2395 2396 2397 2398 2399 2400 2446 2447 2448 2401 2402 2403 2404 2405 2406 2407 2408 2409 2410 2411 2412 2413 2414 2415 1312 1314 2368 2370 2416 2418 2419 2421 2464 2466 1312 1314 2370 2416 2417 2418 2421 2464 2466 1312 1313 1314 2370 2416 2417 2418 2421 2464 2465 2466 1315 1317 2416 2418 2419 2421 2422 2424 2467 2469 1315 1317 2416 2418 2419 2420 2421 2424 2467 2469 1315 1316 1317 2416 2417 2418 2419 2420 2421 2424 2467 2468 2469 1318 1320 2419 2421 2422 2424 2425 2427 2470 2472 1318 1320 2419 2421 2422 2423 2424 2427 2470 2472 1318 1319 1320 2419 2420 2421 2422 2423 2424 2427 2470 2471 2472 1321 1323 2422 2424 2425 2427 2428 2430 2473 2475 1321 1323 2422 2424 2425 2426 2427 2430 2473 2475 1321 1322 1323 2422 2423 2424 2425 2426 2427 2430 2473 2474 2475 1324 1326 2425 2427 2428 2430 2431 2433 2476 2478 1324 1326 2425 2427 2428 2429 2430 2431 2433 2476 2478 1324 1325 1326 2425 2426 2427 2428 2429 2430 2431 2432 2433 2476 2477 2478 1327 1329 2383 2385 2428 2430 2431 2433 2434 2436 2479 2481 1327 1329 2385 2430 2431 2432 2433 2436 2479 2481 1327 1328 1329 2385 2430 2431 2432 2433 2436 2479 2480 2481 1330 1332 2386 2388 2431 2433 2434 2436 2437 2439 2482 2484 1330 1332 2388 2431 2433 2434 2435 2436 2439 2482 2484 1330 1331 1332 2388 2431 2432 2433 2434 2435 2436 2439 2482 2483 2484 1333 1335 2389 2391 2434 2436 2437 2439 2440 2442 2485 2487 1333 1335 2391 2434 2436 2437 2438 2439 2442 2485 2487 1333 1334 1335 2391 2434 2435 2436 2437 2438 2439 2442 2485 2486 2487 1336 1338 2392 2394 2437 2439 2440 2442 2443 2445 2488 2490 1336 1338 2394 2437 2439 2440 2441 2442 2445 2488 2490 1336 1337 1338 2394 2437 2438 2439 2440 2441 2442 2445 2488 2489 2490 1339 1341 2395 2397 2440 2442 2443 2445 2446 2448 2491 2493 1339 1341 2397 2440 2442 2443 2444 2445 2448 2491 2493 1339 1340 1341 2397 2440 2441 2442 2443 2444 2445 2448 2491 2492 2493 1342 1344 2398 2400 2443 2445 2446 2448 2494 2496 1342 1344 2400 2443 2445 2446 2447 2448 2494 2496 1342 1343 1344 2400 2443 2444 2445 2446 2447 2448 2494 2495 2496 2449 2450 2451 2452 2453 2454 2455 2456 2457 2458 2459 2460 2461 2462 2463 1360 1362 2416 2418 2464 2466 2467 2469 2512 2514 1360 1362 2418 2464 2465 2466 2467 2469 2512 2514 1360 1361 1362 2418 2464 2465 2466 2467 2468 2469 2512 2513 2514 1363 1365 2419 2421 2464 2466 2467 2469 2470 2472 2515 2517 1363 1365 2421 2466 2467 2468 2469 2470 2472 2515 2517 1363 1364 1365 2421 2466 2467 2468 2469 2470 2471 2472 2515 2516 2517 1366 1368 2422 2424 2467 2469 2470 2472 2473 2475 2518 2520 1366 1368 2424 2469 2470 2471 2472 2473 2475 2518 2520 1366 1367 1368 2424 2469 2470 2471 2472 2473 2474 2475 2518 2519 2520 1369 1371 2425 2427 2470 2472 2473 2475 2476 2478 2521 2523 1369 1371 2427 2472 2473 2474 2475 2478 2521 2523 1369 1370 1371 2427 2472 2473 2474 2475 2478 2521 2522 2523 1372 1374 2428 2430 2473 2475 2476 2478 2479 2481 2524 2526 1372 1374 2430 2473 2475 2476 2477 2478 2481 2524 2526 1372 1373 1374 2430 2473 2474 2475 2476 2477 2478 2481 2524 2525 2526 1375 1377 2431 2433 2476 2478 2479 2481 2482 2484 2527 2529 1375 1377 2433 2476 2478 2479 2480 2481 2484 2527 2529 1375 1376 1377 2433 2476 2477 2478 2479 2480 2481 2484 2527 2528 2529 1378 1380 2434 2436 2479 2481 2482 2484 2485 2487 2530 2532 1378 1380 2436 2479 2481 2482 2483 2484 2487 2530 2532 1378 1379 1380 2436 2479 2480 2481 2482 2483 2484 2487 2530 2531 2532 1381 1383 2437 2439 2482 2484 2485 2487 2488 2490 2533 2535 1381 1383 2439 2482 2484 2485 2486 2487 2490 2533 2535 1381 1382 1383 2439 2482 2483 2484 2485 2486 2487 2490 2533 2534 2535 1384 1386 2440 2442 2485 2487 2488 2490 2491 2493 2536 2538 1384 1386 2442 2485 2487 2488 2489 2490 2493 2536 2538 1384 1385 1386 2442 2485 2486 2487 2488 2489 2490 2493 2536 2537 2538 1387 1389 2443 2445 2488 2490 2491 2493 2494 2496 2539 2541 1387 1389 2445 2488 2490 2491 2492 2493 2496 2539 2541 1387 1388 1389 2445 2488 2489 2490 2491 2492 2493 2496 2539 2540 2541 1390 1392 2446 2448 2491 2493 2494 2496 1390 1392 2448 2491 2493 2494 2495 2496 1390 1391 1392 2448 2491 2492 2493 2494 2495 2496 2497 2498 2499 2500 2501 2502 2503 2504 2505 2506 2507 2508 2509 2510 2511 1408 1410 2464 2466 2512 2514 2515 2517 2560 2562 1408 1410 2466 2512 2513 2514 2515 2517 2560 2562 1408 1409 1410 2466 2512 2513 2514 2515 2516 2517 2560 2561 2562 1411 1413 2467 2469 2512 2514 2515 2517 2518 2520 2563 2565 1411 1413 2469 2514 2515 2516 2517 2518 2520 2563 2565 1411 1412 1413 2469 2514 2515 2516 2517 2518 2519 2520 2563 2564 2565 1414 1416 2470 2472 2515 2517 2518 2520 2521 2523 2566 2568 1414 1416 2472 2517 2518 2519 2520 2521 2523 2566 2568 1414 1415 1416 2472 2517 2518 2519 2520 2521 2522 2523 2566 2567 2568 1417 1419 2473 2475 2518 2520 2521 2523 2524 2526 2569 2571 1417 1419 2475 2520 2521 2522 2523 2524 2526 2569 2571 1417 1418 1419 2475 2520 2521 2522 2523 2524 2525 2526 2569 2570 2571 1420 1422 2476 2478 2521 2523 2524 2526 2527 2529 2572 2574 1420 1422 2478 2523 2524 2525 2526 2529 2572 2574 1420 1421 1422 2478 2523 2524 2525 2526 2529 2572 2573 2574 1423 1425 2479 2481 2524 2526 2527 2529 2530 2532 2575 2577 1423 1425 2481 2524 2526 2527 2528 2529 2532 2575 2577 1423 1424 1425 2481 2524 2525 2526 2527 2528 2529 2532 2575 2576 2577 1426 1428 2482 2484 2527 2529 2530 2532 2533 2535 2578 2580 1426 1428 2484 2527 2529 2530 2531 2532 2535 2578 2580 1426 1427 1428 2484 2527 2528 2529 2530 2531 2532 2535 2578 2579 2580 1429 1431 2485 2487 2530 2532 2533 2535 2536 2538 2581 2583 1429 1431 2487 2530 2532 2533 2534 2535 2538 2581 2583 1429 1430 1431 2487 2530 2531 2532 2533 2534 2535 2538 2581 2582 2583 1432 1434 2488 2490 2533 2535 2536 2538 2539 2541 2584 2586 1432 1434 2490 2533 2535 2536 2537 2538 2541 2584 2586 1432 1433 1434 2490 2533 2534 2535 2536 2537 2538 2541 2584 2585 2586 1435 1437 2491 2493 2536 2538 2539 2541 2587 2589 1435 1437 2493 2536 2538 2539 2540 2541 2587 2589 1435 1436 1437 2493 2536 2537 2538 2539 2540 2541 2587 2588 2589 2542 2543 2544 2545 2546 2547 2548 2549 2550 2551 2552 2553 2554 2555 2556 2557 2558 2559 1456 1458 2512 2514 2560 2562 2563 2565 2608 2610 1456 1458 2514 2560 2561 2562 2563 2565 2608 2610 1456 1457 1458 2514 2560 2561 2562 2563 2564 2565 2608 2609 2610 1459 1461 2515 2517 2560 2562 2563 2565 2566 2568 2611 2613 1459 1461 2517 2562 2563 2564 2565 2566 2568 2611 2613 1459 1460 1461 2517 2562 2563 2564 2565 2566 2567 2568 2611 2612 2613 1462 1464 2518 2520 2563 2565 2566 2568 2569 2571 2614 2616 1462 1464 2520 2565 2566 2567 2568 2569 2571 2614 2616 1462 1463 1464 2520 2565 2566 2567 2568 2569 2570 2571 2614 2615 2616 1465 1467 2521 2523 2566 2568 2569 2571 2572 2574 2617 2619 1465 1467 2523 2568 2569 2570 2571 2572 2574 2617 2619 1465 1466 1467 2523 2568 2569 2570 2571 2572 2573 2574 2617 2618 2619 1468 1470 2524 2526 2569 2571 2572 2574 2575 2577 2620 2622 1468 1470 2526 2571 2572 2573 2574 2577 2620 2622 1468 1469 1470 2526 2571 2572 2573 2574 2577 2620 2621 2622 1471 1473 2527 2529 2572 2574 2575 2577 2578 2580 2623 2625 1471 1473 2529 2572 2574 2575 2576 2577 2580 2623 2625 1471 1472 1473 2529 2572 2573 2574 2575 2576 2577 2580 2623 2624 2625 1474 1476 2530 2532 2575 2577 2578 2580 2581 2583 2626 2628 1474 1476 2532 2575 2577 2578 2579 2580 2583 2626 2628 1474 1475 1476 2532 2575 2576 2577 2578 2579 2580 2583 2626 2627 2628 1477 1479 2533 2535 2578 2580 2581 2583 2584 2586 2629 2631 1477 1479 2535 2578 2580 2581 2582 2583 2586 2629 2631 1477 1478 1479 2535 2578 2579 2580 2581 2582 2583 2586 2629 2630 2631 1480 1482 2536 2538 2581 2583 2584 2586 2587 2589 2632 2634 1480 1482 2538 2581 2583 2584 2585 2586 2589 2632 2634 1480 1481 1482 2538 2581 2582 2583 2584 2585 2586 2589 2632 2633 2634 1483 1485 2539 2541 2584 2586 2587 2589 2635 2637 1483 1485 2541 2584 2586 2587 2588 2589 2635 2637 1483 1484 1485 2541 2584 2585 2586 2587 2588 2589 2635 2636 2637 2590 2591 2592 2593 2594 2595 2596 2597 2598 2599 2600 2601 2602 2603 2604 1501 1503 2605 2607 2608 2610 2653 2655 1501 1503 2605 2606 2607 2610 2653 2655 1501 1502 1503 2605 2606 2607 2610 2653 2654 2655 1504 1506 2560 2562 2605 2607 2608 2610 2611 2613 2656 2658 1504 1506 2562 2605 2607 2608 2609 2610 2611 2613 2656 2658 1504 1505 1506 2562 2605 2606 2607 2608 2609 2610 2611 2612 2613 2656 2657 2658 1507 1509 2563 2565 2608 2610 2611 2613 2614 2616 2659 2661 1507 1509 2565 2610 2611 2612 2613 2614 2616 2659 2661 1507 1508 1509 2565 2610 2611 2612 2613 2614 2615 2616 2659 2660 2661 1510 1512 2566 2568 2611 2613 2614 2616 2617 2619 2662 2664 1510 1512 2568 2613 2614 2615 2616 2617 2619 2662 2664 1510 1511 1512 2568 2613 2614 2615 2616 2617 2618 2619 2662 2663 2664 1513 1515 2569 2571 2614 2616 2617 2619 2620 2622 2665 2667 1513 1515 2571 2616 2617 2618 2619 2620 2622 2665 2667 1513 1514 1515 2571 2616 2617 2618 2619 2620 2621 2622 2665 2666 2667 1516 1518 2572 2574 2617 2619 2620 2622 2623 2625 2668 2670 1516 1518 2574 2619 2620 2621 2622 2625 2668 2670 1516 1517 1518 2574 2619 2620 2621 2622 2625 2668 2669 2670 1519 1521 2575 2577 2620 2622 2623 2625 2626 2628 2671 2673 1519 1521 2577 2620 2622 2623 2624 2625 2628 2671 2673 1519 1520 1521 2577 2620 2621 2622 2623 2624 2625 2628 2671 2672 2673 1522 1524 2578 2580 2623 2625 2626 2628 2629 2631 2674 2676 1522 1524 2580 2623 2625 2626 2627 2628 2631 2674 2676 1522 1523 1524 2580 2623 2624 2625 2626 2627 2628 2631 2674 2675 2676 1525 1527 2581 2583 2626 2628 2629 2631 2632 2634 2677 2679 1525 1527 2583 2626 2628 2629 2630 2631 2634 2677 2679 1525 1526 1527 2583 2626 2627 2628 2629 2630 2631 2634 2677 2678 2679 1528 1530 2584 2586 2629 2631 2632 2634 2635 2637 2680 2682 1528 1530 2586 2629 2631 2632 2633 2634 2637 2680 2682 1528 1529 1530 2586 2629 2630 2631 2632 2633 2634 2637 2680 2681 2682 1531 1533 2587 2589 2632 2634 2635 2637 2683 2685 1531 1533 2589 2632 2634 2635 2636 2637 2683 2685 1531 1532 1533 2589 2632 2633 2634 2635 2636 2637 2683 2684 2685 2638 2639 2640 2641 2642 2643 2644 2645 2646 2647 2648 2649 2650 2651 2652 1549 1551 2605 2607 2653 2655 2656 2658 2701 2703 1549 1551 2607 2653 2654 2655 2656 2658 2701 2703 1549 1550 1551 2607 2653 2654 2655 2656 2657 2658 2701 2702 2703 1552 1554 2608 2610 2653 2655 2656 2658 2659 2661 2704 2706 1552 1554 2610 2655 2656 2657 2658 2659 2661 2704 2706 1552 1553 1554 2610 2655 2656 2657 2658 2659 2660 2661 2704 2705 2706 1555 1557 2611 2613 2656 2658 2659 2661 2662 2664 2707 2709 1555 1557 2613 2658 2659 2660 2661 2662 2664 2707 2709 1555 1556 1557 2613 2658 2659 2660 2661 2662 2663 2664 2707 2708 2709 1558 1560 2614 2616 2659 2661 2662 2664 2665 2667 2710 2712 1558 1560 2616 2661 2662 2663 2664 2665 2667 2710 2712 1558 1559 1560 2616 2661 2662 2663 2664 2665 2666 2667 2710 2711 2712 1561 1563 2617 2619 2662 2664 2665 2667 2668 2670 2713 2715 1561 1563 2619 2664 2665 2666 2667 2668 2670 2713 2715 1561 1562 1563 2619 2664 2665 2666 2667 2668 2669 2670 2713 2714 2715 1564 1566 2620 2622 2665 2667 2668 2670 2671 2673 2716 2718 1564 1566 2622 2667 2668 2669 2670 2673 2716 2718 1564 1565 1566 2622 2667 2668 2669 2670 2673 2716 2717 2718 1567 1569 2623 2625 2668 2670 2671 2673 2674 2676 2719 2721 1567 1569 2625 2668 2670 2671 2672 2673 2676 2719 2721 1567 1568 1569 2625 2668 2669 2670 2671 2672 2673 2676 2719 2720 2721 1570 1572 2626 2628 2671 2673 2674 2676 2677 2679 2722 2724 1570 1572 2628 2671 2673 2674 2675 2676 2679 2722 2724 1570 1571 1572 2628 2671 2672 2673 2674 2675 2676 2679 2722 2723 2724 1573 1575 2629 2631 2674 2676 2677 2679 2680 2682 2725 2727 1573 1575 2631 2674 2676 2677 2678 2679 2682 2725 2727 1573 1574 1575 2631 2674 2675 2676 2677 2678 2679 2682 2725 2726 2727 1576 1578 2632 2634 2677 2679 2680 2682 2683 2685 2728 2730 1576 1578 2634 2677 2679 2680 2681 2682 2685 2728 2730 1576 1577 1578 2634 2677 2678 2679 2680 2681 2682 2685 2728 2729 2730 1579 1581 2635 2637 2680 2682 2683 2685 1579 1581 2637 2680 2682 2683 2684 2685 1579 1580 1581 2637 2680 2681 2682 2683 2684 2685 2686 2687 2688 2689 2690 2691 2692 2693 2694 2695 2696 2697 2698 2699 2700 1597 1599 2653 2655 2701 2703 2704 2706 2749 2751 1597 1599 2655 2701 2702 2703 2704 2706 2749 2751 1597 1598 1599 2655 2701 2702 2703 2704 2705 2706 2749 2750 2751 1600 1602 2656 2658 2701 2703 2704 2706 2707 2709 2752 2754 1600 1602 2658 2703 2704 2705 2706 2707 2709 2752 2754 1600 1601 1602 2658 2703 2704 2705 2706 2707 2708 2709 2752 2753 2754 1603 1605 2659 2661 2704 2706 2707 2709 2710 2712 2755 2757 1603 1605 2661 2706 2707 2708 2709 2710 2712 2755 2757 1603 1604 1605 2661 2706 2707 2708 2709 2710 2711 2712 2755 2756 2757 1606 1608 2662 2664 2707 2709 2710 2712 2713 2715 2758 2760 1606 1608 2664 2709 2710 2711 2712 2713 2715 2758 2760 1606 1607 1608 2664 2709 2710 2711 2712 2713 2714 2715 2758 2759 2760 1609 1611 2665 2667 2710 2712 2713 2715 2716 2718 2761 2763 1609 1611 2667 2712 2713 2714 2715 2716 2718 2761 2763 1609 1610 1611 2667 2712 2713 2714 2715 2716 2717 2718 2761 2762 2763 1612 1614 2668 2670 2713 2715 2716 2718 2719 2721 2764 2766 1612 1614 2670 2715 2716 2717 2718 2721 2764 2766 1612 1613 1614 2670 2715 2716 2717 2718 2721 2764 2765 2766 1615 1617 2671 2673 2716 2718 2719 2721 2722 2724 2767 2769 1615 1617 2673 2716 2718 2719 2720 2721 2724 2767 2769 1615 1616 1617 2673 2716 2717 2718 2719 2720 2721 2724 2767 2768 2769 1618 1620 2674 2676 2719 2721 2722 2724 2725 2727 2770 2772 1618 1620 2676 2719 2721 2722 2723 2724 2727 2770 2772 1618 1619 1620 2676 2719 2720 2721 2722 2723 2724 2727 2770 2771 2772 1621 1623 2677 2679 2722 2724 2725 2727 2728 2730 2773 2775 1621 1623 2679 2722 2724 2725 2726 2727 2730 2773 2775 1621 1622 1623 2679 2722 2723 2724 2725 2726 2727 2730 2773 2774 2775 1624 1626 2680 2682 2725 2727 2728 2730 2776 2778 1624 1626 2682 2725 2727 2728 2729 2730 2776 2778 1624 1625 1626 2682 2725 2726 2727 2728 2729 2730 2776 2777 2778 2731 2732 2733 2734 2735 2736 2737 2738 2739 2740 2741 2742 2743 2744 2745 2746 2747 2748 1645 1647 2701 2703 2749 2751 2752 2754 2797 2799 1645 1647 2703 2749 2750 2751 2752 2754 2797 2799 1645 1646 1647 2703 2749 2750 2751 2752 2753 2754 2797 2798 2799 1648 1650 2704 2706 2749 2751 2752 2754 2755 2757 2800 2802 1648 1650 2706 2751 2752 2753 2754 2755 2757 2800 2802 1648 1649 1650 2706 2751 2752 2753 2754 2755 2756 2757 2800 2801 2802 1651 1653 2707 2709 2752 2754 2755 2757 2758 2760 2803 2805 1651 1653 2709 2754 2755 2756 2757 2758 2760 2803 2805 1651 1652 1653 2709 2754 2755 2756 2757 2758 2759 2760 2803 2804 2805 1654 1656 2710 2712 2755 2757 2758 2760 2761 2763 2806 2808 1654 1656 2712 2757 2758 2759 2760 2761 2763 2806 2808 1654 1655 1656 2712 2757 2758 2759 2760 2761 2762 2763 2806 2807 2808 1657 1659 2713 2715 2758 2760 2761 2763 2764 2766 2809 2811 1657 1659 2715 2760 2761 2762 2763 2764 2766 2809 2811 1657 1658 1659 2715 2760 2761 2762 2763 2764 2765 2766 2809 2810 2811 1660 1662 2716 2718 2761 2763 2764 2766 2767 2769 2812 2814 1660 1662 2718 2763 2764 2765 2766 2769 2812 2814 1660 1661 1662 2718 2763 2764 2765 2766 2769 2812 2813 2814 1663 1665 2719 2721 2764 2766 2767 2769 2770 2772 2815 2817 1663 1665 2721 2764 2766 2767 2768 2769 2772 2815 2817 1663 1664 1665 2721 2764 2765 2766 2767 2768 2769 2772 2815 2816 2817 1666 1668 2722 2724 2767 2769 2770 2772 2773 2775 2818 2820 1666 1668 2724 2767 2769 2770 2771 2772 2775 2818 2820 1666 1667 1668 2724 2767 2768 2769 2770 2771 2772 2775 2818 2819 2820 1669 1671 2725 2727 2770 2772 2773 2775 2776 2778 2821 2823 1669 1671 2727 2770 2772 2773 2774 2775 2778 2821 2823 1669 1670 1671 2727 2770 2771 2772 2773 2774 2775 2778 2821 2822 2823 1672 1674 2728 2730 2773 2775 2776 2778 2824 2826 1672 1674 2730 2773 2775 2776 2777 2778 2824 2826 1672 1673 1674 2730 2773 2774 2775 2776 2777 2778 2824 2825 2826 2779 2780 2781 2782 2783 2784 2785 2786 2787 2788 2789 2790 2791 2792 2793 1690 1692 2794 2796 2797 2799 2842 2844 1690 1692 2794 2795 2796 2797 2799 2844 1690 1691 1692 2794 2795 2796 2797 2798 2799 2844 1693 1695 2749 2751 2794 2796 2797 2799 2800 2802 2845 2847 1693 1695 2751 2796 2797 2798 2799 2800 2802 2845 2847 1693 1694 1695 2751 2796 2797 2798 2799 2800 2801 2802 2845 2846 2847 1696 1698 2752 2754 2797 2799 2800 2802 2803 2805 2848 2850 1696 1698 2754 2799 2800 2801 2802 2803 2805 2848 2850 1696 1697 1698 2754 2799 2800 2801 2802 2803 2804 2805 2848 2849 2850 1699 1701 2755 2757 2800 2802 2803 2805 2806 2808 2851 2853 1699 1701 2757 2802 2803 2804 2805 2806 2808 2851 2853 1699 1700 1701 2757 2802 2803 2804 2805 2806 2807 2808 2851 2852 2853 1702 1704 2758 2760 2803 2805 2806 2808 2809 2811 2854 2856 1702 1704 2760 2805 2806 2807 2808 2809 2811 2854 2856 1702 1703 1704 2760 2805 2806 2807 2808 2809 2810 2811 2854 2855 2856 1705 1707 2761 2763 2806 2808 2809 2811 2812 2814 2857 2859 1705 1707 2763 2808 2809 2810 2811 2812 2814 2859 1705 1706 1707 2763 2808 2809 2810 2811 2812 2813 2814 2859 1708 1710 2764 2766 2809 2811 2812 2814 2815 2817 2860 2862 1708 1710 2766 2811 2812 2813 2814 2817 2862 1708 1709 1710 2766 2811 2812 2813 2814 2817 2862 1711 1713 2767 2769 2812 2814 2815 2817 2818 2820 2863 2865 1711 1713 2769 2812 2814 2815 2816 2817 2820 2865 1711 1712 1713 2769 2812 2813 2814 2815 2816 2817 2820 2865 1714 1716 2770 2772 2815 2817 2818 2820 2821 2823 2866 2868 1714 1716 2772 2815 2817 2818 2819 2820 2823 2866 2868 1714 1715 1716 2772 2815 2816 2817 2818 2819 2820 2823 2866 2867 2868 1717 1719 2773 2775 2818 2820 2821 2823 2824 2826 2869 2871 1717 1719 2775 2818 2820 2821 2822 2823 2826 2869 2871 1717 1718 1719 2775 2818 2819 2820 2821 2822 2823 2826 2869 2870 2871 1720 1722 2776 2778 2821 2823 2824 2826 1720 1722 2778 2821 2823 2824 2825 2826 1720 1721 1722 2778 2821 2822 2823 2824 2825 2826 2827 2828 2829 2830 2831 2832 2833 2834 2835 2836 2837 2838 2839 2840 2841 1738 1740 2794 2796 2842 2844 2845 2847 2890 2892 1738 1740 2794 2796 2842 2843 2844 2845 2847 2892 1738 1739 1740 2794 2795 2796 2842 2843 2844 2845 2846 2847 2892 1741 1743 2797 2799 2842 2844 2845 2847 2848 2850 2893 2895 1741 1743 2799 2844 2845 2846 2847 2848 2850 2895 1741 1742 1743 2799 2844 2845 2846 2847 2848 2849 2850 2895 1744 1746 2800 2802 2845 2847 2848 2850 2851 2853 2896 2898 1744 1746 2802 2847 2848 2849 2850 2851 2853 2898 1744 1745 1746 2802 2847 2848 2849 2850 2851 2852 2853 2898 1747 1749 2803 2805 2848 2850 2851 2853 2854 2856 2899 2901 1747 1749 2805 2850 2851 2852 2853 2854 2856 2901 1747 1748 1749 2805 2850 2851 2852 2853 2854 2855 2856 2901 1750 1752 2806 2808 2851 2853 2854 2856 2857 2859 2902 2904 1750 1752 2808 2853 2854 2855 2856 2857 2859 2904 1750 1751 1752 2808 2853 2854 2855 2856 2857 2858 2859 2904 1753 1755 2809 2811 2854 2856 2857 2859 2860 2862 2905 2907 1753 1755 2809 2811 2856 2857 2858 2859 2860 2862 2907 1753 1754 1755 2809 2810 2811 2856 2857 2858 2859 2860 2861 2862 2907 1756 1758 2812 2814 2857 2859 2860 2862 2863 2865 2908 2910 1756 1758 2812 2814 2859 2860 2861 2862 2865 2910 1756 1757 1758 2812 2813 2814 2859 2860 2861 2862 2865 2910 1759 1761 2815 2817 2860 2862 2863 2865 2866 2868 2911 2913 1759 1761 2815 2817 2860 2862 2863 2864 2865 2868 2913 1759 1760 1761 2815 2816 2817 2860 2861 2862 2863 2864 2865 2868 2913 1762 1764 2818 2820 2863 2865 2866 2868 2869 2871 2914 2916 1762 1764 2820 2863 2865 2866 2867 2868 2871 2914 2916 1762 1763 1764 2820 2863 2864 2865 2866 2867 2868 2871 2914 2915 2916 1765 1767 2821 2823 2866 2868 2869 2871 2917 2919 1765 1767 2823 2866 2868 2869 2870 2871 2917 2919 1765 1766 1767 2823 2866 2867 2868 2869 2870 2871 2917 2918 2919 2872 2873 2874 2875 2876 2877 2878 2879 2880 2881 2882 2883 2884 2885 2886 1783 1785 2887 2889 2890 2892 2935 2937 1783 1785 2887 2888 2889 2890 2892 2937 1783 1784 1785 2887 2888 2889 2890 2891 2892 2937 1786 1788 2842 2844 2887 2889 2890 2892 2893 2895 2938 2940 1786 1788 2842 2844 2889 2890 2891 2892 2893 2895 2940 1786 1787 1788 2842 2843 2844 2889 2890 2891 2892 2893 2894 2895 2940 1789 1791 2845 2847 2890 2892 2893 2895 2896 2898 2941 2943 1789 1791 2845 2847 2892 2893 2894 2895 2896 2898 2943 1789 1790 1791 2845 2846 2847 2892 2893 2894 2895 2896 2897 2898 2943 1792 1794 2848 2850 2893 2895 2896 2898 2899 2901 2944 2946 1792 1794 2848 2850 2895 2896 2897 2898 2899 2901 2946 1792 1793 1794 2848 2849 2850 2895 2896 2897 2898 2899 2900 2901 2946 1795 1797 2851 2853 2896 2898 2899 2901 2902 2904 2947 2949 1795 1797 2851 2853 2898 2899 2900 2901 2902 2904 2949 1795 1796 1797 2851 2852 2853 2898 2899 2900 2901 2902 2903 2904 2949 1798 1800 2854 2856 2899 2901 2902 2904 2905 2907 2950 2952 1798 1800 2854 2856 2901 2902 2903 2904 2905 2907 2952 1798 1799 1800 2854 2855 2856 2901 2902 2903 2904 2905 2906 2907 2952 1801 1803 2857 2859 2902 2904 2905 2907 2908 2910 2953 2955 1801 1803 2857 2859 2904 2905 2906 2907 2908 2910 2955 1801 1802 1803 2857 2858 2859 2904 2905 2906 2907 2908 2909 2910 2955 1804 1806 2860 2862 2905 2907 2908 2910 2911 2913 2956 2958 1804 1806 2860 2862 2907 2908 2909 2910 2913 2958 1804 1805 1806 2860 2861 2862 2907 2908 2909 2910 2913 2958 1807 1809 2863 2865 2908 2910 2911 2913 2914 2916 2959 2961 1807 1809 2863 2865 2908 2910 2911 2912 2913 2916 2961 1807 1808 1809 2863 2864 2865 2908 2909 2910 2911 2912 2913 2916 2961 1810 1812 2866 2868 2911 2913 2914 2916 2917 2919 1810 1812 2868 2911 2913 2914 2915 2916 2919 1810 1811 1812 2868 2911 2912 2913 2914 2915 2916 2919 1813 1815 2869 2871 2914 2916 2917 2919 1813 1815 2871 2914 2916 2917 2918 2919 1813 1814 1815 2871 2914 2915 2916 2917 2918 2919 2920 2921 2922 2923 2924 2925 2926 2927 2928 2929 2930 2931 2932 2933 2934 1831 1833 2887 2889 2935 2937 2938 2940 2983 2985 1831 1833 2887 2889 2935 2936 2937 2938 2940 2985 1831 1832 1833 2887 2888 2889 2935 2936 2937 2938 2939 2940 2985 1834 1836 2890 2892 2935 2937 2938 2940 2941 2943 2986 2988 1834 1836 2890 2892 2937 2938 2939 2940 2941 2943 2988 1834 1835 1836 2890 2891 2892 2937 2938 2939 2940 2941 2942 2943 2988 1837 1839 2893 2895 2938 2940 2941 2943 2944 2946 2989 2991 1837 1839 2893 2895 2940 2941 2942 2943 2944 2946 2991 1837 1838 1839 2893 2894 2895 2940 2941 2942 2943 2944 2945 2946 2991 1840 1842 2896 2898 2941 2943 2944 2946 2947 2949 2992 2994 1840 1842 2896 2898 2943 2944 2945 2946 2947 2949 2994 1840 1841 1842 2896 2897 2898 2943 2944 2945 2946 2947 2948 2949 2994 1843 1845 2899 2901 2944 2946 2947 2949 2950 2952 2995 2997 1843 1845 2899 2901 2946 2947 2948 2949 2950 2952 2997 1843 1844 1845 2899 2900 2901 2946 2947 2948 2949 2950 2951 2952 2997 1846 1848 2902 2904 2947 2949 2950 2952 2953 2955 2998 3000 1846 1848 2902 2904 2949 2950 2951 2952 2953 2955 3000 1846 1847 1848 2902 2903 2904 2949 2950 2951 2952 2953 2954 2955 3000 1849 1851 2905 2907 2950 2952 2953 2955 2956 2958 3001 3003 1849 1851 2905 2907 2952 2953 2954 2955 2956 2958 3003 1849 1850 1851 2905 2906 2907 2952 2953 2954 2955 2956 2957 2958 3003 1852 1854 2908 2910 2953 2955 2956 2958 2959 2961 3004 3006 1852 1854 2908 2910 2955 2956 2957 2958 2959 2961 3006 1852 1853 1854 2908 2909 2910 2955 2956 2957 2958 2959 2960 2961 3006 1855 1857 2911 2913 2956 2958 2959 2961 3007 3009 1855 1857 2911 2913 2958 2959 2960 2961 3009 1855 1856 1857 2911 2912 2913 2958 2959 2960 2961 3009 2962 2963 2964 2965 2966 2967 2968 2969 2970 2971 2972 2973 2974 2975 2976 2977 2978 2979 1876 1878 2980 2982 2983 2985 3028 3030 1876 1878 2980 2981 2982 2983 2985 3030 1876 1877 1878 2980 2981 2982 2983 2984 2985 3030 1879 1881 2935 2937 2980 2982 2983 2985 2986 2988 3031 3033 1879 1881 2935 2937 2982 2983 2984 2985 2986 2988 3033 1879 1880 1881 2935 2936 2937 2982 2983 2984 2985 2986 2987 2988 3033 1882 1884 2938 2940 2983 2985 2986 2988 2989 2991 3034 3036 1882 1884 2938 2940 2985 2986 2987 2988 2989 2991 3036 1882 1883 1884 2938 2939 2940 2985 2986 2987 2988 2989 2990 2991 3036 1885 1887 2941 2943 2986 2988 2989 2991 2992 2994 3037 3039 1885 1887 2941 2943 2988 2989 2990 2991 2992 2994 3039 1885 1886 1887 2941 2942 2943 2988 2989 2990 2991 2992 2993 2994 3039 1888 1890 2944 2946 2989 2991 2992 2994 2995 2997 3040 3042 1888 1890 2944 2946 2991 2992 2993 2994 2995 2997 3042 1888 1889 1890 2944 2945 2946 2991 2992 2993 2994 2995 2996 2997 3042 1891 1893 2947 2949 2992 2994 2995 2997 2998 3000 3043 3045 1891 1893 2947 2949 2994 2995 2996 2997 2998 3000 3045 1891 1892 1893 2947 2948 2949 2994 2995 2996 2997 2998 2999 3000 3045 1894 1896 2950 2952 2995 2997 2998 3000 3001 3003 3046 3048 1894 1896 2950 2952 2997 2998 2999 3000 3001 3003 3048 1894 1895 1896 2950 2951 2952 2997 2998 2999 3000 3001 3002 3003 3048 1897 1899 2953 2955 2998 3000 3001 3003 3004 3006 3049 3051 1897 1899 2953 2955 3000 3001 3002 3003 3004 3006 3051 1897 1898 1899 2953 2954 2955 3000 3001 3002 3003 3004 3005 3006 3051 1900 1902 2956 2958 3001 3003 3004 3006 3007 3009 1900 1902 2956 2958 3003 3004 3005 3006 3007 3009 1900 1901 1902 2956 2957 2958 3003 3004 3005 3006 3007 3008 3009 1903 1905 2959 2961 3004 3006 3007 3009 1903 1905 2959 2961 3006 3007 3008 3009 1903 1904 1905 2959 2960 2961 3006 3007 3008 3009 3010 3011 3012 3013 3014 3015 3016 3017 3018 3019 3020 3021 3022 3023 3024 3025 3026 3027 1924 1926 2980 2982 3028 3030 3031 3033 3076 3078 1924 1926 2980 2982 3028 3029 3030 3031 3033 3078 1924 1925 1926 2980 2981 2982 3028 3029 3030 3031 3032 3033 3078 1927 1929 2983 2985 3028 3030 3031 3033 3034 3036 3079 3081 1927 1929 2983 2985 3030 3031 3032 3033 3034 3036 3081 1927 1928 1929 2983 2984 2985 3030 3031 3032 3033 3034 3035 3036 3081 1930 1932 2986 2988 3031 3033 3034 3036 3037 3039 3082 3084 1930 1932 2986 2988 3033 3034 3035 3036 3037 3039 3084 1930 1931 1932 2986 2987 2988 3033 3034 3035 3036 3037 3038 3039 3084 1933 1935 2989 2991 3034 3036 3037 3039 3040 3042 3085 3087 1933 1935 2989 2991 3036 3037 3038 3039 3040 3042 3087 1933 1934 1935 2989 2990 2991 3036 3037 3038 3039 3040 3041 3042 3087 1936 1938 2992 2994 3037 3039 3040 3042 3043 3045 3088 3090 1936 1938 2992 2994 3039 3040 3041 3042 3043 3045 3090 1936 1937 1938 2992 2993 2994 3039 3040 3041 3042 3043 3044 3045 3090 1939 1941 2995 2997 3040 3042 3043 3045 3046 3048 3091 3093 1939 1941 2995 2997 3042 3043 3044 3045 3046 3048 3093 1939 1940 1941 2995 2996 2997 3042 3043 3044 3045 3046 3047 3048 3093 1942 1944 2998 3000 3043 3045 3046 3048 3049 3051 3094 3096 1942 1944 2998 3000 3045 3046 3047 3048 3049 3051 3096 1942 1943 1944 2998 2999 3000 3045 3046 3047 3048 3049 3050 3051 3096 1945 1947 3001 3003 3046 3048 3049 3051 3097 3099 1945 1947 3001 3003 3048 3049 3050 3051 3099 1945 1946 1947 3001 3002 3003 3048 3049 3050 3051 3099 3052 3053 3054 3055 3056 3057 3058 3059 3060 3061 3062 3063 3064 3065 3066 3067 3068 3069 3070 3071 3072 3073 3074 3075 1972 1974 3028 3030 3076 3078 3079 3081 3124 3126 1972 1974 3028 3030 3076 3077 3078 3079 3081 3126 1972 1973 1974 3028 3029 3030 3076 3077 3078 3079 3080 3081 3126 1975 1977 3031 3033 3076 3078 3079 3081 3082 3084 3127 3129 1975 1977 3031 3033 3078 3079 3080 3081 3082 3084 3129 1975 1976 1977 3031 3032 3033 3078 3079 3080 3081 3082 3083 3084 3129 1978 1980 3034 3036 3079 3081 3082 3084 3085 3087 3130 3132 1978 1980 3034 3036 3081 3082 3083 3084 3085 3087 3132 1978 1979 1980 3034 3035 3036 3081 3082 3083 3084 3085 3086 3087 3132 1981 1983 3037 3039 3082 3084 3085 3087 3088 3090 3133 3135 1981 1983 3037 3039 3084 3085 3086 3087 3088 3090 3135 1981 1982 1983 3037 3038 3039 3084 3085 3086 3087 3088 3089 3090 3135 1984 1986 3040 3042 3085 3087 3088 3090 3091 3093 3136 3138 1984 1986 3040 3042 3087 3088 3089 3090 3091 3093 3138 1984 1985 1986 3040 3041 3042 3087 3088 3089 3090 3091 3092 3093 3138 1987 1989 3043 3045 3088 3090 3091 3093 3094 3096 3139 3141 1987 1989 3043 3045 3090 3091 3092 3093 3094 3096 3141 1987 1988 1989 3043 3044 3045 3090 3091 3092 3093 3094 3095 3096 3141 1990 1992 3046 3048 3091 3093 3094 3096 3097 3099 1990 1992 3046 3048 3093 3094 3095 3096 3097 3099 1990 1991 1992 3046 3047 3048 3093 3094 3095 3096 3097 3098 3099 1993 1995 3049 3051 3094 3096 3097 3099 1993 1995 3049 3051 3096 3097 3098 3099 1993 1994 1995 3049 3050 3051 3096 3097 3098 3099 3100 3101 3102 3103 3104 3105 3106 3107 3108 3109 3110 3111 3112 3113 3114 3115 3116 3117 3118 3119 3120 3121 3122 3123 2020 2022 3076 3078 3124 3126 3127 3129 2020 2022 3076 3078 3124 3125 3126 3127 3129 2020 2021 2022 3076 3077 3078 3124 3125 3126 3127 3128 3129 2023 2025 3079 3081 3124 3126 3127 3129 3130 3132 3175 3177 2023 2025 3079 3081 3126 3127 3128 3129 3130 3132 3177 2023 2024 2025 3079 3080 3081 3126 3127 3128 3129 3130 3131 3132 3177 2026 2028 3082 3084 3127 3129 3130 3132 3133 3135 3178 3180 2026 2028 3082 3084 3129 3130 3131 3132 3133 3135 3180 2026 2027 2028 3082 3083 3084 3129 3130 3131 3132 3133 3134 3135 3180 2029 2031 3085 3087 3130 3132 3133 3135 3136 3138 3181 3183 2029 2031 3085 3087 3132 3133 3134 3135 3136 3138 3183 2029 2030 2031 3085 3086 3087 3132 3133 3134 3135 3136 3137 3138 3183 2032 2034 3088 3090 3133 3135 3136 3138 3139 3141 3184 3186 2032 2034 3088 3090 3135 3136 3137 3138 3139 3141 3186 2032 2033 2034 3088 3089 3090 3135 3136 3137 3138 3139 3140 3141 3186 2035 2037 3091 3093 3136 3138 3139 3141 3187 3189 2035 2037 3091 3093 3138 3139 3140 3141 3189 2035 2036 2037 3091 3092 3093 3138 3139 3140 3141 3189 3142 3143 3144 3145 3146 3147 3148 3149 3150 3151 3152 3153 3154 3155 3156 3157 3158 3159 3160 3161 3162 3163 3164 3165 3166 3167 3168 3169 3170 3171 3172 3173 3174 2071 2073 3127 3129 3175 3177 3178 3180 2071 2073 3127 3129 3175 3176 3177 3178 3180 2071 2072 2073 3127 3128 3129 3175 3176 3177 3178 3179 3180 2074 2076 3130 3132 3175 3177 3178 3180 3181 3183 3226 3228 2074 2076 3130 3132 3177 3178 3179 3180 3181 3183 3228 2074 2075 2076 3130 3131 3132 3177 3178 3179 3180 3181 3182 3183 3228 2077 2079 3133 3135 3178 3180 3181 3183 3184 3186 3229 3231 2077 2079 3133 3135 3180 3181 3182 3183 3184 3186 3231 2077 2078 2079 3133 3134 3135 3180 3181 3182 3183 3184 3185 3186 3231 2080 2082 3136 3138 3181 3183 3184 3186 3187 3189 3232 3234 2080 2082 3136 3138 3183 3184 3185 3186 3187 3189 3234 2080 2081 2082 3136 3137 3138 3183 3184 3185 3186 3187 3188 3189 3234 2083 2085 3139 3141 3184 3186 3187 3189 2083 2085 3139 3141 3186 3187 3188 3189 2083 2084 2085 3139 3140 3141 3186 3187 3188 3189 3190 3191 3192 3193 3194 3195 3196 3197 3198 3199 3200 3201 3202 3203 3204 3205 3206 3207 3208 3209 3210 3211 3212 3213 3214 3215 3216 3217 3218 3219 3220 3221 3222 3223 3224 3225 2122 2124 3178 3180 3226 3228 3229 3231 3274 3276 2122 2124 3178 3180 3226 3227 3228 3229 3231 3276 2122 2123 2124 3178 3179 3180 3226 3227 3228 3229 3230 3231 3276 2125 2127 3181 3183 3226 3228 3229 3231 3232 3234 3277 3279 2125 2127 3181 3183 3228 3229 3230 3231 3232 3234 3279 2125 2126 2127 3181 3182 3183 3228 3229 3230 3231 3232 3233 3234 3279 2128 2130 3184 3186 3229 3231 3232 3234 2128 2130 3184 3186 3231 3232 3233 3234 2128 2129 2130 3184 3185 3186 3231 3232 3233 3234 3235 3236 3237 3238 3239 3240 3241 3242 3243 3244 3245 3246 3247 3248 3249 3250 3251 3252 3253 3254 3255 3256 3257 3258 3259 3260 3261 3262 3263 3264 3265 3266 3267 3268 3269 3270 3271 3272 3273 2170 2172 3226 3228 3274 3276 3277 3279 2170 2172 3226 3228 3274 3275 3276 3277 3279 2170 2171 2172 3226 3227 3228 3274 3275 3276 3277 3278 3279 2173 2175 3229 3231 3274 3276 3277 3279 2173 2175 3229 3231 3276 3277 3278 3279 2173 2174 2175 3229 3230 3231 3276 3277 3278 3279 3280 3281 3282 3283 3284 3285 3286 3287 3288 3289 3290 3291 3292 3293 3294 3295 3296 3297 3298 3299 3300 3301 3302 3303 3304 3305 3306 3307 3308 3309 3310 3311 3312 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.58231501E+03 0.52492442E+00 -0.20203364E+01 -0.27550543E+00 -0.56252230E+01 -0.16807221E+00 -0.35663180E+03 -0.88662401E+02 0.43323260E+01 -0.19094766E+01 0.26312807E+02 -0.24130042E+01 -0.60285039E+03 0.75193603E+02 0.73233615E+01 -0.32277769E+01 0.44479169E+02 -0.50183851E+01 -0.40789423E+01 -0.16998248E+01 -0.27550543E+00 0.58372624E+03 0.63124101E+00 -0.73516016E+01 -0.27406444E+00 0.14215287E+01 -0.19094766E+01 -0.35731519E+03 -0.82875303E+02 0.38183672E+01 0.25567757E+02 -0.18996892E+01 0.24029503E+01 -0.23924408E+00 -0.32277769E+01 -0.60400514E+03 0.70151506E+02 0.64545628E+01 0.43219704E+02 -0.43030678E+01 -0.32112320E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.53832442E+03 0.53782022E+00 -0.63733512E+00 -0.15517509E+00 -0.89792671E+01 -0.30109811E+00 -0.33089489E+03 -0.74442006E+02 0.37903600E+01 -0.21251184E+01 0.26986678E+02 -0.16569781E+01 -0.55934473E+03 0.63483385E+02 0.64072219E+01 -0.35922975E+01 0.45618281E+02 -0.45334382E+01 -0.28009558E+01 -0.13980131E+01 -0.15517509E+00 0.50198176E+03 0.47689354E+00 -0.63224679E+00 -0.86217037E-01 -0.57287189E+01 -0.15448592E+00 0.13851396E+01 -0.21251184E+01 -0.31288440E+03 -0.75938657E+02 0.66177709E+01 -0.23682623E+01 0.27415937E+02 -0.21159596E+01 0.23414383E+01 -0.26047842E+00 -0.35922975E+01 -0.52889940E+03 0.65540651E+02 0.11186675E+02 -0.40033106E+01 0.46343867E+02 -0.51556247E+01 -0.35768156E+01 -0.14107303E+01 -0.86217037E-01 0.46586228E+03 0.29383283E+00 -0.38013097E+00 -0.42128177E-01 -0.43311389E+01 -0.84835819E-01 0.43689315E+01 -0.23682623E+01 -0.29407852E+03 -0.74441522E+02 0.72325006E+01 -0.25253587E+01 0.25448551E+02 -0.23306147E+01 0.73852418E+01 -0.93201429E+00 -0.40033106E+01 -0.49711033E+03 0.65294128E+02 0.12225815E+02 -0.42688625E+01 0.43018230E+02 -0.54288819E+01 -0.39396711E+01 -0.14010699E+01 -0.42128177E-01 0.42014767E+03 0.28664674E+00 -0.45043645E+00 -0.28088374E-01 -0.30132612E+01 -0.41440337E-01 -0.15185682E+01 -0.94695072E-01 0.83901469E+01 -0.25253587E+01 -0.27386615E+03 -0.70163194E+02 0.84045939E+01 -0.24770889E+01 0.27643276E+02 -0.24844433E+01 -0.90991269E+00 0.14182692E+02 -0.18692398E+01 -0.42688625E+01 -0.46294292E+03 0.63568717E+02 0.14207117E+02 -0.41872710E+01 0.46728152E+02 -0.61586425E+01 -0.41996989E+01 -0.15381153E+01 -0.11205588E+01 -0.28088374E-01 0.39605626E+03 0.21289817E+00 -0.43256755E+00 -0.19131946E-01 -0.24236070E+01 -0.27943549E-01 -0.13020729E+01 -0.57589129E-01 0.73902619E+01 -0.24770889E+01 -0.25965366E+03 -0.67508510E+02 0.86129243E+01 -0.24530265E+01 0.27643725E+02 -0.24646498E+01 -0.12106635E+01 0.12492498E+02 -0.16776607E+01 -0.41872710E+01 -0.43891854E+03 0.61392103E+02 0.14559283E+02 -0.41465920E+01 0.46728953E+02 -0.62753919E+01 -0.41662440E+01 -0.20465056E+01 -0.81089445E+00 -0.19131946E-01 0.37180667E+03 0.16790239E+00 -0.27576248E+00 -0.12196645E-01 -0.20755418E+01 -0.18758993E-01 -0.85465113E+00 -0.37800198E-01 0.56903327E+01 -0.24530265E+01 -0.24225577E+03 -0.64514006E+02 0.87655485E+01 -0.24257603E+01 0.25159407E+02 -0.24055380E+01 -0.14740605E+01 0.96189292E+01 -0.13569623E+01 -0.41465920E+01 -0.40950877E+03 0.58423373E+02 0.14817273E+02 -0.41005051E+01 0.42529422E+02 -0.59997136E+01 -0.40663174E+01 -0.24917501E+01 -0.58379831E+00 -0.12196645E-01 0.34769930E+03 0.12785204E+00 -0.15025582E+01 -0.11948511E-01 -0.81286985E+00 -0.23819524E-01 0.34445751E+01 -0.24257603E+01 -0.22507085E+03 -0.61460330E+02 0.65646306E+01 0.23436855E+02 -0.23767260E+01 -0.17553192E+01 0.58227096E+01 -0.83153640E+00 -0.41005051E+01 -0.38045976E+03 0.55129317E+02 0.11096852E+02 0.39617660E+02 -0.56577656E+01 -0.40176177E+01 -0.29671916E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.95033409E+01 -0.16807221E+00 0.58715640E+03 0.20768709E+00 -0.66263142E+00 -0.11226122E-01 -0.14917882E+01 -0.11178095E-01 -0.88143285E+00 -0.15588662E-01 -0.24130042E+01 -0.36403964E+03 -0.10420357E+03 0.11702675E+02 0.10112293E+01 -0.41288435E+01 0.32774276E+02 -0.41117354E+01 -0.10375061E+01 -0.40789423E+01 -0.61537261E+03 0.90595331E+02 0.19782202E+02 0.17093819E+01 -0.24808822E+00 -0.69793971E+01 0.55401636E+02 -0.80406217E+01 -0.69504776E+01 -0.17538002E+01 -0.93527780E+01 -0.27406444E+00 -0.38310490E+00 -0.11226122E-01 0.58877517E+03 0.37583663E+00 -0.97621276E+00 -0.28605960E-01 -0.21579866E+01 -0.22766993E-01 -0.12770249E+01 -0.37420658E-01 -0.18996892E+01 -0.41288435E+01 -0.36275210E+03 -0.10186561E+03 0.14544988E+02 0.72034968E+00 -0.38446595E+01 0.31763844E+02 -0.38235852E+01 -0.83688804E+00 -0.32112320E+01 -0.69793971E+01 -0.61319572E+03 0.88189741E+02 0.24586836E+02 0.12176783E+01 -0.17063358E+00 -0.64990078E+01 0.53693564E+02 -0.75240940E+01 -0.64633840E+01 -0.14146747E+01 -0.69261266E+00 -0.28605960E-01 0.57964280E+03 0.21236083E+00 -0.64659514E+00 -0.28598130E-01 -0.26326900E+01 -0.28465858E-01 -0.10407070E+01 -0.46029227E-01 -0.38446595E+01 -0.36080559E+03 -0.92549851E+02 0.12072043E+02 -0.37281591E+01 0.30535283E+02 -0.37102441E+01 -0.77776517E+00 -0.64990078E+01 -0.60990576E+03 0.10113849E+03 0.20406572E+02 -0.63020758E+01 0.51616842E+02 -0.72946364E+01 -0.62717966E+01 -0.13147342E+01 -0.74936863E+00 -0.28598130E-01 0.57960782E+03 0.20612325E+00 -0.50660252E+00 -0.22406424E-01 -0.26813113E+01 -0.28468338E-01 -0.10397916E+01 -0.45988738E-01 0.16519968E+01 -0.37281591E+01 -0.36323852E+03 -0.10089664E+03 0.12039996E+02 -0.38116668E+01 0.31315243E+02 -0.37116769E+01 -0.77727817E+00 0.27925334E+01 -0.39466218E+00 -0.63020758E+01 -0.61401798E+03 0.87613858E+02 0.20352399E+02 -0.64432415E+01 0.52935250E+02 -0.74812153E+01 -0.62742143E+01 -0.13139100E+01 -0.10275334E+02 -0.30109811E+00 -0.92027711E+00 -0.22406424E-01 0.57841498E+03 0.40105527E+00 -0.60633936E+00 -0.17767561E-01 -0.22549502E+01 -0.22319387E-01 -0.12199801E+01 -0.35749077E-01 -0.16569781E+01 0.49808187E+01 -0.38116668E+01 -0.36291867E+03 -0.99874183E+02 0.13885676E+02 -0.37395622E+01 0.34272320E+02 -0.37973032E+01 -0.86906437E+00 -0.28009558E+01 0.84195758E+01 -0.11816716E+01 -0.64432415E+01 -0.61347772E+03 0.88241532E+02 0.23472342E+02 -0.63213517E+01 0.57933929E+02 -0.81309186E+01 -0.64189614E+01 -0.14690664E+01 -0.52720176E+01 -0.15448592E+00 -0.88376592E+00 -0.17767561E-01 0.53819049E+03 0.22860480E+00 -0.36629296E+00 -0.10733482E-01 -0.21028053E+01 -0.17511047E-01 -0.90554114E+00 -0.26535070E-01 -0.21159596E+01 0.64992267E+01 -0.37395622E+01 -0.34501964E+03 -0.94437882E+02 0.14167430E+02 -0.35930102E+01 0.34671114E+02 -0.36860291E+01 -0.10223718E+01 -0.35768156E+01 0.10986285E+02 -0.15779046E+01 -0.63213517E+01 -0.58322082E+03 0.84628322E+02 0.23948610E+02 -0.60736243E+01 0.58608013E+02 -0.84175711E+01 -0.62308592E+01 -0.17282160E+01 -0.47968887E+01 -0.84835819E-01 -0.80210585E+00 -0.10733482E-01 0.49120539E+03 0.13248632E+00 -0.39934254E+00 -0.70626095E-02 -0.15065650E+01 -0.10573342E-01 -0.10123748E+01 -0.17904448E-01 -0.23306147E+01 0.74001667E+01 -0.35930102E+01 -0.31953541E+03 -0.87270037E+02 0.14135047E+02 -0.34167533E+01 0.34709746E+02 -0.35398843E+01 -0.12450844E+01 -0.39396711E+01 0.12509242E+02 -0.17988232E+01 -0.60736243E+01 -0.54014266E+03 0.79198658E+02 0.23893881E+02 -0.57756766E+01 0.58673355E+02 -0.84372023E+01 -0.59838204E+01 -0.21046906E+01 -0.23431693E+01 -0.41440337E-01 -0.60882022E+00 -0.70626095E-02 0.45308736E+03 0.68671832E-01 -0.17952822E+00 -0.31750629E-02 -0.12500289E+01 -0.69509890E-02 -0.49817901E+00 -0.88105909E-02 -0.24844433E+01 0.80397464E+01 -0.34167533E+01 -0.29842278E+03 -0.81860502E+02 0.14079488E+02 -0.32915798E+01 0.32776872E+02 -0.33632083E+01 -0.15144038E+01 -0.41996989E+01 0.13590380E+02 -0.20179013E+01 -0.57756766E+01 -0.50445359E+03 0.74924081E+02 0.23799955E+02 -0.55640865E+01 0.55405994E+02 -0.82266890E+01 -0.56851642E+01 -0.25599466E+01 -0.15800177E+01 -0.27943549E-01 -0.38085523E+00 -0.31750629E-02 0.41704012E+03 0.42224667E-01 -0.12247098E+00 -0.21659719E-02 -0.96282021E+00 -0.31237309E-02 -0.26765315E+00 -0.47336046E-02 -0.24646498E+01 0.76865494E+01 -0.32915798E+01 -0.27554457E+03 -0.76543503E+02 0.13835576E+02 -0.30734057E+01 0.30072650E+02 -0.32388179E+01 -0.17586124E+01 -0.41662440E+01 0.12993343E+02 -0.20075327E+01 -0.55640865E+01 -0.46578054E+03 0.70327031E+02 0.23387654E+02 -0.51952822E+01 0.50834807E+02 -0.78542169E+01 -0.54748978E+01 -0.29727583E+01 -0.17974492E+01 -0.18758993E-01 -0.28221387E+00 -0.21659719E-02 0.38232845E+03 0.29595214E-01 -0.17389934E+00 -0.18148921E-02 -0.46688455E+00 -0.21283901E-02 -0.35963947E+00 -0.37533603E-02 -0.24055380E+01 0.72573020E+01 -0.30734057E+01 -0.25249098E+03 -0.70502971E+02 0.13352024E+02 -0.28726571E+01 0.27264523E+02 -0.30204609E+01 -0.19721237E+01 -0.40663174E+01 0.12267737E+02 -0.18598161E+01 -0.51952822E+01 -0.42681054E+03 0.64538446E+02 0.22570249E+02 -0.48559394E+01 0.46087927E+02 -0.69870316E+01 -0.51057843E+01 -0.33336753E+01 -0.11448824E+01 -0.11948511E-01 -0.22552177E+00 -0.18148921E-02 0.35827852E+03 0.19645213E-01 -0.34041326E+00 -0.18063119E-02 -0.30363694E+00 -0.31688925E-02 -0.23767260E+01 0.50814602E+01 -0.28726571E+01 -0.23237971E+03 -0.66372454E+02 0.10250425E+02 0.22538935E+02 -0.28594450E+01 -0.21342173E+01 -0.40176177E+01 0.85897002E+01 -0.13110006E+01 -0.48559394E+01 -0.39281466E+03 0.59555841E+02 0.17327318E+02 0.38099815E+02 -0.58149738E+01 -0.48336058E+01 -0.36076809E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.10710627E+01 -0.11178095E-01 0.57664083E+03 0.20060363E-01 -0.24673275E+00 -0.24431051E-02 -0.50275251E+00 -0.24344383E-02 -0.24521007E+00 -0.25591232E-02 -0.41117354E+01 -0.36951689E+03 -0.10739081E+03 0.14473053E+02 0.12598142E+01 -0.45324730E+01 0.38055507E+02 -0.45169952E+01 -0.12998960E+01 -0.69504776E+01 -0.62463134E+03 0.94914364E+02 0.24465248E+02 0.21295899E+01 -0.32783572E+00 -0.76616923E+01 0.64329029E+02 -0.99030117E+01 -0.76355288E+01 -0.21973442E+01 -0.21814878E+01 -0.22766993E-01 -0.23409345E+00 -0.24431051E-02 0.57810629E+03 0.34919008E-01 -0.26512178E+00 -0.26886511E-02 -0.57254940E+00 -0.26800805E-02 -0.27636288E+00 -0.28842481E-02 -0.38235852E+01 -0.45324730E+01 -0.36896133E+03 -0.10720477E+03 0.18657388E+02 0.74248961E+00 -0.45082972E+01 0.38015026E+02 -0.44945266E+01 -0.12865738E+01 -0.64633840E+01 -0.76616923E+01 -0.62369183E+03 0.94574832E+02 0.31538432E+02 0.12551036E+01 -0.19218681E+00 -0.76208205E+01 0.64260557E+02 -0.98398496E+01 -0.75975428E+01 -0.21748226E+01 -0.27275416E+01 -0.28465858E-01 -0.25762117E+00 -0.26886511E-02 0.57892699E+03 0.42732943E-01 -0.32769397E+00 -0.34199625E-02 -0.69620582E+00 -0.31666804E-02 -0.33683290E+00 -0.35153406E-02 -0.37102441E+01 -0.45082972E+01 -0.36893026E+03 -0.98002191E+02 0.18375718E+02 -0.44366481E+01 0.38721161E+02 -0.44472212E+01 -0.12614183E+01 -0.62717966E+01 -0.76208205E+01 -0.62363972E+03 0.10911105E+03 0.31062304E+02 -0.74997050E+01 0.65454250E+02 -0.99161438E+01 -0.75175827E+01 -0.21323014E+01 -0.27277792E+01 -0.28468338E-01 -0.33767214E+00 -0.34199625E-02 0.57908054E+03 0.44058334E-01 -0.32755690E+00 -0.34185321E-02 -0.73488848E+00 -0.34093212E-02 -0.36942559E+00 -0.38554926E-02 -0.37116769E+01 0.98147627E+00 -0.44366481E+01 -0.37128234E+03 -0.10664909E+03 0.18269537E+02 -0.44365683E+01 0.40088522E+02 -0.44233411E+01 -0.12494341E+01 -0.62742143E+01 0.16590864E+01 -0.25000051E+00 -0.74997050E+01 -0.62761527E+03 0.94589072E+02 0.30882809E+02 -0.74995750E+01 0.67765594E+02 -0.10211302E+02 -0.74772107E+01 -0.21120419E+01 -0.21385990E+01 -0.22319387E-01 -0.36012857E+00 -0.34185321E-02 0.57847280E+03 0.37287746E-01 -0.26939197E+00 -0.28114965E-02 -0.75130318E+00 -0.34090856E-02 -0.36819108E+00 -0.38426087E-02 -0.37973032E+01 0.32107202E+01 -0.44365683E+01 -0.37513644E+03 -0.10664886E+03 0.18317866E+02 -0.43982700E+01 0.41711503E+02 -0.44248029E+01 -0.12490543E+01 -0.64189614E+01 0.54274013E+01 -0.81785463E+00 -0.74995750E+01 -0.63413063E+03 0.95574845E+02 0.30964516E+02 -0.74348304E+01 0.70509125E+02 -0.10625014E+02 -0.74796868E+01 -0.21114013E+01 -0.16778735E+01 -0.17511047E-01 -0.31793598E+00 -0.28114965E-02 0.55474903E+03 0.29553440E-01 -0.18227636E+00 -0.19023186E-02 -0.67335162E+00 -0.28042008E-02 -0.29888915E+00 -0.31193424E-02 -0.36860291E+01 0.47680567E+01 -0.43982700E+01 -0.36390682E+03 -0.10278084E+03 0.18064403E+02 -0.42463847E+01 0.42136737E+02 -0.43874214E+01 -0.13348595E+01 -0.62308592E+01 0.80599173E+01 -0.12292842E+01 -0.74348304E+01 -0.61514765E+03 0.93163769E+02 0.30536050E+02 -0.71780887E+01 0.71227889E+02 -0.10863549E+02 -0.74164918E+01 -0.22564449E+01 -0.10131165E+01 -0.10573342E-01 -0.24825922E+00 -0.19023186E-02 0.51920487E+03 0.18823489E-01 -0.11827383E+00 -0.12343592E-02 -0.51884683E+00 -0.18782924E-02 -0.18675856E+00 -0.19490968E-02 -0.35398843E+01 0.64838811E+01 -0.42463847E+01 -0.34419200E+03 -0.96916962E+02 0.17439049E+02 -0.39733548E+01 0.40524145E+02 -0.41932912E+01 -0.14753468E+01 -0.59838204E+01 0.10960352E+02 -0.17017208E+01 -0.71780887E+01 -0.58182216E+03 0.88768635E+02 0.29478962E+02 -0.67165536E+01 0.68502014E+02 -0.10635726E+02 -0.70883394E+01 -0.24939263E+01 -0.66602986E+00 -0.69509890E-02 -0.19858635E+00 -0.12343592E-02 0.47252958E+03 0.12074909E-01 -0.28192377E-01 -0.29422840E-03 -0.36741877E+00 -0.12175774E-02 -0.11756918E+00 -0.12270051E-02 -0.33632083E+01 0.78886303E+01 -0.39733548E+01 -0.31651079E+03 -0.88678619E+02 0.16662947E+02 -0.37352263E+01 0.37856342E+02 -0.39198308E+01 -0.16614562E+01 -0.56851642E+01 0.13334930E+02 -0.20974954E+01 -0.67165536E+01 -0.53502944E+03 0.82092491E+02 0.28167030E+02 -0.63140265E+01 0.63992312E+02 -0.10065562E+02 -0.66260765E+01 -0.28085241E+01 -0.29930964E+00 -0.31237309E-02 -0.11643972E+00 -0.29422840E-03 0.43738055E+03 0.55958296E-02 -0.16217394E-02 -0.16925206E-04 -0.20947241E+00 -0.28999742E-03 -0.80340221E-01 -0.83846689E-03 -0.32388179E+01 0.86664178E+01 -0.37352263E+01 -0.29406254E+03 -0.82802041E+02 0.15978837E+02 -0.34760355E+01 0.34447542E+02 -0.36819706E+01 -0.18375694E+01 -0.54748978E+01 0.14649713E+02 -0.23563697E+01 -0.63140265E+01 -0.49708331E+03 0.77003990E+02 0.27010623E+02 -0.58758874E+01 0.58230126E+02 -0.93661703E+01 -0.62240031E+01 -0.31062273E+01 -0.20393809E+00 -0.21283901E-02 -0.11023481E+00 -0.16925206E-04 0.40269551E+03 0.37167283E-02 -0.14737675E-02 -0.15380905E-04 -0.12353727E+00 -0.16665148E-04 -0.57366022E-01 -0.59869776E-03 -0.30204609E+01 0.90983861E+01 -0.34760355E+01 -0.26989504E+03 -0.76449015E+02 0.15194425E+02 -0.32404837E+01 0.29659902E+02 -0.34229940E+01 -0.20259409E+01 -0.51057843E+01 0.15379904E+02 -0.24917653E+01 -0.58758874E+01 -0.45623034E+03 0.70887220E+02 0.25684645E+02 -0.54777135E+01 0.50137073E+02 -0.81229254E+01 -0.57862261E+01 -0.34246482E+01 -0.17307719E+00 -0.18063119E-02 -0.14162830E+00 -0.15380905E-04 0.37956711E+03 0.27342053E-02 -0.18468844E-02 -0.15122013E-04 -0.35584583E-01 -0.10490999E-04 -0.28594450E+01 0.87075681E+01 -0.32404837E+01 -0.24332481E+03 -0.72082031E+02 0.11483163E+02 0.16689927E+02 -0.31862433E+01 -0.21889664E+01 -0.48336058E+01 0.14719273E+02 -0.23847611E+01 -0.54777135E+01 -0.41131626E+03 0.63780781E+02 0.19411139E+02 0.28212653E+02 -0.45709076E+01 -0.53860258E+01 -0.37002288E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.23326301E+00 -0.24344383E-02 0.57507916E+03 0.38357379E-02 -0.61330853E-01 -0.24941367E-04 -0.24053318E+00 -0.24894191E-04 -0.19741121E-01 -0.76162909E-05 -0.45169952E+01 -0.37305396E+03 -0.10022923E+03 0.15487904E+02 0.12056910E+01 -0.47705675E+01 0.41710395E+02 -0.47620287E+01 -0.14261365E+01 -0.76355288E+01 -0.63061041E+03 0.11299210E+03 0.26180753E+02 0.20381001E+01 -0.33018964E+00 -0.80641672E+01 0.70507252E+02 -0.11422778E+02 -0.80497333E+01 -0.24107412E+01 -0.25679995E+00 -0.26800805E-02 -0.23898319E-02 -0.24941367E-04 0.57512775E+03 0.41066606E-02 -0.87123907E-01 -0.25087633E-04 -0.24811441E+00 -0.25032665E-04 -0.51195054E-02 -0.76616229E-05 -0.44945266E+01 -0.47705675E+01 -0.37403651E+03 -0.10925131E+03 0.20220255E+02 0.14464879E+01 -0.47706176E+01 0.42446987E+02 -0.47606802E+01 -0.14116883E+01 -0.75975428E+01 -0.80641672E+01 -0.63227092E+03 0.98012889E+02 0.34180302E+02 0.24451416E+01 -0.39613289E+00 -0.80642470E+01 0.71752342E+02 -0.11624465E+02 -0.80474488E+01 -0.23863159E+01 -0.30342498E+00 -0.31666804E-02 -0.24038469E-02 -0.25087633E-04 0.57515641E+03 0.52770057E-02 -0.79344378E-02 -0.25382928E-04 -0.24183986E+00 -0.25312166E-04 -0.66178409E-01 -0.69066782E-03 -0.44472212E+01 -0.47706176E+01 -0.37464345E+03 -0.10924511E+03 0.20149213E+02 0.39033555E+00 -0.47709720E+01 0.44102251E+02 -0.47581730E+01 -0.13900576E+01 -0.75175827E+01 -0.80642470E+01 -0.63329729E+03 0.98193118E+02 0.34060225E+02 0.65982322E+00 -0.10689604E+00 -0.80648511E+01 0.74550445E+02 -0.12077701E+02 -0.80432156E+01 -0.23497534E+01 -0.32667434E+00 -0.34093212E-02 -0.24321414E-02 -0.25382928E-04 0.57529329E+03 0.63019063E-02 -0.47552521E-01 -0.49627962E-03 -0.30674308E+00 -0.25241294E-03 -0.73306335E-01 -0.76505808E-03 -0.44233411E+01 -0.47709720E+01 -0.37636258E+03 -0.10907205E+03 0.20050582E+02 -0.47241863E+01 0.46208999E+02 -0.47371923E+01 -0.13827379E+01 -0.74772107E+01 -0.80648511E+01 -0.63620291E+03 0.98474973E+02 0.33893491E+02 -0.79857645E+01 0.78111643E+02 -0.12595337E+02 -0.80077441E+01 -0.23373788E+01 -0.32665177E+00 -0.34090856E-02 -0.63767677E-01 -0.49627962E-03 0.57538353E+03 0.66288635E-02 -0.24141033E-02 -0.25194674E-04 -0.37051672E+00 -0.49508786E-03 -0.80441990E-01 -0.83952900E-03 -0.44248029E+01 0.15957294E+01 -0.47241863E+01 -0.37965795E+03 -0.10888646E+03 0.20020417E+02 -0.47703035E+01 0.47904941E+02 -0.47132973E+01 -0.13756968E+01 -0.74796868E+01 0.26974210E+01 -0.43276435E+00 -0.79857645E+01 -0.64177380E+03 0.99168081E+02 0.33842508E+02 -0.80637164E+01 0.80978512E+02 -0.12991897E+02 -0.79673577E+01 -0.23254778E+01 -0.26869291E+00 -0.28042008E-02 -0.63581913E-01 -0.25194674E-04 0.57525873E+03 0.48382758E-02 -0.23029972E-02 -0.24035121E-04 -0.33088133E+00 -0.25145119E-04 -0.59007951E-01 -0.61583367E-03 -0.43874214E+01 0.35641332E+01 -0.47703035E+01 -0.38200388E+03 -0.10924551E+03 0.19950620E+02 -0.46228863E+01 0.48289200E+02 -0.47614281E+01 -0.13964088E+01 -0.74164918E+01 0.60248073E+01 -0.97606576E+00 -0.80637164E+01 -0.64573900E+03 0.10020851E+03 0.33724511E+02 -0.78145269E+01 0.81628018E+02 -0.13224376E+02 -0.80487133E+01 -0.23604874E+01 -0.17997422E+00 -0.18782924E-02 -0.11448077E+00 -0.24035121E-04 0.54067833E+03 0.32197793E-02 -0.21259208E-02 -0.22187071E-04 -0.30833229E+00 -0.23990032E-04 -0.13839797E-01 -0.80577291E-05 -0.41932912E+01 0.57457621E+01 -0.46228863E+01 -0.36306423E+03 -0.10269365E+03 0.19287736E+02 -0.43364913E+01 0.46980387E+02 -0.46146947E+01 -0.15089297E+01 -0.70883394E+01 0.97126360E+01 -0.15735346E+01 -0.78145269E+01 -0.61372377E+03 0.95280061E+02 0.32603984E+02 -0.73304000E+01 0.79415645E+02 -0.12866050E+02 -0.78006799E+01 -0.25506948E+01 -0.11666583E+00 -0.12175774E-02 -0.15370768E+00 -0.22187071E-04 0.50616727E+03 0.24728039E-02 -0.19243063E-02 -0.20082931E-04 -0.26547366E+00 -0.21915232E-04 -0.45514360E-01 -0.84730171E-05 -0.39198308E+01 0.78590684E+01 -0.43364913E+01 -0.34227959E+03 -0.96142388E+02 0.18194383E+02 -0.39985084E+01 0.43895681E+02 -0.42838474E+01 -0.16449913E+01 -0.66260765E+01 0.13284960E+02 -0.21523019E+01 -0.73304000E+01 -0.57858903E+03 0.89845061E+02 0.30755768E+02 -0.67590784E+01 0.74201208E+02 -0.12021368E+02 -0.72414106E+01 -0.27806916E+01 -0.27786973E-01 -0.28999742E-03 -0.14812760E+00 -0.20082931E-04 0.46009423E+03 0.14319779E-02 -0.17349305E-02 -0.18106519E-04 -0.23696305E+00 -0.19590447E-04 -0.58360867E-01 -0.91538248E-05 -0.36819706E+01 0.95606028E+01 -0.39985084E+01 -0.31505563E+03 -0.87403089E+02 0.17081396E+02 -0.36678429E+01 0.41382436E+02 -0.39008968E+01 -0.18224369E+01 -0.62240031E+01 0.16161243E+02 -0.26183124E+01 -0.67590784E+01 -0.53257003E+03 0.82741962E+02 0.28874387E+02 -0.62001176E+01 0.69952869E+02 -0.11333192E+02 -0.65940759E+01 -0.30806474E+01 -0.15968212E-02 -0.16665148E-04 -0.16533186E+00 -0.18106519E-04 0.42564353E+03 0.10727203E-02 -0.15518553E-02 -0.16195864E-04 -0.26510563E+00 -0.17618593E-04 -0.59577134E-01 -0.97283995E-05 -0.34229940E+01 0.11886166E+02 -0.36678429E+01 -0.29901873E+03 -0.80847251E+02 0.16020787E+02 -0.33809302E+01 0.42827330E+02 -0.35694188E+01 -0.19705921E+01 -0.57862261E+01 0.20092362E+02 -0.32552296E+01 -0.62001176E+01 -0.50546093E+03 0.78617985E+02 0.27081526E+02 -0.57151243E+01 0.72395271E+02 -0.11728997E+02 -0.60337414E+01 -0.33310866E+01 -0.14489610E-02 -0.15122013E-04 -0.26775677E+00 -0.16195864E-04 0.39101108E+03 0.95535783E-03 -0.59779534E-01 -0.10278589E-04 -0.31862433E+01 0.20669061E+02 -0.33809302E+01 -0.24516982E+03 -0.74289358E+02 0.87210274E+01 -0.21455762E+01 -0.53860258E+01 0.34938980E+02 -0.56606570E+01 -0.57151243E+01 -0.41443506E+03 0.64143619E+02 0.14742025E+02 -0.36268820E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.23853116E-02 -0.24894191E-04 0.57485382E+03 0.14276539E-02 -0.69040852E-01 -0.25585438E-04 -0.23914903E+00 -0.25509959E-04 -0.55206415E-01 -0.78195004E-05 -0.47620287E+01 -0.37818800E+03 -0.10026451E+03 0.15762163E+02 0.19554283E+01 -0.47716102E+01 0.46140393E+02 -0.47580907E+01 -0.14582423E+01 -0.80497333E+01 -0.63928900E+03 0.11431216E+03 0.26644360E+02 0.33054560E+01 -0.53550504E+00 -0.80659299E+01 0.77995721E+02 -0.12635806E+02 -0.80430765E+01 -0.24650128E+01 -0.23985799E-02 -0.25032665E-04 -0.24515455E-02 -0.25585438E-04 0.57486458E+03 0.14534908E-02 -0.80982370E-01 -0.25634127E-04 -0.23200970E+00 -0.25550840E-04 -0.55119630E-01 -0.78381908E-05 -0.47606802E+01 -0.47716102E+01 -0.38094393E+03 -0.10928573E+03 0.20531953E+02 0.31282473E+01 -0.47717070E+01 0.47718748E+02 -0.47567900E+01 -0.14589760E+01 -0.80474488E+01 -0.80659299E+01 -0.64394718E+03 0.99820041E+02 0.34707196E+02 0.52879856E+01 -0.85668723E+00 -0.80660879E+01 0.80663716E+02 -0.13068034E+02 -0.80408723E+01 -0.24662515E+01 -0.24253612E-02 -0.25312166E-04 -0.24562108E-02 -0.25634127E-04 0.57484861E+03 0.14539954E-02 -0.51146276E-01 -0.25710072E-04 -0.24387167E+00 -0.25618235E-04 -0.53671820E-01 -0.78650378E-05 -0.47581730E+01 -0.47717070E+01 -0.38375362E+03 -0.10928258E+03 0.20527605E+02 0.24899798E+01 -0.47718289E+01 0.51162626E+02 -0.47553911E+01 -0.14583174E+01 -0.80432156E+01 -0.80660879E+01 -0.64869713E+03 0.10059674E+03 0.34699859E+02 0.42090618E+01 -0.68189325E+00 -0.80662996E+01 0.86485303E+02 -0.14011138E+02 -0.80385130E+01 -0.24651397E+01 -0.24185703E-01 -0.25241294E-03 -0.24634877E-02 -0.25710072E-04 0.57490045E+03 0.16813887E-02 -0.26877149E-01 -0.25804428E-04 -0.30468985E+00 -0.25711604E-04 -0.46162916E-01 -0.78893794E-05 -0.47371923E+01 -0.47718289E+01 -0.38505782E+03 -0.10928134E+03 0.20498379E+02 0.10447785E+00 -0.47717809E+01 0.54850702E+02 -0.47552271E+01 -0.14501622E+01 -0.80077441E+01 -0.80662996E+01 -0.65090125E+03 0.10095682E+03 0.34650441E+02 0.17660924E+00 -0.28611716E-01 -0.80662125E+01 0.92719559E+02 -0.15021105E+02 -0.80382301E+01 -0.24513525E+01 -0.47438329E-01 -0.49508786E-03 -0.24725287E-02 -0.25804428E-04 0.57491829E+03 0.19241236E-02 -0.24623592E-02 -0.25698295E-04 -0.32828139E+00 -0.25763098E-04 -0.39116784E-01 -0.79051779E-05 -0.47132973E+01 -0.47717809E+01 -0.38727296E+03 -0.10025400E+03 0.20466586E+02 -0.47712987E+01 0.57167553E+02 -0.47551848E+01 -0.14428372E+01 -0.79673577E+01 -0.80662125E+01 -0.65464621E+03 0.11682452E+03 0.34596706E+02 -0.80653990E+01 0.96636031E+02 -0.15655569E+02 -0.80381643E+01 -0.24389721E+01 -0.24093550E-02 -0.25145119E-04 -0.58354240E-01 -0.25698295E-04 0.57493642E+03 0.14537194E-02 -0.24482718E-02 -0.25551272E-04 -0.32882232E+00 -0.25608416E-04 -0.46988259E-01 -0.78592885E-05 -0.47614281E+01 0.31989950E+01 -0.47712987E+01 -0.39052649E+03 -0.10928015E+03 0.20521060E+02 -0.47704788E+01 0.57223219E+02 -0.47552192E+01 -0.14504481E+01 -0.80487133E+01 0.54075782E+01 -0.87606062E+00 -0.80653990E+01 -0.66014561E+03 0.10245752E+03 0.34688785E+02 -0.80640173E+01 0.96730076E+02 -0.15670861E+02 -0.80382181E+01 -0.24518359E+01 -0.22986769E-02 -0.23990032E-04 -0.13090690E+00 -0.25551272E-04 0.57501910E+03 0.14509787E-02 -0.23278464E-02 -0.24294459E-04 -0.33392357E+00 -0.25481281E-04 -0.56475911E-01 -0.78137698E-05 -0.46146947E+01 0.57425527E+01 -0.47704788E+01 -0.39129491E+03 -0.10928448E+03 0.20186025E+02 -0.45718624E+01 0.55453699E+02 -0.47580243E+01 -0.14587762E+01 -0.78006799E+01 0.97072109E+01 -0.15726313E+01 -0.80640173E+01 -0.66144491E+03 0.10265780E+03 0.34122453E+02 -0.77282720E+01 0.93738933E+02 -0.15186317E+02 -0.80429643E+01 -0.24659153E+01 -0.20998737E-02 -0.21915232E-04 -0.18420454E+00 -0.24294459E-04 0.52909333E+03 0.13365414E-02 -0.21140734E-02 -0.22063427E-04 -0.32053148E+00 -0.23521242E-04 -0.57097011E-01 -0.84205212E-05 -0.42838474E+01 0.79814062E+01 -0.45718624E+01 -0.36183494E+03 -0.10054776E+03 0.19068643E+02 -0.41902376E+01 0.50170634E+02 -0.44269149E+01 -0.15845640E+01 -0.72414106E+01 0.13491762E+02 -0.21857632E+01 -0.77282720E+01 -0.61164545E+03 0.94936056E+02 0.32233618E+02 -0.70831776E+01 0.84808394E+02 -0.13739575E+02 -0.74832529E+01 -0.26785451E+01 -0.18771175E-02 -0.19590447E-04 -0.16038550E+00 -0.22063427E-04 0.48305359E+03 0.12210278E-02 -0.19047534E-02 -0.19878868E-04 -0.26610429E+00 -0.21544321E-04 -0.57996357E-01 -0.91411352E-05 -0.39008968E+01 0.85022034E+01 -0.41902376E+01 -0.33090803E+03 -0.91807741E+02 0.17737475E+02 -0.38079455E+01 0.45134249E+02 -0.40921523E+01 -0.17360007E+01 -0.65940759E+01 0.14372125E+02 -0.23283983E+01 -0.70831776E+01 -0.55936694E+03 0.86820392E+02 0.29983424E+02 -0.64369470E+01 0.76294935E+02 -0.12360385E+02 -0.69173742E+01 -0.29345355E+01 -0.16881784E-02 -0.17618593E-04 -0.12017962E+00 -0.19878868E-04 0.43702283E+03 0.10881647E-02 -0.23734229E+00 -0.19354806E-04 -0.58560585E-01 -0.10017061E-04 -0.35694188E+01 0.70459977E+01 -0.38079455E+01 -0.29843639E+03 -0.83065671E+02 0.13013397E+02 0.40527498E+02 -0.37079928E+01 -0.19187718E+01 -0.60337414E+01 0.11910547E+02 -0.19296126E+01 -0.64369470E+01 -0.50447656E+03 0.78286656E+02 0.21997831E+02 0.68507639E+02 -0.11098836E+02 -0.62679871E+01 -0.32434895E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.24443132E-02 -0.25509959E-04 0.57478946E+03 0.14296456E-02 -0.62044278E-01 -0.26688160E-04 -0.22352072E+00 -0.25425414E-04 -0.56169102E-01 -0.81663047E-05 -0.47580907E+01 -0.38266089E+03 -0.10030582E+03 0.15551099E+02 0.35517256E+01 -0.47728386E+01 0.49071106E+02 -0.45475998E+01 -0.14603618E+01 -0.80430765E+01 -0.64684997E+03 0.11543532E+03 0.26287578E+02 0.60038370E+01 -0.97263799E+00 -0.80680064E+01 0.82949797E+02 -0.13438094E+02 -0.76872627E+01 -0.24685955E+01 -0.24482304E-02 -0.25550840E-04 -0.25572061E-02 -0.26688160E-04 0.57484386E+03 0.14571430E-02 -0.93051196E-01 -0.26770459E-04 -0.24476972E+00 -0.26083358E-04 -0.55215162E-01 -0.81907446E-05 -0.47567900E+01 -0.47728386E+01 -0.38785209E+03 -0.10932835E+03 0.20425388E+02 0.65986580E+01 -0.47726485E+01 0.51214427E+02 -0.46507363E+01 -0.14601662E+01 -0.80408723E+01 -0.80680064E+01 -0.65562483E+03 0.10160568E+03 0.34527060E+02 0.11154366E+02 -0.18070354E+01 -0.80676805E+01 0.86572821E+02 -0.14025016E+02 -0.78616002E+01 -0.24682635E+01 -0.24546880E-02 -0.25618235E-04 -0.25650918E-02 -0.26770459E-04 0.57493309E+03 0.14582277E-02 -0.11228963E+00 -0.26928272E-04 -0.31656758E+00 -0.26806025E-04 -0.53682695E-01 -0.82386264E-05 -0.47553911E+01 -0.47726485E+01 -0.39452018E+03 -0.10932875E+03 0.20524561E+02 0.61930383E+01 -0.47726177E+01 0.58288778E+02 -0.47516012E+01 -0.14600938E+01 -0.80385130E+01 -0.80676805E+01 -0.66689692E+03 0.10343025E+03 0.34694713E+02 0.10468712E+02 -0.16959515E+01 -0.80676330E+01 0.98531351E+02 -0.15962269E+02 -0.80321067E+01 -0.24681426E+01 -0.24636345E-02 -0.25711604E-04 -0.25802131E-02 -0.26928272E-04 0.57492132E+03 0.14588529E-02 -0.50668791E-01 -0.27077998E-04 -0.36617143E+00 -0.26972819E-04 -0.52128653E-01 -0.82886627E-05 -0.47552271E+01 -0.47726177E+01 -0.39794035E+03 -0.10932680E+03 0.20528588E+02 0.24299921E+01 -0.47727468E+01 0.65469467E+02 -0.47549139E+01 -0.14608747E+01 -0.80382301E+01 -0.80676330E+01 -0.67267788E+03 0.10437131E+03 0.34701505E+02 0.41076556E+01 -0.66544656E+00 -0.80678453E+01 0.11066951E+03 -0.17928632E+02 -0.80377006E+01 -0.24694602E+01 -0.24685685E-02 -0.25763098E-04 -0.25945596E-02 -0.27077998E-04 0.57491705E+03 0.14591127E-02 -0.25925027E-02 -0.27056531E-04 -0.40929373E+00 -0.27031042E-04 -0.51377246E-01 -0.83065546E-05 -0.47551848E+01 -0.47727468E+01 -0.39975022E+03 -0.10932556E+03 0.20528470E+02 -0.47725660E+01 0.69707805E+02 -0.47549027E+01 -0.14608630E+01 -0.80381643E+01 -0.80678453E+01 -0.67573777E+03 0.10486962E+03 0.34701317E+02 -0.80675420E+01 0.11783407E+03 -0.19089266E+02 -0.80376875E+01 -0.24694428E+01 -0.24537472E-02 -0.25608416E-04 -0.57927708E-01 -0.27056531E-04 0.57495935E+03 0.14586587E-02 -0.25753546E-02 -0.26877566E-04 -0.39677260E+00 -0.26960165E-04 -0.51990619E-01 -0.82830240E-05 -0.47552192E+01 0.31437670E+01 -0.47725660E+01 -0.40167152E+03 -0.10932652E+03 0.20529394E+02 -0.47721327E+01 0.68486522E+02 -0.47562860E+01 -0.14609828E+01 -0.80382181E+01 0.53142214E+01 -0.86091209E+00 -0.80675420E+01 -0.67898527E+03 0.10539374E+03 0.34702875E+02 -0.80668130E+01 0.11576957E+03 -0.18754848E+02 -0.80400223E+01 -0.24696437E+01 -0.24415654E-02 -0.25481281E-04 -0.12610705E+00 -0.26877566E-04 0.57500724E+03 0.14570466E-02 -0.24732826E-02 -0.25812297E-04 -0.37633253E+00 -0.26785208E-04 -0.53475055E-01 -0.82253849E-05 -0.47580243E+01 0.75519975E+01 -0.47721327E+01 -0.40178322E+03 -0.10932794E+03 0.20383029E+02 -0.46239093E+01 0.64191733E+02 -0.47564077E+01 -0.14603466E+01 -0.80429643E+01 0.12765896E+02 -0.20681019E+01 -0.80668130E+01 -0.67917436E+03 0.10542131E+03 0.34455466E+02 -0.78162509E+01 0.10850970E+03 -0.17578799E+02 -0.80402315E+01 -0.24685699E+01 -0.22537584E-02 -0.23521242E-04 -0.17606838E+00 -0.25812297E-04 0.54055330E+03 0.13706714E-02 -0.22970968E-02 -0.23973542E-04 -0.34175937E+00 -0.25475303E-04 -0.54844342E-01 -0.86688503E-05 -0.44269149E+01 0.95580479E+01 -0.46239093E+01 -0.37674337E+03 -0.10277157E+03 0.19517038E+02 -0.43377454E+01 0.56952369E+02 -0.45641563E+01 -0.15528349E+01 -0.74832529E+01 0.16156913E+02 -0.26174681E+01 -0.78162509E+01 -0.63684655E+03 0.98833318E+02 0.32991584E+02 -0.73325248E+01 0.96272217E+02 -0.15596386E+02 -0.77152444E+01 -0.26249103E+01 -0.20643337E-02 -0.21544321E-04 -0.19807344E+00 -0.23973542E-04 0.50605598E+03 0.12828126E-02 -0.21007017E-02 -0.21923874E-04 -0.29231577E+00 -0.23634552E-04 -0.56318974E-01 -0.91602712E-05 -0.40921523E+01 0.10116997E+02 -0.43377454E+01 -0.34911006E+03 -0.96216272E+02 0.18374990E+02 -0.40000020E+01 0.48568136E+02 -0.42769539E+01 -0.16573901E+01 -0.69173742E+01 0.17101772E+02 -0.27705515E+01 -0.73325248E+01 -0.59013565E+03 0.91532256E+02 0.31061078E+02 -0.67615985E+01 0.82099576E+02 -0.13300440E+02 -0.72297629E+01 -0.28016522E+01 -0.18545388E-02 -0.19354806E-04 -0.13037112E+00 -0.21923874E-04 0.45988358E+03 0.11474481E-02 -0.14544903E+00 -0.21098457E-04 -0.57318543E-01 -0.10010604E-04 -0.37079928E+01 0.77991083E+01 -0.40000020E+01 -0.30975874E+03 -0.87470802E+02 0.13394024E+02 0.37938706E+02 -0.38499013E+01 -0.18263584E+01 -0.62679871E+01 0.13183603E+02 -0.21358043E+01 -0.67615985E+01 -0.52361580E+03 0.81123098E+02 0.22641243E+02 0.64131542E+02 -0.10389604E+02 -0.65078683E+01 -0.30872741E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.50551705E+03 0.12406478E-02 -0.24057914E-02 -0.25107928E-04 -0.22066738E-02 -0.23029846E-04 -0.57686407E-01 -0.99051999E-05 -0.31019601E+03 -0.96262683E+02 0.97862578E+01 -0.42940391E+01 0.19835020E+02 -0.38097221E+01 -0.16717298E+01 -0.52435500E+03 0.80758997E+02 0.16542684E+02 -0.72586437E+01 0.33529096E+02 -0.54316301E+01 -0.64399502E+01 -0.28258900E+01 -0.24362123E-02 -0.25425414E-04 -0.74876051E-01 -0.25107928E-04 0.52865880E+03 0.13461324E-02 -0.73997074E-01 -0.26227671E-04 -0.84434598E-02 -0.23686270E-04 -0.56046068E-01 -0.93289205E-05 -0.45475998E+01 0.13837884E+02 -0.42940391E+01 -0.35889487E+03 -0.10062627E+03 0.18984973E+02 0.43310283E+01 -0.44853735E+01 0.37150315E+02 -0.40513848E+01 -0.15953249E+01 -0.76872627E+01 0.23391558E+02 -0.37894005E+01 -0.72586437E+01 -0.60667588E+03 0.93934360E+02 0.32092198E+02 0.73211702E+01 -0.11860196E+01 -0.75820754E+01 0.62798893E+02 -0.10173335E+02 -0.68484609E+01 -0.26967372E+01 -0.24992552E-02 -0.26083358E-04 -0.25130830E-02 -0.26227671E-04 0.55177232E+03 0.14044010E-02 -0.15668612E+00 -0.27455381E-04 -0.13782599E+00 -0.25552152E-04 -0.53265675E-01 -0.89667033E-05 -0.46507363E+01 -0.44853735E+01 -0.37906662E+03 -0.10500044E+03 0.19704360E+02 0.12333979E+02 -0.46764159E+01 0.49956892E+02 -0.43529070E+01 -0.15271880E+01 -0.78616002E+01 -0.75820754E+01 -0.64077381E+03 0.99271279E+02 0.33308234E+02 0.20849344E+02 -0.33775593E+01 -0.79050080E+01 0.84447076E+02 -0.13680288E+02 -0.73581490E+01 -0.25815568E+01 -0.25684997E-02 -0.26806025E-04 -0.26307197E-02 -0.27455381E-04 0.57492296E+03 0.14624084E-02 -0.16198256E+00 -0.28322849E-04 -0.31386583E+00 -0.27259136E-04 -0.48974647E-01 -0.86838251E-05 -0.47516012E+01 -0.46764159E+01 -0.40792812E+03 -0.10937761E+03 0.20272988E+02 0.13362148E+02 -0.47738776E+01 0.64594518E+02 -0.45952814E+01 -0.14635822E+01 -0.80321067E+01 -0.79050080E+01 -0.68956168E+03 0.10697965E+03 0.34269454E+02 0.22587375E+02 -0.36590933E+01 -0.80697626E+01 0.10919057E+03 -0.17688576E+02 -0.77678636E+01 -0.24740393E+01 -0.25844816E-02 -0.26972819E-04 -0.27138387E-02 -0.28322849E-04 0.57507018E+03 0.14650380E-02 -0.94098850E-01 -0.28635332E-04 -0.53819792E+00 -0.28456061E-04 -0.43304230E-01 -0.87599193E-05 -0.47549139E+01 -0.47738776E+01 -0.41669717E+03 -0.10938061E+03 0.20519955E+02 0.66853787E+01 -0.47738909E+01 0.80044732E+02 -0.47447320E+01 -0.14603090E+01 -0.80377006E+01 -0.80697626E+01 -0.70438450E+03 0.10937287E+03 0.34686913E+02 0.11300958E+02 -0.18307135E+01 -0.80697798E+01 0.13530754E+03 -0.21919324E+02 -0.80204896E+01 -0.24685050E+01 -0.25900604E-02 -0.27031042E-04 -0.27437802E-02 -0.28635332E-04 0.57506595E+03 0.14657043E-02 -0.27497649E-02 -0.28697790E-04 -0.62907866E+00 -0.28632140E-04 -0.39838055E-01 -0.88100746E-05 -0.47549027E+01 -0.47738909E+01 -0.41895970E+03 -0.10938104E+03 0.20522181E+02 -0.47738956E+01 0.88993349E+02 -0.47469534E+01 -0.14603067E+01 -0.80376875E+01 -0.80697798E+01 -0.70820948E+03 0.10999085E+03 0.34690686E+02 -0.80697896E+01 0.15043436E+03 -0.24369717E+02 -0.80242501E+01 -0.24685025E+01 -0.25832691E-02 -0.26960165E-04 -0.70760107E-01 -0.28697790E-04 0.57510738E+03 0.14652996E-02 -0.27223071E-02 -0.28411228E-04 -0.60098619E+00 -0.28563549E-04 -0.41964468E-01 -0.87739954E-05 -0.47562860E+01 0.43901562E+01 -0.47738956E+01 -0.41833130E+03 -0.10938150E+03 0.20527906E+02 -0.47737187E+01 0.83975321E+02 -0.47522972E+01 -0.14594767E+01 -0.80400223E+01 0.74211168E+01 -0.12021920E+01 -0.80697896E+01 -0.70714692E+03 0.10981801E+03 0.34700360E+02 -0.80694940E+01 0.14195182E+03 -0.22995641E+02 -0.80332795E+01 -0.24670980E+01 -0.25665051E-02 -0.26785208E-04 -0.14676595E+00 -0.28411228E-04 0.57507029E+03 0.14638510E-02 -0.26614878E-02 -0.27776491E-04 -0.48044860E+00 -0.28301956E-04 -0.46530041E-01 -0.86924355E-05 -0.47564077E+01 0.11865530E+02 -0.47737187E+01 -0.41626645E+03 -0.10937908E+03 0.20483830E+02 -0.47250120E+01 0.74431540E+02 -0.47560321E+01 -0.14604292E+01 -0.80402315E+01 0.20057491E+02 -0.32492529E+01 -0.80694940E+01 -0.70365680E+03 0.10925919E+03 0.34625861E+02 -0.79871544E+01 0.12581907E+03 -0.20382310E+02 -0.80395966E+01 -0.24687096E+01 -0.24409926E-02 -0.25475303E-04 -0.20002262E+00 -0.27776491E-04 0.56352835E+03 0.14329259E-02 -0.25152802E-02 -0.26250602E-04 -0.36799836E+00 -0.27663830E-04 -0.50662846E-01 -0.87673732E-05 -0.45641563E+01 0.14573841E+02 -0.47250120E+01 -0.40302041E+03 -0.10719043E+03 0.20027838E+02 -0.45288581E+01 0.65074723E+02 -0.47065101E+01 -0.14913157E+01 -0.77152444E+01 0.24635603E+02 -0.39909248E+01 -0.79871544E+01 -0.68126520E+03 0.10573024E+03 0.33855038E+02 -0.76555817E+01 0.11000223E+03 -0.17820172E+02 -0.79558789E+01 -0.25209182E+01 -0.22646155E-02 -0.23634552E-04 -0.23641910E+00 -0.26250602E-04 0.52896125E+03 0.13447081E-02 -0.22650799E-02 -0.23639399E-04 -0.22590056E+00 -0.25613009E-04 -0.53706823E-01 -0.92257162E-05 -0.42769539E+01 0.15644070E+02 -0.45288581E+01 -0.37281321E+03 -0.10062862E+03 0.18965360E+02 -0.41372028E+01 0.53596444E+02 -0.44195152E+01 -0.15915783E+01 -0.72297629E+01 0.26444736E+02 -0.42840328E+01 -0.76555817E+01 -0.63020345E+03 0.97740717E+02 0.32059040E+02 -0.69935225E+01 0.90599428E+02 -0.14677058E+02 -0.74707486E+01 -0.26904039E+01 -0.20216120E-02 -0.21098457E-04 -0.26132781E+00 -0.23639399E-04 0.47136634E+03 0.11796732E-02 -0.51081988E-01 -0.22804627E-04 -0.55373045E-01 -0.10189061E-04 -0.38499013E+01 0.14276224E+02 -0.41372028E+01 -0.31413612E+03 -0.89695520E+02 0.13771905E+02 0.29290310E+02 -0.39916066E+01 -0.17831636E+01 -0.65078683E+01 0.24132512E+02 -0.39094881E+01 -0.69935225E+01 -0.53101534E+03 0.82134742E+02 0.23280012E+02 0.49512306E+02 -0.80210370E+01 -0.67474068E+01 -0.30142581E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.18958112E+00 -0.23029846E-04 0.42537296E+03 0.10715340E-02 -0.12628141E+00 -0.22183240E-04 -0.19073349E-02 -0.19905810E-04 -0.57003955E-01 -0.11969802E-04 -0.38097221E+01 -0.26914069E+03 -0.80988821E+02 0.12675962E+02 0.27187583E+01 -0.36700656E+01 0.22310249E+02 -0.32068077E+01 -0.19802948E+01 -0.64399502E+01 -0.45495508E+03 0.70082321E+02 0.21427431E+02 0.45957857E+01 -0.74449701E+00 -0.62038744E+01 0.37713218E+02 -0.61093750E+01 -0.54207838E+01 -0.33474880E+01 -0.22695710E-02 -0.23686270E-04 -0.21255537E-02 -0.22183240E-04 0.45971170E+03 0.11786059E-02 -0.18440792E+00 -0.24261411E-04 -0.21320279E-02 -0.22250808E-04 -0.54499852E-01 -0.11137754E-04 -0.40513848E+01 -0.36700656E+01 -0.30965220E+03 -0.87547250E+02 0.17112696E+02 0.13093529E+02 -0.40014572E+01 0.32643080E+02 -0.35431100E+01 -0.18368744E+01 -0.68484609E+01 -0.62038744E+01 -0.52343607E+03 0.80902187E+02 0.28927296E+02 0.22133302E+02 -0.35854881E+01 -0.67640633E+01 0.55179862E+02 -0.89388715E+01 -0.59892731E+01 -0.31050525E+01 -0.24483561E-02 -0.25552152E-04 -0.23246798E-02 -0.24261411E-04 0.50591618E+03 0.12930679E-02 -0.30440354E+00 -0.26645486E-04 -0.14649951E+00 -0.23763460E-04 -0.48561085E-01 -0.10237645E-04 -0.43529070E+01 -0.40014572E+01 -0.36019235E+03 -0.96302513E+02 0.18242362E+02 0.22638721E+02 -0.43393966E+01 0.47247510E+02 -0.38706427E+01 -0.16671745E+01 -0.73581490E+01 -0.67640633E+01 -0.60886882E+03 0.94350579E+02 0.30836875E+02 0.38268474E+02 -0.61992643E+01 -0.73353123E+01 0.79867150E+02 -0.12938001E+02 -0.65429310E+01 -0.28181894E+01 -0.26119159E-02 -0.27259136E-04 -0.25531172E-02 -0.26645486E-04 0.54060151E+03 0.13826741E-02 -0.36581696E+00 -0.28986084E-04 -0.32336120E+00 -0.26733988E-04 -0.37939151E-01 -0.97877547E-05 -0.45952814E+01 -0.43393966E+01 -0.40561228E+03 -0.10287077E+03 0.19402726E+02 0.25964243E+02 -0.46265250E+01 0.69551885E+02 -0.42678508E+01 -0.15621511E+01 -0.77678636E+01 -0.73353123E+01 -0.68564699E+03 0.10648907E+03 0.32798363E+02 0.43889957E+02 -0.71098200E+01 -0.78206778E+01 0.11757051E+03 -0.19045476E+02 -0.72143749E+01 -0.26406602E+01 -0.27266028E-02 -0.28456061E-04 -0.27773886E-02 -0.28986084E-04 0.57512809E+03 0.14710524E-02 -0.18542539E+00 -0.30563854E-04 -0.58596145E+00 -0.29723276E-04 -0.23834622E-01 -0.94021289E-05 -0.47447320E+01 -0.46265250E+01 -0.44592885E+03 -0.10943785E+03 0.20272320E+02 0.15650290E+02 -0.47751626E+01 0.10039086E+03 -0.46448017E+01 -0.14688418E+01 -0.80204896E+01 -0.78206778E+01 -0.75379764E+03 0.11723273E+03 0.34268312E+02 0.26455233E+02 -0.42854807E+01 -0.80719295E+01 0.16970060E+03 -0.27489782E+02 -0.78515677E+01 -0.24829287E+01 -0.27434744E-02 -0.28632140E-04 -0.29285674E-02 -0.30563854E-04 0.57520322E+03 0.14740832E-02 -0.29416280E-02 -0.30700161E-04 -0.85968395E+00 -0.30749960E-04 -0.11791679E-01 -0.95039760E-05 -0.47469534E+01 -0.47751626E+01 -0.45529778E+03 -0.10944174E+03 0.20525033E+02 -0.47749737E+01 0.12541576E+03 -0.47484940E+01 -0.14671910E+01 -0.80242501E+01 -0.80719295E+01 -0.76963537E+03 0.11978744E+03 0.34695505E+02 -0.80716104E+01 0.21200280E+03 -0.34342032E+02 -0.80268543E+01 -0.24801396E+01 -0.27369021E-02 -0.28563549E-04 -0.99876087E-01 -0.30700161E-04 0.57516494E+03 0.14732997E-02 -0.28922477E-02 -0.30184806E-04 -0.71220218E+00 -0.30505978E-04 -0.20158733E-01 -0.94187340E-05 -0.47522972E+01 0.95332522E+01 -0.47749737E+01 -0.44573274E+03 -0.10943806E+03 0.20524459E+02 -0.47743924E+01 0.10631215E+03 -0.47456943E+01 -0.14648449E+01 -0.80332795E+01 0.16114999E+02 -0.26104598E+01 -0.80716104E+01 -0.75346616E+03 0.11717810E+03 0.34694530E+02 -0.80706327E+01 0.17970995E+03 -0.29111112E+02 -0.80221160E+01 -0.24761723E+01 -0.27118368E-02 -0.28301956E-04 -0.26835624E+00 -0.30184806E-04 0.57520815E+03 0.14712649E-02 -0.28382956E-02 -0.29621737E-04 -0.56931617E+00 -0.30004439E-04 -0.33098183E-01 -0.92428001E-05 -0.47560321E+01 0.21512569E+02 -0.47743924E+01 -0.43681580E+03 -0.10943408E+03 0.20524231E+02 -0.47731085E+01 0.85410030E+02 -0.47465937E+01 -0.14618491E+01 -0.80395966E+01 0.36364846E+02 -0.58907798E+01 -0.80706327E+01 -0.73839342E+03 0.11474748E+03 0.34694155E+02 -0.80684581E+01 0.14437711E+03 -0.23387800E+02 -0.80236419E+01 -0.24711096E+01 -0.26506929E-02 -0.27663830E-04 -0.31107453E+00 -0.29621737E-04 0.57514268E+03 0.14678365E-02 -0.26956843E-02 -0.28133381E-04 -0.44832657E+00 -0.29452477E-04 -0.43135835E-01 -0.90771279E-05 -0.47065101E+01 0.23423199E+02 -0.47731085E+01 -0.42683226E+03 -0.10943152E+03 0.20326504E+02 -0.46255575E+01 0.73511831E+02 -0.47465231E+01 -0.14625507E+01 -0.79558789E+01 0.39594554E+02 -0.64140399E+01 -0.80684581E+01 -0.72151684E+03 0.11202164E+03 0.34359905E+02 -0.78190422E+01 0.12426433E+03 -0.20129948E+02 -0.80235181E+01 -0.24722944E+01 -0.24541873E-02 -0.25613009E-04 -0.36670428E+00 -0.28133381E-04 0.54076809E+03 0.13791015E-02 -0.24187469E-02 -0.25243137E-04 -0.47462177E+00 -0.27428044E-04 -0.48717647E-01 -0.94536151E-05 -0.44195152E+01 0.23835402E+02 -0.46255575E+01 -0.40613436E+03 -0.10286765E+03 0.19409339E+02 -0.42882222E+01 0.72197736E+02 -0.45102819E+01 -0.15542434E+01 -0.74707486E+01 0.40291363E+02 -0.65269939E+01 -0.78190422E+01 -0.68652953E+03 0.10664209E+03 0.32809543E+02 -0.72488069E+01 0.12204305E+03 -0.19770349E+02 -0.76241805E+01 -0.26272931E+01 -0.21850937E-02 -0.22804627E-04 -0.43512517E+00 -0.25243137E-04 0.49442470E+03 0.12137476E-02 -0.53505942E-01 -0.10006409E-04 -0.39916066E+01 0.35331745E+02 -0.42882222E+01 -0.31905106E+03 -0.94106391E+02 0.99901027E+01 -0.16997381E+01 -0.67474068E+01 0.59724749E+02 -0.96752944E+01 -0.72488069E+01 -0.53932361E+03 0.83202806E+02 0.16887259E+02 -0.28732354E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.22188495E-01 -0.19905810E-04 0.35624958E+03 0.90470568E-03 -0.12056436E+00 -0.19490644E-04 -0.16758613E-02 -0.17490047E-04 -0.56812041E-01 -0.14640770E-04 -0.32068077E+01 -0.23145383E+03 -0.67884610E+02 0.11464227E+02 0.94096397E+01 -0.31402877E+01 0.17558430E+02 -0.27507270E+01 -0.23587909E+01 -0.54207838E+01 -0.39124930E+03 0.60276811E+02 0.19379115E+02 0.15906044E+02 -0.25766673E+01 -0.53083387E+01 0.29680750E+02 -0.48080725E+01 -0.46498258E+01 -0.39872974E+01 -0.10442122E-01 -0.22250808E-04 -0.18675545E-02 -0.19490644E-04 0.40240967E+03 0.10367382E-02 -0.29821239E+00 -0.21851909E-04 -0.58779169E-01 -0.19325226E-04 -0.52065558E-01 -0.13125358E-04 -0.35431100E+01 -0.31402877E+01 -0.27845932E+03 -0.76645502E+02 0.15340356E+02 0.21802822E+02 -0.34800929E+01 0.25787942E+02 -0.30780453E+01 -0.20902235E+01 -0.59892731E+01 -0.53083387E+01 -0.47070763E+03 0.72743432E+02 0.25931334E+02 0.36855490E+02 -0.59702838E+01 -0.58827489E+01 0.43591937E+02 -0.70615323E+01 -0.52031278E+01 -0.35333138E+01 -0.22769672E-02 -0.23763460E-04 -0.20938062E-02 -0.21851909E-04 0.43705599E+03 0.11260789E-02 -0.41640767E+00 -0.24773945E-04 -0.15382048E+00 -0.21953293E-04 -0.39166332E-01 -0.12390340E-04 -0.38706427E+01 -0.34800929E+01 -0.32692845E+03 -0.83216692E+02 0.16556385E+02 0.35863226E+02 -0.38537242E+01 0.40410594E+02 -0.34153510E+01 -0.19272396E+01 -0.65429310E+01 -0.58827489E+01 -0.55263943E+03 0.85709818E+02 0.27986897E+02 0.60623151E+02 -0.98203101E+01 -0.65143303E+01 0.68310016E+02 -0.11065501E+02 -0.57733048E+01 -0.32578037E+01 -0.25615973E-02 -0.26733988E-04 -0.23737899E-02 -0.24773945E-04 0.49493426E+03 0.12728968E-02 -0.56088406E+00 -0.28811357E-04 -0.49629986E+00 -0.25522785E-04 -0.14348107E-01 -0.11291817E-04 -0.42678508E+01 -0.38537242E+01 -0.39920173E+03 -0.94176106E+02 0.18002224E+02 0.47350486E+02 -0.43330727E+01 0.68230276E+02 -0.38389315E+01 -0.16980784E+01 -0.72143749E+01 -0.65143303E+01 -0.67481061E+03 0.10497153E+03 0.30430955E+02 0.80041261E+02 -0.12965548E+02 -0.73246260E+01 0.11533646E+03 -0.18682869E+02 -0.64893297E+01 -0.28704318E+01 -0.28480249E-02 -0.29723276E-04 -0.27606466E-02 -0.28811357E-04 0.55265280E+03 0.14215661E-02 -0.43860921E+00 -0.32333973E-04 -0.93809341E+00 -0.30174259E-04 -0.98984396E-03 -0.10330459E-04 -0.46448017E+01 -0.43330727E+01 -0.47899523E+03 -0.10513858E+03 0.19561832E+02 0.37782580E+02 -0.46790249E+01 0.12462987E+03 -0.43673821E+01 -0.15257493E+01 -0.78515677E+01 -0.73246260E+01 -0.80969294E+03 0.12628357E+03 0.33067302E+02 0.63867626E+02 -0.10345390E+02 -0.79094179E+01 0.21067418E+03 -0.34125373E+02 -0.73826173E+01 -0.25791245E+01 -0.29463997E-02 -0.30749960E-04 -0.30981766E-02 -0.32333973E-04 0.57610393E+03 0.14841410E-02 -0.31852221E-02 -0.33242419E-04 -0.18658174E+01 -0.33766112E-04 -0.96472465E-03 -0.10068303E-04 -0.47484940E+01 -0.46790249E+01 -0.54056621E+03 -0.10952935E+03 0.20434084E+02 -0.47765998E+01 0.21080725E+03 -0.47563521E+01 -0.14613155E+01 -0.80268543E+01 -0.79094179E+01 -0.91377311E+03 0.14291169E+03 0.34541762E+02 -0.80743576E+01 0.35634858E+03 -0.57720843E+02 -0.80401375E+01 -0.24702077E+01 -0.29230218E-02 -0.30505978E-04 -0.24803450E+00 -0.33242419E-04 0.57550887E+03 0.14829856E-02 -0.30883055E-02 -0.32230953E-04 -0.10092726E+01 -0.33068305E-04 -0.95556070E-03 -0.99726638E-05 -0.47456943E+01 0.28689754E+02 -0.47765998E+01 -0.49409341E+03 -0.10951398E+03 0.20528275E+02 -0.47759952E+01 0.13562274E+03 -0.47524962E+01 -0.14651993E+01 -0.80221160E+01 0.48497120E+02 -0.78556109E+01 -0.80743576E+01 -0.83521480E+03 0.13022704E+03 0.34700975E+02 -0.80733421E+01 0.22925650E+03 -0.37135191E+02 -0.80336129E+01 -0.24767708E+01 -0.28749653E-02 -0.30004439E-04 -0.41241729E+00 -0.32230953E-04 0.57519069E+03 0.14795120E-02 -0.30069859E-02 -0.31382266E-04 -0.49911312E+00 -0.32047129E-04 -0.80139423E-02 -0.99070950E-05 -0.47465937E+01 0.42569293E+02 -0.47759952E+01 -0.46234161E+03 -0.10949542E+03 0.20527064E+02 -0.47748703E+01 0.89964943E+02 -0.47494534E+01 -0.14678694E+01 -0.80236419E+01 0.71959131E+02 -0.11656244E+02 -0.80733421E+01 -0.78154226E+03 0.12158133E+03 0.34698943E+02 -0.80714349E+01 0.15207674E+03 -0.24634033E+02 -0.80284759E+01 -0.24812864E+01 -0.28220775E-02 -0.29452477E-04 -0.43290524E+00 -0.31382266E-04 0.57503149E+03 0.14758353E-02 -0.28957310E-02 -0.30221159E-04 -0.28886261E+00 -0.31218023E-04 -0.30579909E-01 -0.96501086E-05 -0.47465231E+01 0.35396470E+02 -0.47748703E+01 -0.43450468E+03 -0.10948827E+03 0.20429436E+02 -0.46769808E+01 0.69290058E+02 -0.47506181E+01 -0.14681648E+01 -0.80235181E+01 0.59834150E+02 -0.96923637E+01 -0.80714349E+01 -0.73448618E+03 0.11397923E+03 0.34533900E+02 -0.79059682E+01 0.11712783E+03 -0.18973202E+02 -0.80304389E+01 -0.24817839E+01 -0.26281004E-02 -0.27428044E-04 -0.32038204E+00 -0.30221159E-04 0.55186282E+03 0.13874395E-02 -0.19750234E+00 -0.29774965E-04 -0.39997528E-01 -0.98819052E-05 -0.45102819E+01 0.21665194E+02 -0.46769808E+01 -0.39709700E+03 -0.96452757E+02 0.15336972E+02 0.58806825E+02 -0.46086963E+01 -0.15292250E+01 -0.76241805E+01 0.36622843E+02 -0.59324904E+01 -0.79059682E+01 -0.67125278E+03 0.11856897E+03 0.25925617E+02 0.99407057E+02 -0.16102830E+02 -0.77905402E+01 -0.25850020E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.48867607E-02 -0.17490047E-04 0.31031167E+03 0.79300686E-03 -0.15765390E+00 -0.17263735E-04 -0.91135186E-02 -0.15422818E-04 -0.57152102E-01 -0.17161875E-04 -0.27507270E+01 -0.19981890E+03 -0.59147403E+02 0.10598055E+02 0.13552430E+02 -0.27154363E+01 0.81967632E+01 -0.24259626E+01 -0.26992882E+01 -0.46498258E+01 -0.33777366E+03 0.51959485E+02 0.17914941E+02 0.22909013E+02 -0.37110429E+01 -0.45901706E+01 0.13855800E+02 -0.22445083E+01 -0.41008446E+01 -0.45628743E+01 -0.18517045E-02 -0.19325226E-04 -0.16541766E-02 -0.17263735E-04 0.34496899E+03 0.89592176E-03 -0.33972665E+00 -0.19714003E-04 -0.44239529E-01 -0.17560687E-04 -0.49122130E-01 -0.15748757E-04 -0.30780453E+01 -0.27154363E+01 -0.24255089E+03 -0.65723061E+02 0.13987573E+02 0.29580329E+02 -0.30438226E+01 0.15120848E+02 -0.27114628E+01 -0.24314260E+01 -0.52031278E+01 -0.45901706E+01 -0.41000802E+03 0.63344299E+02 0.23644591E+02 0.50002588E+02 -0.80998458E+01 -0.51452776E+01 0.25560282E+02 -0.41404725E+01 -0.45834567E+01 -0.41100826E+01 -0.21035206E-02 -0.21953293E-04 -0.18889563E-02 -0.19714003E-04 0.39125737E+03 0.10133153E-02 -0.65888912E+00 -0.22988498E-04 -0.10794534E+00 -0.20394295E-04 -0.26226452E-01 -0.14424569E-04 -0.34153510E+01 -0.30438226E+01 -0.30226887E+03 -0.74494601E+02 0.15085272E+02 0.52248365E+02 -0.34270315E+01 0.25803312E+02 -0.30405040E+01 -0.21501943E+01 -0.57733048E+01 -0.51452776E+01 -0.51095495E+03 0.79264038E+02 0.25500128E+02 0.88320577E+02 -0.14306604E+02 -0.57930501E+01 0.43617890E+02 -0.70654417E+01 -0.51396644E+01 -0.36346854E+01 -0.24455422E-02 -0.25522785E-04 -0.22027119E-02 -0.22988498E-04 0.43748058E+03 0.11357538E-02 -0.83735753E+00 -0.27548317E-04 -0.25091805E+00 -0.24896148E-04 -0.12839192E-02 -0.13399561E-04 -0.38389315E+01 -0.34270315E+01 -0.38540336E+03 -0.83267654E+02 0.16619424E+02 0.84500754E+02 -0.38958941E+01 0.50320737E+02 -0.35209698E+01 -0.19272400E+01 -0.64893297E+01 -0.57930501E+01 -0.65148583E+03 0.10158914E+03 0.28093470E+02 0.14284007E+03 -0.23137098E+02 -0.65856193E+01 0.85062173E+02 -0.13778289E+02 -0.59518472E+01 -0.32578065E+01 -0.28912371E-02 -0.30174259E-04 -0.26396247E-02 -0.27548317E-04 0.50753119E+03 0.13171729E-02 -0.12129343E+01 -0.33917203E-04 -0.10637215E+01 -0.30689517E-04 -0.11608889E-02 -0.12115562E-04 -0.43673821E+01 -0.38958941E+01 -0.52536138E+03 -0.96452559E+02 0.18456140E+02 0.10669878E+03 -0.44722193E+01 0.12856937E+03 -0.40471967E+01 -0.16625969E+01 -0.73826173E+01 -0.65856193E+01 -0.88807032E+03 0.13918923E+03 0.31198243E+02 0.18036351E+03 -0.29213649E+02 -0.75598347E+01 0.21733352E+03 -0.35201717E+02 -0.68413770E+01 -0.28104518E+01 -0.32354013E-02 -0.33766112E-04 -0.32498785E-02 -0.33917203E-04 0.57849567E+03 0.14973431E-02 -0.34951579E-02 -0.36477050E-04 -0.43747313E+01 -0.38023947E-04 -0.10601736E-02 -0.11064451E-04 -0.47563521E+01 -0.44722193E+01 -0.79450407E+03 -0.10963647E+03 0.20151920E+02 -0.47785850E+01 0.46489940E+03 -0.46673536E+01 -0.14650651E+01 -0.80401375E+01 -0.75598347E+01 -0.13430296E+04 0.21215420E+03 0.34064795E+02 -0.80777140E+01 0.78586592E+03 -0.12728026E+03 -0.78896943E+01 -0.24765460E+01 -0.31685388E-02 -0.33068305E-04 -0.11079898E+01 -0.36477050E-04 0.57644819E+03 0.14950011E-02 -0.32937125E-02 -0.34374674E-04 -0.11830743E+01 -0.36365310E-04 -0.10245894E-02 -0.10693079E-04 -0.47524962E+01 0.10412546E+03 -0.47785850E+01 -0.57975761E+03 -0.10960089E+03 0.20548189E+02 -0.47776800E+01 0.14597505E+03 -0.47645572E+01 -0.14625411E+01 -0.80336129E+01 0.17601354E+03 -0.28508945E+02 -0.80777140E+01 -0.98002155E+03 0.15345788E+03 0.34734637E+02 -0.80761900E+01 0.24675605E+03 -0.39967119E+02 -0.80540009E+01 -0.24722779E+01 -0.30706918E-02 -0.32047129E-04 -0.92503375E+00 -0.34374674E-04 0.57558862E+03 0.14879754E-02 -0.31647136E-02 -0.33028383E-04 -0.47106134E+00 -0.34274280E-04 -0.98565306E-03 -0.10286721E-04 -0.47494534E+01 0.88420532E+02 -0.47776800E+01 -0.49169918E+03 -0.10956911E+03 0.20541572E+02 -0.47763472E+01 0.73575168E+02 -0.47640016E+01 -0.14617749E+01 -0.80284759E+01 0.14946606E+03 -0.24210075E+02 -0.80761900E+01 -0.83116828E+03 0.12943272E+03 0.34723467E+02 -0.80739316E+01 0.12437146E+03 -0.20145325E+02 -0.80530681E+01 -0.24709843E+01 -0.29912485E-02 -0.31218023E-04 -0.64445134E+00 -0.33028383E-04 0.57516975E+03 0.14832013E-02 -0.30629382E-02 -0.31966208E-04 -0.30291400E+00 -0.32962271E-04 -0.14067534E-01 -0.10104963E-04 -0.47506181E+01 0.56210454E+02 -0.47763472E+01 -0.44068899E+03 -0.10955398E+03 0.20495125E+02 -0.47275361E+01 0.54752635E+02 -0.47671558E+01 -0.14611605E+01 -0.80304389E+01 0.95018084E+02 -0.15391186E+02 -0.80739316E+01 -0.74494017E+03 0.11550708E+03 0.34644941E+02 -0.79914270E+01 0.92553790E+02 -0.14992013E+02 -0.80583944E+01 -0.24699439E+01 -0.28529776E-02 -0.29774965E-04 -0.40867176E+00 -0.31966208E-04 0.56332193E+03 0.14207330E-02 -0.15716562E+00 -0.31899025E-04 -0.31166100E-01 -0.10076485E-04 -0.46086963E+01 0.30525309E+02 -0.47275361E+01 -0.39126151E+03 -0.10736000E+03 0.15556430E+02 0.37600113E+02 -0.47180090E+01 -0.14901284E+01 -0.77905402E+01 0.51599982E+02 -0.83583710E+01 -0.79914270E+01 -0.66138846E+03 0.10208534E+03 0.26296589E+02 0.63559232E+02 -0.10295578E+02 -0.79753225E+01 -0.25189130E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.22978609E+03 0.58613218E-03 -0.35185103E-01 -0.13283667E-04 -0.11599025E-02 -0.12105267E-04 -0.62688382E-01 -0.23213044E-04 -0.13774419E+03 -0.43816660E+02 0.76424481E+01 0.58459524E+01 -0.20845371E+01 -0.19104687E+01 -0.36425216E+01 -0.23284278E+03 0.35667017E+02 0.12918794E+02 0.98819980E+01 -0.16007868E+01 -0.35237015E+01 -0.32294562E+01 -0.61573185E+01 -0.14777835E-02 -0.15422818E-04 -0.12728144E-02 -0.13283667E-04 0.27585334E+03 0.72235850E-03 -0.17145267E+00 -0.15635827E-04 -0.12860444E-02 -0.13421741E-04 -0.58961975E-01 -0.19556480E-04 -0.24259626E+01 -0.20845371E+01 -0.17607907E+03 -0.52585057E+02 0.12065069E+02 0.17455773E+02 -0.24283018E+01 0.35253523E+00 -0.20833663E+01 -0.30369940E+01 -0.41008446E+01 -0.35237015E+01 -0.29764387E+03 0.45741228E+02 0.20394783E+02 0.29507220E+02 -0.47798516E+01 -0.41047987E+01 0.59592515E+00 -0.96533443E-01 -0.35217201E+01 -0.51337324E+01 -0.16826299E-02 -0.17560687E-04 -0.14981936E-02 -0.15635827E-04 0.31047109E+03 0.81079021E-03 -0.35516694E+00 -0.17948696E-04 -0.15437154E-02 -0.16110912E-04 -0.48563239E-01 -0.17854924E-04 -0.27114628E+01 -0.24283018E+01 -0.21574654E+03 -0.59166043E+02 0.12989807E+02 0.34295519E+02 -0.27159780E+01 0.34077931E+01 -0.24258745E+01 -0.27015410E+01 -0.45834567E+01 -0.41047987E+01 -0.36469795E+03 0.56273456E+02 0.21957967E+02 0.57973145E+02 -0.93908619E+01 -0.45910892E+01 0.57605335E+01 -0.93312816E+00 -0.41006982E+01 -0.45666848E+01 -0.19541406E-02 -0.20394295E-04 -0.17198082E-02 -0.17948696E-04 0.34523209E+03 0.90225060E-03 -0.71300240E+00 -0.21604671E-04 -0.18373648E-02 -0.19175571E-04 -0.14615176E-01 -0.16793702E-04 -0.30405040E+01 -0.27159780E+01 -0.26674948E+03 -0.65753455E+02 0.14087562E+02 0.65837486E+02 -0.31277751E+01 0.31057057E+01 -0.27649448E+01 -0.24309664E+01 -0.51396644E+01 -0.45910892E+01 -0.45091303E+03 0.69892338E+02 0.23813602E+02 0.11129162E+03 -0.18027209E+02 -0.52871876E+01 0.52498816E+01 -0.85038494E+00 -0.46738596E+01 -0.41093030E+01 -0.23854991E-02 -0.24896148E-04 -0.20701163E-02 -0.21604671E-04 0.41487000E+03 0.10797161E-02 -0.14893747E+01 -0.27142091E-04 -0.22757736E-02 -0.23751003E-04 -0.14057315E-02 -0.14670850E-04 -0.35209698E+01 -0.31277751E+01 -0.38085355E+03 -0.78927659E+02 0.15582531E+02 0.14352064E+03 -0.36647369E+01 -0.32334390E+01 -0.20267265E+01 -0.59518472E+01 -0.52871876E+01 -0.64379484E+03 0.10044229E+03 0.26340706E+02 0.24260728E+03 -0.39295989E+02 -0.61948711E+01 -0.54658053E+01 -0.34259784E+01 -0.29406082E-02 -0.30689517E-04 -0.26007009E-02 -0.27142091E-04 0.47473149E+03 0.12383838E-02 -0.39991868E+01 -0.35238816E-04 -0.28115951E-02 -0.29343079E-04 -0.13243924E-02 -0.13821958E-04 -0.40471967E+01 -0.36647369E+01 -0.65802809E+03 -0.89945654E+02 0.17444635E+02 0.38781468E+03 -0.42295457E+01 -0.37128363E+01 -0.17801773E+01 -0.68413770E+01 -0.61948711E+01 -0.11123300E+04 0.17564428E+03 0.29488395E+02 0.65556152E+03 -0.10617404E+03 -0.71496192E+01 -0.62761737E+01 -0.30092095E+01 -0.36433786E-02 -0.38023947E-04 -0.33765129E-02 -0.35238816E-04 0.56907973E+03 0.15789273E-02 -0.37515504E-02 -0.39152878E-04 -0.36096880E-02 -0.37672337E-04 -0.12329110E-02 -0.12867217E-04 -0.46673536E+01 -0.42295457E+01 -0.21044274E+04 -0.10545640E+03 0.31506343E+02 -0.46844756E+01 -0.44348850E+01 -0.15208751E+01 -0.78896943E+01 -0.71496192E+01 -0.35573237E+04 0.57035342E+03 0.53258311E+02 -0.79186335E+01 -0.74967294E+01 -0.25708872E+01 -0.34844513E-02 -0.36365310E-04 -0.43132374E+01 -0.39152878E-04 0.57838196E+03 0.15051761E-02 -0.34620455E-02 -0.36131473E-04 -0.36521160E-02 -0.38115135E-04 -0.10845381E-02 -0.11318731E-04 -0.47645572E+01 0.42514024E+03 -0.46844756E+01 -0.75467552E+03 -0.10968478E+03 0.20472160E+02 -0.47794951E+01 -0.47715009E+01 -0.14597647E+01 -0.80540009E+01 0.71865668E+03 -0.11639256E+03 -0.79186335E+01 -0.12757028E+04 0.20112619E+03 0.34606123E+02 -0.80792585E+01 -0.80657406E+01 -0.24675848E+01 -0.32840929E-02 -0.34274280E-04 -0.16392645E+01 -0.36131473E-04 0.57577660E+03 0.14956980E-02 -0.32907314E-02 -0.34343562E-04 -0.34728984E-02 -0.36244739E-04 -0.10266717E-02 -0.10714810E-04 -0.47640016E+01 0.16106208E+03 -0.47794951E+01 -0.49827023E+03 -0.10962325E+03 0.20564645E+02 -0.47780980E+01 0.75819676E+01 -0.47703929E+01 -0.14603184E+01 -0.80530681E+01 0.27225934E+03 -0.44098175E+02 -0.80792585E+01 -0.84227598E+03 0.13109326E+03 0.34762469E+02 -0.80768906E+01 0.12816558E+02 -0.20759135E+01 -0.80638721E+01 -0.24685221E+01 -0.31583789E-02 -0.32962271E-04 -0.81337681E+00 -0.34343562E-04 0.57519600E+03 0.14890724E-02 -0.31813009E-02 -0.33201496E-04 -0.22166944E+00 -0.34294215E-04 -0.99022856E-03 -0.10334473E-04 -0.47671558E+01 0.75140097E+02 -0.47780980E+01 -0.44468461E+03 -0.10959875E+03 0.20565455E+02 -0.47774699E+01 0.39882149E+02 -0.47713253E+01 -0.14590786E+01 -0.80583944E+01 0.12701672E+03 -0.20573825E+02 -0.80768906E+01 -0.75169429E+03 0.11648750E+03 0.34763825E+02 -0.80758350E+01 0.67416734E+02 -0.10919981E+02 -0.80654413E+01 -0.24664250E+01 -0.30565007E-02 -0.31899025E-04 -0.55733083E+00 -0.33201496E-04 0.57475318E+03 0.14191498E-02 -0.25510073E-01 -0.10149217E-04 -0.47180090E+01 0.47641436E+02 -0.47774699E+01 -0.37732136E+03 -0.10958694E+03 0.10968069E+02 -0.14602675E+01 -0.79753225E+01 0.80533082E+02 -0.13044827E+02 -0.80758350E+01 -0.63782403E+03 0.98074874E+02 0.18540423E+02 -0.24684361E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.67886457E-01 -0.12105267E-04 0.22985844E+03 0.59672425E-03 -0.41488017E-01 -0.12103840E-04 -0.11404836E-02 -0.11902603E-04 -0.63308042E-01 -0.23087268E-04 0.28870110E+01 -0.19104687E+01 -0.14334945E+03 -0.43819004E+02 0.93800710E+01 0.85673652E+01 -0.19103693E+01 -0.19106725E+01 -0.36436389E+01 0.48802034E+01 -0.79054791E+00 -0.32294562E+01 -0.24231791E+03 0.37196344E+02 0.15856072E+02 0.14482274E+02 -0.23459947E+01 -0.32292883E+01 -0.32298007E+01 -0.61592072E+01 -0.63956856E-01 -0.13421741E-04 -0.11597657E-02 -0.12103840E-04 0.22995780E+03 0.61212934E-03 -0.15422862E+00 -0.13429905E-04 -0.11663975E-02 -0.12173052E-04 -0.60973523E-01 -0.23473926E-04 -0.20833663E+01 -0.19103693E+01 -0.14944624E+03 -0.43826616E+02 0.11637723E+02 0.17561895E+02 -0.20848288E+01 -0.19104756E+01 -0.36437574E+01 -0.35217201E+01 -0.32292883E+01 -0.25262376E+03 0.38846729E+02 0.19672395E+02 0.29686608E+02 -0.48089082E+01 -0.35241921E+01 -0.32294658E+01 -0.61594038E+01 -0.66318298E-01 -0.16110912E-04 -0.12868267E-02 -0.13429905E-04 0.27605201E+03 0.72487228E-03 -0.32951707E+00 -0.16403515E-04 -0.13144753E-02 -0.13718459E-04 -0.52938282E-01 -0.20166959E-04 -0.24258745E+01 -0.20848288E+01 -0.18874184E+03 -0.52601941E+02 0.12107669E+02 0.30495022E+02 -0.24701913E+01 -0.20841773E+01 -0.30366821E+01 -0.41006982E+01 -0.35241921E+01 -0.31904920E+03 0.49165927E+02 0.20466800E+02 0.51548785E+02 -0.83501761E+01 -0.41756113E+01 -0.35230932E+01 -0.51332074E+01 -0.68362792E-01 -0.19175571E-04 -0.15717520E-02 -0.16403515E-04 0.32214757E+03 0.84329072E-03 -0.52465201E+00 -0.19795671E-04 -0.16557416E-02 -0.17280069E-04 -0.29494763E-01 -0.18063337E-04 -0.27649448E+01 -0.24701913E+01 -0.23400402E+03 -0.61379794E+02 0.13221950E+02 0.49398648E+02 -0.28547062E+01 -0.25206038E+01 -0.26045985E+01 -0.46738596E+01 -0.41756113E+01 -0.39556015E+03 0.61111547E+02 0.22350372E+02 0.83503422E+02 -0.13525992E+02 -0.48255923E+01 -0.42608252E+01 -0.44028107E+01 -0.22283947E+00 -0.23751003E-04 -0.18967816E-02 -0.19795671E-04 0.36847470E+03 0.96544672E-03 -0.81318431E+00 -0.24093738E-04 -0.20286485E-02 -0.21171893E-04 -0.15824708E-02 -0.16515382E-04 0.84749399E+01 -0.32334390E+01 -0.28547062E+01 -0.29669662E+03 -0.70166544E+02 0.14612125E+02 0.77270965E+02 -0.32805685E+01 -0.29554628E+01 -0.22800486E+01 0.14326038E+02 -0.23204550E+01 -0.54658053E+01 -0.48255923E+01 -0.50153595E+03 0.77805696E+02 0.24700333E+02 0.13061884E+03 -0.21156940E+02 -0.55454729E+01 -0.49959143E+01 -0.38541941E+01 -0.84451639E+00 -0.29343079E-04 -0.23086138E-02 -0.24093738E-04 0.42671000E+03 0.11198369E-02 -0.10475849E+01 -0.30681625E-04 -0.25012740E-02 -0.26104427E-04 -0.14416386E-02 -0.15045593E-04 0.67680332E+02 -0.37128363E+01 -0.32805685E+01 -0.40881465E+03 -0.81159344E+02 0.16340623E+02 0.97265790E+02 -0.38824558E+01 -0.34832142E+01 -0.19724001E+01 0.11440675E+03 -0.18529986E+02 -0.62761737E+01 -0.55454729E+01 -0.69105976E+03 0.10788868E+03 0.27622172E+02 0.16441797E+03 -0.26630093E+02 -0.65628982E+01 -0.58880212E+01 -0.33341428E+01 -0.40053101E+01 -0.37672337E-04 -0.29398520E-02 -0.30681625E-04 0.52063920E+03 0.13599029E-02 -0.34660619E-02 -0.36173390E-04 -0.31482507E-02 -0.32856569E-04 -0.12296929E-02 -0.12833632E-04 0.37637479E+03 -0.44348850E+01 -0.38824558E+01 -0.67291882E+03 -0.98742650E+02 0.18725128E+02 -0.45287714E+01 -0.42455944E+01 -0.16222799E+01 0.63622393E+03 -0.10304043E+03 -0.74967294E+01 -0.65628982E+01 -0.11375019E+04 0.17922403E+03 0.31652947E+02 -0.76554309E+01 -0.71767526E+01 -0.27423019E+01 -0.97162808E+00 -0.38115135E-04 -0.10016969E+01 -0.36173390E-04 0.57604994E+03 0.15023318E-02 -0.34792827E-02 -0.36311369E-04 -0.34989709E-02 -0.36516844E-04 -0.10719859E-02 -0.11187730E-04 0.74628540E+02 -0.47715009E+01 0.97489376E+02 -0.45287714E+01 -0.50166834E+03 -0.10967559E+03 0.20323078E+02 -0.47798171E+01 -0.47714255E+01 -0.14592005E+01 0.12615201E+03 -0.20432140E+02 -0.80657406E+01 0.16479595E+03 -0.26691085E+02 -0.76554309E+01 -0.84801969E+03 0.13188810E+03 0.34354116E+02 -0.80798027E+01 -0.80656140E+01 -0.24666309E+01 -0.15987333E+00 -0.36244739E-04 -0.82628466E+00 -0.36311369E-04 0.57509413E+03 0.14986357E-02 -0.33828411E-02 -0.35304860E-04 -0.34459143E-02 -0.35963121E-04 -0.10383418E-02 -0.10836605E-04 -0.47703929E+01 0.78714003E+02 -0.47798171E+01 -0.40830577E+03 -0.10964765E+03 0.20571294E+02 -0.47794430E+01 -0.47708020E+01 -0.14584898E+01 -0.80638721E+01 0.13305815E+03 -0.21551510E+02 -0.80798027E+01 -0.69020007E+03 0.10640089E+03 0.34773710E+02 -0.80791644E+01 -0.80645636E+01 -0.24654311E+01 -0.32860031E-02 -0.34294215E-04 -0.43816125E+00 -0.35304860E-04 0.57456493E+03 0.14597886E-02 -0.33981475E-02 -0.35464605E-04 -0.21262248E-02 -0.10778205E-04 -0.47713253E+01 0.42804789E+02 -0.47794430E+01 -0.38206304E+03 -0.10963121E+03 0.15793919E+02 0.96425004E+01 -0.47718529E+01 -0.14589556E+01 -0.80654413E+01 0.72357161E+02 -0.11719986E+02 -0.80791644E+01 -0.64583890E+03 0.99258914E+02 0.26698019E+02 0.16299671E+02 -0.26401245E+01 -0.80663336E+01 -0.24662167E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.24128114E+03 0.61053060E-03 -0.36745224E-01 -0.11963890E-04 -0.12401056E-02 -0.12942303E-04 -0.63456979E-01 -0.21232487E-04 -0.14777267E+03 -0.46000009E+02 0.75709913E+01 0.92686398E+01 -0.19555350E+01 -0.21400582E+01 -0.34702348E+01 -0.24979476E+03 0.38330186E+02 0.12797995E+02 0.15667699E+02 -0.25380787E+01 -0.33056342E+01 -0.36175519E+01 -0.58660810E+01 -0.11595734E+00 -0.11902603E-04 -0.11463560E-02 -0.11963890E-04 0.22992078E+03 0.60799291E-03 -0.53412268E-01 -0.11896592E-04 -0.11498448E-02 -0.12000301E-04 -0.63594462E-01 -0.22712078E-04 0.85387112E+01 -0.19106725E+01 -0.19555350E+01 -0.15201540E+03 -0.43818310E+02 0.11383840E+02 0.11580450E+02 -0.19098309E+01 -0.19571084E+01 -0.36457717E+01 0.14433837E+02 -0.23381730E+01 -0.32298007E+01 -0.33056342E+01 -0.25696684E+03 0.39571585E+02 0.19243241E+02 0.19575592E+02 -0.31710985E+01 -0.32283782E+01 -0.33082960E+01 -0.61628125E+01 -0.10399828E+00 -0.12173052E-04 -0.11399077E-02 -0.11896592E-04 0.22998800E+03 0.60896425E-03 -0.14493342E+00 -0.12176631E-04 -0.11487335E-02 -0.11988703E-04 -0.62686689E-01 -0.23209883E-04 0.55208100E+01 -0.19104756E+01 -0.19098309E+01 -0.15431280E+03 -0.43828808E+02 0.11289908E+02 0.16910541E+02 -0.19111809E+01 -0.19108935E+01 -0.36426013E+01 0.93323711E+01 -0.15117534E+01 -0.32294658E+01 -0.32283782E+01 -0.26085019E+03 0.40174310E+02 0.19084451E+02 0.28585561E+02 -0.46305832E+01 -0.32306580E+01 -0.32301723E+01 -0.61574493E+01 -0.10959146E+00 -0.13718459E-04 -0.11667404E-02 -0.12176631E-04 0.23007758E+03 0.61374558E-03 -0.24328091E+00 -0.13979237E-04 -0.11848147E-02 -0.12365262E-04 -0.58185297E-01 -0.23977760E-04 0.51372413E+01 -0.20841773E+01 -0.19111809E+01 -0.16120435E+03 -0.43837882E+02 0.11678161E+02 0.24198730E+02 -0.21239615E+01 -0.19111011E+01 -0.36428105E+01 0.86839927E+01 -0.14066924E+01 -0.35230932E+01 -0.32306580E+01 -0.27249984E+03 0.42037981E+02 0.19740762E+02 0.40905532E+02 -0.66261574E+01 -0.35903445E+01 -0.32305253E+01 -0.61578069E+01 -0.18009043E+00 -0.17280069E-04 -0.13394625E-02 -0.13979237E-04 0.28765248E+03 0.75606631E-03 -0.35662905E+00 -0.17870173E-04 -0.14366905E-02 -0.14993952E-04 -0.45081617E-01 -0.20015607E-04 0.86115155E+01 -0.25206038E+01 -0.21239615E+01 -0.20758615E+03 -0.54808161E+02 0.12411776E+02 0.34155028E+02 -0.26069066E+01 -0.22345164E+01 -0.29196208E+01 0.14556894E+02 -0.23579633E+01 -0.42608252E+01 -0.35903445E+01 -0.35090337E+03 0.54184103E+02 0.20980854E+02 0.57735619E+02 -0.93521645E+01 -0.44067113E+01 -0.37772243E+01 -0.49353235E+01 -0.35002965E+00 -0.21171893E-04 -0.17122843E-02 -0.17870173E-04 0.34530721E+03 0.90444207E-03 -0.47150985E+00 -0.22409953E-04 -0.18424100E-02 -0.19228224E-04 -0.15534761E-01 -0.17423765E-04 0.22515897E+02 -0.29554628E+01 -0.26069066E+01 -0.26385430E+03 -0.65783412E+02 0.13891176E+02 0.43574756E+02 -0.31285009E+01 -0.27607207E+01 -0.24321780E+01 0.38060872E+02 -0.61650064E+01 -0.49959143E+01 -0.44067113E+01 -0.44601930E+03 0.69023803E+02 0.23481640E+02 0.73658766E+02 -0.11931066E+02 -0.52884179E+01 -0.46667223E+01 -0.41113536E+01 -0.75095722E+00 -0.26104427E-04 -0.21472769E-02 -0.22409953E-04 0.41453605E+03 0.10835157E-02 -0.43707748E+00 -0.28371765E-04 -0.23028751E-02 -0.24033846E-04 -0.14331548E-02 -0.14957052E-04 0.60063016E+02 -0.34832142E+01 -0.31285009E+01 -0.33647841E+03 -0.78955712E+02 0.15770532E+02 0.39122168E+02 -0.37857528E+01 -0.33371646E+01 -0.20270036E+01 0.10153045E+03 -0.16445125E+02 -0.58880212E+01 -0.52884179E+01 -0.56878271E+03 0.88222558E+02 0.26658491E+02 0.66132068E+02 -0.10711566E+02 -0.63994322E+01 -0.56411381E+01 -0.34264445E+01 -0.15705797E+01 -0.32856569E-04 -0.27185258E-02 -0.28371765E-04 0.50676230E+03 0.13209824E-02 -0.32815703E-02 -0.34247952E-04 -0.29025049E-02 -0.30291855E-04 -0.11989549E-02 -0.12512836E-04 0.13569495E+03 -0.42455944E+01 -0.37857528E+01 -0.42570079E+03 -0.96514271E+02 0.18276708E+02 -0.44749500E+01 -0.41004355E+01 -0.16590973E+01 0.22937874E+03 -0.37152092E+02 -0.71767526E+01 -0.63994322E+01 -0.71960461E+03 0.11174866E+03 0.30894940E+02 -0.75644520E+01 -0.69313760E+01 -0.28045381E+01 -0.87393253E+00 -0.36516844E-04 -0.15378390E+00 -0.34247952E-04 0.57511438E+03 0.14971549E-02 -0.34522739E-02 -0.36029493E-04 -0.33966575E-02 -0.35449055E-04 -0.10485927E-02 -0.10943588E-04 0.67319482E+02 -0.47714255E+01 0.16436817E+02 -0.44749500E+01 -0.41332039E+03 -0.10966693E+03 0.20268791E+02 -0.47798503E+01 -0.47704216E+01 -0.14597855E+01 0.11379680E+03 -0.18431643E+02 -0.80656140E+01 0.27784783E+02 -0.45002953E+01 -0.75644520E+01 -0.69867647E+03 0.10772560E+03 0.34262351E+02 -0.80798587E+01 -0.80639167E+01 -0.24676190E+01 -0.28639730E+00 -0.35963121E-04 -0.23772233E+00 -0.36029493E-04 0.57461766E+03 0.14623046E-02 -0.34034794E-02 -0.35520251E-04 -0.10384528E-02 -0.10837763E-04 0.11770645E+02 -0.47708020E+01 0.23067276E+02 -0.47798503E+01 -0.36441519E+03 -0.10965817E+03 0.15803139E+02 -0.47796613E+01 -0.14604714E+01 0.19897097E+02 -0.32227639E+01 -0.80645636E+01 0.38992923E+02 -0.63157445E+01 -0.80798587E+01 -0.61600743E+03 0.94358729E+02 0.26713622E+02 -0.80795357E+01 -0.24687808E+01 -0.92241827E-01 -0.35464605E-04 -0.24367706E+00 -0.35520251E-04 0.57444270E+03 0.14257672E-02 -0.11013347E-01 -0.10844475E-04 -0.47718529E+01 0.21354776E+02 -0.47796613E+01 -0.35094102E+03 -0.10965215E+03 0.11023000E+02 -0.14591348E+01 -0.80663336E+01 0.36098097E+02 -0.58469286E+01 -0.80795357E+01 -0.59323041E+03 0.90685708E+02 0.18633268E+02 -0.24665199E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.50524872E-01 -0.12942303E-04 0.27575451E+03 0.70388324E-03 -0.12552775E-02 -0.13100644E-04 -0.13823857E-02 -0.14427202E-04 -0.63023480E-01 -0.18396914E-04 0.62654400E+01 -0.21400582E+01 -0.17223406E+03 -0.52567430E+02 0.97508953E+01 0.76726354E+01 -0.21364055E+01 -0.24266808E+01 -0.30418515E+01 0.10591093E+02 -0.17157092E+01 -0.36175519E+01 -0.29114430E+03 0.44733734E+02 0.16482902E+02 0.12969815E+02 -0.21010516E+01 -0.36113775E+01 -0.41020580E+01 -0.51419423E+01 -0.10974181E+00 -0.12000301E-04 -0.31715043E-01 -0.13100644E-04 0.24142916E+03 0.63568310E-03 -0.52575007E-01 -0.11994335E-04 -0.12365576E-02 -0.12905275E-04 -0.63367554E-01 -0.21296887E-04 0.79768355E+01 -0.19571084E+01 -0.21364055E+01 -0.15824006E+03 -0.46008688E+02 0.11667628E+02 0.11771221E+02 -0.19562652E+01 -0.21395018E+01 -0.34731796E+01 0.13484043E+02 -0.21843344E+01 -0.33082960E+01 -0.36113775E+01 -0.26748900E+03 0.41175183E+02 0.19722955E+02 0.19898073E+02 -0.32233689E+01 -0.33068706E+01 -0.36166139E+01 -0.58710629E+01 -0.10923002E+00 -0.11988703E-04 -0.11492732E-02 -0.11994335E-04 0.22997364E+03 0.60811355E-03 -0.12408179E+00 -0.11983552E-04 -0.11284540E-02 -0.11777057E-04 -0.63341723E-01 -0.22857855E-04 0.78766213E+01 -0.19108935E+01 -0.19562652E+01 -0.15553723E+03 -0.43828367E+02 0.11336191E+02 0.15778360E+02 -0.19101879E+01 -0.19106690E+01 -0.36432492E+01 0.13314632E+02 -0.21568618E+01 -0.32301723E+01 -0.33068706E+01 -0.26291996E+03 0.40511193E+02 0.19162684E+02 0.26671722E+02 -0.43206013E+01 -0.32289795E+01 -0.32297921E+01 -0.61585434E+01 -0.13003196E+00 -0.12365262E-04 -0.11482400E-02 -0.11983552E-04 0.23001051E+03 0.61051613E-03 -0.15214170E+00 -0.12950488E-04 -0.11609537E-02 -0.12116238E-04 -0.61680865E-01 -0.23581201E-04 0.90008987E+01 -0.19111011E+01 -0.19101879E+01 -0.16126652E+03 -0.43837874E+02 0.11383674E+02 0.20397004E+02 -0.20017149E+01 -0.19112524E+01 -0.36444874E+01 0.15215119E+02 -0.24646760E+01 -0.32305253E+01 -0.32289795E+01 -0.27260493E+03 0.42055632E+02 0.19242960E+02 0.34479096E+02 -0.55852208E+01 -0.33836988E+01 -0.32307810E+01 -0.61606414E+01 -0.23814062E+00 -0.14993952E-04 -0.12408899E-02 -0.12950488E-04 0.25318809E+03 0.67070663E-03 -0.27655441E+00 -0.15803473E-04 -0.12889535E-02 -0.13452102E-04 -0.55112544E-01 -0.22226569E-04 0.13212071E+02 -0.22345164E+01 -0.20017149E+01 -0.18333979E+03 -0.48235318E+02 0.11962878E+02 0.25091868E+02 -0.23553143E+01 -0.20535280E+01 -0.33123752E+01 0.22333672E+02 -0.36177164E+01 -0.37772243E+01 -0.33836988E+01 -0.30991742E+03 0.47854592E+02 0.20222038E+02 0.42415271E+02 -0.68706306E+01 -0.39814210E+01 -0.34712812E+01 -0.55992353E+01 -0.34772057E+00 -0.19228224E-04 -0.15142572E-02 -0.15803473E-04 0.32221786E+03 0.84364185E-03 -0.32405406E+00 -0.20445989E-04 -0.16677751E-02 -0.17405656E-04 -0.41786403E-01 -0.18199507E-04 0.23081303E+02 -0.27607207E+01 -0.23553143E+01 -0.23689682E+03 -0.61399215E+02 0.13243956E+02 0.29237469E+02 -0.29356936E+01 -0.25723639E+01 -0.26129498E+01 0.39016635E+02 -0.63199419E+01 -0.46667223E+01 -0.39814210E+01 -0.40045039E+03 0.61855639E+02 0.22387581E+02 0.49423017E+02 -0.80055750E+01 -0.49624965E+01 -0.43483240E+01 -0.44169304E+01 -0.55488178E+00 -0.24033846E-04 -0.19590937E-02 -0.20445989E-04 0.39127008E+03 0.10222417E-02 -0.30670813E+00 -0.25872768E-04 -0.21638333E-02 -0.22582743E-04 -0.21586607E-01 -0.15462216E-04 0.41144406E+02 -0.33371646E+01 -0.29356936E+01 -0.29348485E+03 -0.74565981E+02 0.15258691E+02 0.28224648E+02 -0.35925698E+01 -0.32380134E+01 -0.21468502E+01 0.69550444E+02 -0.11265575E+02 -0.56411381E+01 -0.49624965E+01 -0.49610636E+03 0.76678890E+02 0.25793274E+02 0.47710903E+02 -0.77280713E+01 -0.60728747E+01 -0.54735325E+01 -0.36290334E+01 -0.80505229E+00 -0.30291855E-04 -0.24790769E-02 -0.25872768E-04 0.48314666E+03 0.12586842E-02 -0.10306687E+00 -0.32242448E-04 -0.27353350E-02 -0.28547194E-04 -0.69197351E-02 -0.12840853E-04 0.60712756E+02 -0.41004355E+01 -0.35925698E+01 -0.34528836E+03 -0.92121217E+02 0.17763898E+02 0.77418258E+01 -0.43643937E+01 -0.39580552E+01 -0.17380630E+01 0.10262884E+03 -0.16623199E+02 -0.69313760E+01 -0.60728747E+01 -0.58367545E+03 0.89969790E+02 0.30028088E+02 0.13086782E+02 -0.21197178E+01 -0.73775710E+01 -0.66906964E+01 -0.29380216E+01 -0.66691780E+00 -0.35449055E-04 -0.30894068E-02 -0.32242448E-04 0.57476523E+03 0.14569444E-02 -0.33038625E-02 -0.34480604E-04 -0.14370886E-01 -0.10849465E-04 0.44649890E+02 -0.47704216E+01 -0.43643937E+01 -0.37421213E+03 -0.10966919E+03 0.15329533E+02 -0.47224174E+01 -0.14599415E+01 0.75476138E+02 -0.12225121E+02 -0.80639167E+01 -0.73775710E+01 -0.63256788E+03 0.97015417E+02 0.25913031E+02 -0.79827685E+01 -0.24678833E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.34465067E+03 0.85349529E-03 -0.15446407E-02 -0.16120569E-04 -0.16955321E-01 -0.16827433E-04 -0.61746864E-01 -0.14279239E-04 -0.20606605E+03 -0.65688502E+02 0.80134569E+01 0.81670580E+01 -0.27112761E+01 -0.28642856E+01 -0.24305303E+01 -0.34833405E+03 0.53442501E+02 0.13545947E+02 0.13805595E+02 -0.22364809E+01 -0.45831412E+01 -0.48417883E+01 -0.41085685E+01 -0.80360452E-01 -0.14427202E-04 -0.16347658E-01 -0.16120569E-04 0.31027071E+03 0.80301749E-03 -0.14011493E-02 -0.14623028E-04 -0.94939016E-02 -0.16134123E-04 -0.62288830E-01 -0.16074153E-04 0.10544002E+02 -0.24266808E+01 -0.27112761E+01 -0.19758860E+03 -0.59131265E+02 0.12985718E+02 0.89515889E+01 -0.24240280E+01 -0.27135730E+01 -0.27035268E+01 0.17823566E+02 -0.28873665E+01 -0.41020580E+01 -0.45831412E+01 -0.33400353E+03 0.51391010E+02 0.21951045E+02 0.15131755E+02 -0.24513007E+01 -0.40975736E+01 -0.45870206E+01 -0.45700380E+01 -0.47710277E-01 -0.12905275E-04 -0.97353670E-02 -0.14623028E-04 0.27578622E+03 0.71734272E-03 -0.32091054E-01 -0.12554981E-04 -0.13328196E-02 -0.13909909E-04 -0.62920115E-01 -0.18339563E-04 0.90787260E+01 -0.21395018E+01 -0.24240280E+01 -0.17892355E+03 -0.52573077E+02 0.12029808E+02 0.11556585E+02 -0.20814907E+01 -0.23386791E+01 -0.30402072E+01 0.15346678E+02 -0.24860947E+01 -0.36166139E+01 -0.40975736E+01 -0.30245236E+03 0.46551825E+02 0.20335185E+02 0.19535251E+02 -0.31646251E+01 -0.35185518E+01 -0.39533031E+01 -0.51391662E+01 -0.64501178E-01 -0.11777057E-04 -0.12029931E-02 -0.12554981E-04 0.22988296E+03 0.60793532E-03 -0.71293148E-01 -0.11759384E-04 -0.11352142E-02 -0.11847609E-04 -0.63524363E-01 -0.22487696E-04 0.89962395E+01 -0.19106690E+01 -0.20814907E+01 -0.15514131E+03 -0.43822323E+02 0.11509553E+02 0.14254211E+02 -0.19078821E+01 -0.19564876E+01 -0.36481002E+01 0.15207231E+02 -0.24634745E+01 -0.32297921E+01 -0.35185518E+01 -0.26225068E+03 0.40418167E+02 0.19455737E+02 0.24095299E+02 -0.39032848E+01 -0.32250813E+01 -0.33072448E+01 -0.61667448E+01 -0.11725771E+00 -0.12116238E-04 -0.11267607E-02 -0.11759384E-04 0.22994354E+03 0.60877046E-03 -0.92996664E-01 -0.12390710E-04 -0.11361215E-02 -0.11857078E-04 -0.63099117E-01 -0.23135219E-04 0.10506499E+02 -0.19112524E+01 -0.19078821E+01 -0.15977102E+03 -0.43834704E+02 0.11338339E+02 0.17391223E+02 -0.19546905E+01 -0.19103239E+01 -0.36492619E+01 0.17760186E+02 -0.28769849E+01 -0.32307810E+01 -0.32250813E+01 -0.27007692E+03 0.41654598E+02 0.19166326E+02 0.29398124E+02 -0.47622225E+01 -0.33042088E+01 -0.32292116E+01 -0.61687123E+01 -0.18435981E+00 -0.13452102E-04 -0.11872531E-02 -0.12390710E-04 0.24151139E+03 0.64034340E-03 -0.12935698E+00 -0.14531498E-04 -0.12285658E-02 -0.12821869E-04 -0.60194981E-01 -0.22755466E-04 0.13942145E+02 -0.20535280E+01 -0.19546905E+01 -0.17286665E+03 -0.46041311E+02 0.11712269E+02 0.20478718E+02 -0.22184736E+01 -0.20067788E+01 -0.34736169E+01 0.23567784E+02 -0.38176844E+01 -0.34712812E+01 -0.33042088E+01 -0.29221357E+03 0.45098157E+02 0.19798408E+02 0.34617200E+02 -0.56075503E+01 -0.37501050E+01 -0.33922563E+01 -0.58717972E+01 -0.38295568E+00 -0.17405656E-04 -0.13923791E-02 -0.14531498E-04 0.29929629E+03 0.78507417E-03 -0.32737127E+00 -0.19053771E-04 -0.15647942E-02 -0.16330900E-04 -0.53320545E-01 -0.18974124E-04 0.21121733E+02 -0.25723639E+01 -0.22184736E+01 -0.21642027E+03 -0.57020556E+02 0.12900552E+02 0.23913941E+02 -0.28160557E+01 -0.24830562E+01 -0.28041797E+01 0.35704177E+02 -0.57835004E+01 -0.43483240E+01 -0.37501050E+01 -0.36583682E+03 0.56448122E+02 0.21807090E+02 0.40424126E+02 -0.65480560E+01 -0.47602606E+01 -0.41973582E+01 -0.47401854E+01 -0.46302039E+00 -0.22582743E-04 -0.18256942E-02 -0.19053771E-04 0.39127995E+03 0.10169382E-02 -0.38635653E+00 -0.24784809E-04 -0.20770616E-02 -0.21677154E-04 -0.44529385E-01 -0.15027311E-04 0.31337242E+02 -0.32380134E+01 -0.28160557E+01 -0.29176279E+03 -0.74567079E+02 0.15008424E+02 0.36310525E+02 -0.35539269E+01 -0.32374225E+01 -0.21546054E+01 0.52972422E+02 -0.85805093E+01 -0.54735325E+01 -0.47602606E+01 -0.49319535E+03 0.76206877E+02 0.25370222E+02 0.61379251E+02 -0.99422529E+01 -0.60075522E+01 -0.54725347E+01 -0.36421424E+01 -0.47355919E+00 -0.28547194E-04 -0.23748308E-02 -0.24784809E-04 0.47143383E+03 0.11989427E-02 -0.18473176E+00 -0.30784169E-04 -0.33230226E-01 -0.12848602E-04 0.28960471E+02 -0.39580552E+01 -0.35539269E+01 -0.31504032E+03 -0.89932956E+02 0.13571840E+02 0.15843805E+02 -0.42683282E+01 -0.17813940E+01 0.48954780E+02 -0.79295357E+01 -0.66906964E+01 -0.60075522E+01 -0.53254415E+03 0.81786007E+02 0.22941832E+02 0.26782368E+02 -0.43381207E+01 -0.72151819E+01 -0.30112683E+01 -0.47209570E+00 -0.34480604E-04 -0.29496775E-02 -0.30784169E-04 0.56309388E+03 0.13931534E-02 -0.32800322E-01 -0.10878457E-04 0.25400288E+02 -0.47224174E+01 -0.42683282E+01 -0.34835832E+03 -0.10748533E+03 0.10492712E+02 -0.14898504E+01 0.42936615E+02 -0.69546765E+01 -0.79827685E+01 -0.72151819E+01 -0.58886449E+03 0.90023638E+02 0.17736873E+02 -0.25184421E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.16123710E-02 -0.16827433E-04 0.34466858E+03 0.87085051E-03 -0.16123285E-02 -0.16826990E-04 -0.26112782E-01 -0.16734138E-04 -0.61603359E-01 -0.14191919E-04 0.40042888E+01 -0.28642856E+01 -0.20657734E+03 -0.60270803E+02 0.11026543E+02 0.46647492E+01 -0.28613005E+01 -0.28643717E+01 -0.24292229E+01 0.67688497E+01 -0.10965447E+01 -0.48417883E+01 -0.34919834E+03 0.62745862E+02 0.18639267E+02 0.78852921E+01 -0.12774069E+01 -0.48367423E+01 -0.48419339E+01 -0.41063585E+01 -0.15459394E-02 -0.16134123E-04 -0.24181174E-01 -0.16826990E-04 0.34465958E+03 0.88570179E-03 -0.14820698E-02 -0.15467551E-04 -0.15995969E-02 -0.16694117E-04 -0.62083342E-01 -0.14311777E-04 0.75436455E+01 -0.27135730E+01 -0.28613005E+01 -0.21303816E+03 -0.65690055E+02 0.13480709E+02 0.75976270E+01 -0.26002803E+01 -0.28645800E+01 -0.24336098E+01 0.12751770E+02 -0.20657632E+01 -0.45870206E+01 -0.48367423E+01 -0.36011950E+03 0.55347981E+02 0.22787778E+02 0.12843021E+02 -0.20805458E+01 -0.43955109E+01 -0.48422821E+01 -0.41137712E+01 -0.38541788E-01 -0.13909909E-04 -0.59415082E-01 -0.15467551E-04 0.28730014E+03 0.74559879E-03 -0.12714392E-01 -0.12947817E-04 -0.13440434E-02 -0.14027045E-04 -0.62647550E-01 -0.17362667E-04 0.83044124E+01 -0.23386791E+01 -0.26002803E+01 -0.18323488E+03 -0.54755899E+02 0.12428043E+02 0.10036045E+02 -0.21769877E+01 -0.23869578E+01 -0.29189937E+01 0.14037779E+02 -0.22740776E+01 -0.39533031E+01 -0.43955109E+01 -0.30974023E+03 0.47649979E+02 0.21008360E+02 0.16964930E+02 -0.27482673E+01 -0.36799801E+01 -0.40349134E+01 -0.49342670E+01 -0.50980577E-01 -0.11847609E-04 -0.12406339E-02 -0.12947817E-04 0.24133039E+03 0.63401457E-03 -0.40353251E-01 -0.11828373E-04 -0.11450563E-02 -0.11950326E-04 -0.63485672E-01 -0.21059135E-04 0.87901707E+01 -0.19564876E+01 -0.21769877E+01 -0.15972654E+03 -0.46006226E+02 0.11574441E+02 0.12440799E+02 -0.19533845E+01 -0.20049953E+01 -0.34774202E+01 0.14858896E+02 -0.24070718E+01 -0.33072448E+01 -0.36799801E+01 -0.27000159E+03 0.41588697E+02 0.19565427E+02 0.21029915E+02 -0.34067479E+01 -0.33019994E+01 -0.33892421E+01 -0.58782276E+01 -0.81700425E-01 -0.11857078E-04 -0.11333710E-02 -0.11828373E-04 0.22988232E+03 0.60759939E-03 -0.59511872E-01 -0.12122750E-04 -0.11122322E-02 -0.11607759E-04 -0.63616243E-01 -0.22676231E-04 0.10688462E+02 -0.19103239E+01 -0.19533845E+01 -0.15760196E+03 -0.43828011E+02 0.11384557E+02 0.15030646E+02 -0.19532233E+01 -0.19095173E+01 -0.36531824E+01 0.18067775E+02 -0.29268498E+01 -0.32292116E+01 -0.33019994E+01 -0.26641036E+03 0.41077746E+02 0.19244453E+02 0.25407804E+02 -0.41158816E+01 -0.33017287E+01 -0.32278480E+01 -0.61753395E+01 -0.12015405E+00 -0.12821869E-04 -0.11615777E-02 -0.12122750E-04 0.24140711E+03 0.63818803E-03 -0.79495381E-01 -0.14154005E-04 -0.11963318E-02 -0.12485460E-04 -0.62279773E-01 -0.22219399E-04 0.13639587E+02 -0.20067788E+01 -0.19532233E+01 -0.16979047E+03 -0.46034272E+02 0.11661624E+02 0.17694926E+02 -0.22153792E+01 -0.20036945E+01 -0.34773703E+01 0.23056342E+02 -0.37348969E+01 -0.33922563E+01 -0.33017287E+01 -0.28701362E+03 0.44274019E+02 0.19712798E+02 0.29911484E+02 -0.48453611E+01 -0.37448743E+01 -0.33870428E+01 -0.58781421E+01 -0.20433902E+00 -0.16330900E-04 -0.13562085E-02 -0.14154005E-04 0.29882746E+03 0.78228312E-03 -0.22783386E-01 -0.18495824E-04 -0.15362482E-02 -0.16032981E-04 -0.59223097E-01 -0.18503913E-04 0.19964062E+02 -0.24830562E+01 -0.22153792E+01 -0.20562103E+03 -0.57012907E+02 0.12812149E+02 0.14261129E+02 -0.28123255E+01 -0.24817049E+01 -0.28132636E+01 0.33747250E+02 -0.54666118E+01 -0.41973582E+01 -0.37448743E+01 -0.34758178E+03 0.53511216E+02 0.21657654E+02 0.24107012E+02 -0.39050196E+01 -0.47539550E+01 -0.41950740E+01 -0.47555408E+01 -0.61648801E+00 -0.21677154E-04 -0.17722328E-02 -0.18495824E-04 0.39105156E+03 0.98930809E-03 -0.20095705E-02 -0.20972787E-04 -0.56386148E-01 -0.14393578E-04 0.37103314E+02 -0.32374225E+01 -0.28123255E+01 -0.26120857E+03 -0.74574783E+02 0.11401721E+02 -0.31939497E+01 -0.21496197E+01 0.62719392E+02 -0.10159607E+02 -0.54725347E+01 -0.47539550E+01 -0.44154665E+03 0.67824365E+02 0.19273457E+02 -0.53990486E+01 -0.36337143E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.16034316E-02 -0.16734138E-04 0.34466303E+03 0.87042247E-03 -0.15980291E-02 -0.16677755E-04 -0.11800204E-01 -0.16632213E-04 -0.61592932E-01 -0.14105490E-04 0.44809201E+01 -0.28643717E+01 -0.20522846E+03 -0.60262267E+02 0.11027649E+02 0.28279019E+01 -0.28615690E+01 -0.28647960E+01 -0.24295537E+01 0.75745473E+01 -0.12270711E+01 -0.48419339E+01 -0.34691819E+03 0.62397303E+02 0.18641137E+02 0.47802854E+01 -0.77440273E+00 -0.48371963E+01 -0.48426511E+01 -0.41069176E+01 -0.23809981E-01 -0.16694117E-04 -0.70844374E-01 -0.16677755E-04 0.34475336E+03 0.88551476E-03 -0.14651131E-02 -0.15290583E-04 -0.19760735E-01 -0.16411306E-04 -0.61994042E-01 -0.14174587E-04 0.63203559E+01 -0.28645800E+01 -0.28615690E+01 -0.20969684E+03 -0.65683722E+02 0.13583208E+02 0.54707735E+01 -0.26017154E+01 -0.28158806E+01 -0.24321006E+01 0.10683921E+02 -0.17307849E+01 -0.48422821E+01 -0.48371963E+01 -0.35447129E+03 0.54448839E+02 0.22961043E+02 0.92477889E+01 -0.14981326E+01 -0.43979361E+01 -0.47599617E+01 -0.41112205E+01 -0.16360339E-01 -0.14027045E-04 -0.55631807E-01 -0.15290583E-04 0.28727143E+03 0.74492479E-03 -0.12435232E-02 -0.12977970E-04 -0.13030250E-02 -0.13598958E-04 -0.62596797E-01 -0.17146335E-04 0.72214688E+01 -0.23869578E+01 -0.26017154E+01 -0.17984791E+03 -0.54747707E+02 0.12427625E+02 0.77206051E+01 -0.21771781E+01 -0.23380768E+01 -0.29175561E+01 0.12207171E+02 -0.19775386E+01 -0.40349134E+01 -0.43979361E+01 -0.30401491E+03 0.46742926E+02 0.21007653E+02 0.13050911E+02 -0.21142229E+01 -0.36803018E+01 -0.39522850E+01 -0.49318369E+01 -0.25620619E-01 -0.11950326E-04 -0.26518293E-02 -0.12977970E-04 0.24128914E+03 0.63315052E-03 -0.13810981E-01 -0.11634779E-04 -0.11006289E-02 -0.11486661E-04 -0.63481695E-01 -0.20719887E-04 0.81989485E+01 -0.20049953E+01 -0.21771781E+01 -0.15653041E+03 -0.45997623E+02 0.11571691E+02 0.98238567E+01 -0.19520974E+01 -0.19561967E+01 -0.34760615E+01 0.13859495E+02 -0.22451946E+01 -0.33892421E+01 -0.36803018E+01 -0.26459887E+03 0.40735007E+02 0.19560777E+02 0.16606239E+02 -0.26901584E+01 -0.32998235E+01 -0.33067529E+01 -0.58759299E+01 -0.50339268E-01 -0.11607759E-04 -0.11148212E-02 -0.11634779E-04 0.22981958E+03 0.60621082E-03 -0.18023531E-01 -0.11876018E-04 -0.10881183E-02 -0.11356095E-04 -0.63837177E-01 -0.22231077E-04 0.10360255E+02 -0.19095173E+01 -0.19520974E+01 -0.15508784E+03 -0.43818848E+02 0.11386064E+02 0.12831785E+02 -0.19537229E+01 -0.19090161E+01 -0.36567886E+01 0.17512975E+02 -0.28370121E+01 -0.32278480E+01 -0.32998235E+01 -0.26216048E+03 0.40412391E+02 0.19247000E+02 0.21690848E+02 -0.35138060E+01 -0.33025732E+01 -0.32270008E+01 -0.61814354E+01 -0.95382011E-01 -0.12485460E-04 -0.11379363E-02 -0.11876018E-04 0.24148168E+03 0.63659101E-03 -0.16867021E+00 -0.13820054E-04 -0.11826096E-02 -0.12342249E-04 -0.63020186E-01 -0.21688252E-04 0.13129917E+02 -0.20036945E+01 -0.19537229E+01 -0.17274263E+03 -0.46025611E+02 0.11710275E+02 0.21144376E+02 -0.22179112E+01 -0.20494640E+01 -0.34803075E+01 0.22194797E+02 -0.35953912E+01 -0.33870428E+01 -0.33025732E+01 -0.29200397E+03 0.45104546E+02 0.19795037E+02 0.35742431E+02 -0.57900063E+01 -0.37491545E+01 -0.34644117E+01 -0.58831074E+01 -0.18480862E-01 -0.16032981E-04 -0.13242099E-02 -0.13820054E-04 0.29865514E+03 0.76469165E-03 -0.20105532E-01 -0.17925139E-04 -0.60966350E-01 -0.18146949E-04 0.12425388E+02 -0.24817049E+01 -0.22179112E+01 -0.19650986E+03 -0.56998073E+02 0.10289227E+02 0.12667573E+02 -0.27745677E+01 -0.28086301E+01 0.21003875E+02 -0.34023914E+01 -0.41950740E+01 -0.37491545E+01 -0.33218027E+03 0.51053573E+02 0.17392906E+02 0.21413265E+02 -0.34687080E+01 -0.46901292E+01 -0.47477083E+01 -0.26512448E-01 -0.20972787E-04 -0.17175510E-02 -0.17925139E-04 0.37900353E+03 0.94034887E-03 -0.59610596E-01 -0.14556352E-04 0.17605472E+02 -0.31939497E+01 -0.27745677E+01 -0.23514888E+03 -0.72360764E+02 0.81931919E+01 -0.22165275E+01 0.29760267E+02 -0.48207812E+01 -0.53990486E+01 -0.46901292E+01 -0.39749538E+03 0.60849346E+02 0.13849764E+02 -0.37468149E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.15936654E-02 -0.16632213E-04 0.34465667E+03 0.85322576E-03 -0.15603987E-02 -0.16285026E-04 -0.61605779E-01 -0.14034255E-04 0.31315115E+01 -0.28647960E+01 -0.20210141E+03 -0.65668414E+02 0.81139592E+01 0.10432158E+01 -0.28137417E+01 -0.24280655E+01 0.52935070E+01 -0.85754645E+00 -0.48426511E+01 -0.34163222E+03 0.52406411E+02 0.13715837E+02 0.17634519E+01 -0.28567865E+00 -0.47563489E+01 -0.41044020E+01 -0.15724985E-02 -0.16411306E-04 -0.61502372E-01 -0.16285026E-04 0.33323007E+03 0.85636298E-03 -0.13963692E-02 -0.14573141E-04 -0.53339692E-02 -0.15145699E-04 -0.62108993E-01 -0.14554666E-04 0.48166846E+01 -0.28158806E+01 -0.28137417E+01 -0.19928675E+03 -0.63486307E+02 0.13273757E+02 0.31502848E+01 -0.25053347E+01 -0.26169199E+01 -0.25147666E+01 0.81421188E+01 -0.13190203E+01 -0.47599617E+01 -0.47563489E+01 -0.33687412E+03 0.51716900E+02 0.22437948E+02 0.53252382E+01 -0.86268678E+00 -0.42350152E+01 -0.44236383E+01 -0.42509584E+01 -0.62867949E-02 -0.13598958E-04 -0.75083445E-01 -0.14573141E-04 0.27580705E+03 0.71551982E-03 -0.11711663E-02 -0.12222822E-04 -0.49045070E-02 -0.12440083E-04 -0.62807060E-01 -0.17675613E-04 0.59756739E+01 -0.23380768E+01 -0.25053347E+01 -0.16923485E+03 -0.52550474E+02 0.12108122E+02 0.49393941E+01 -0.20813670E+01 -0.21386753E+01 -0.30387763E+01 0.10101279E+02 -0.16363979E+01 -0.39522850E+01 -0.42350152E+01 -0.28607459E+03 0.43955116E+02 0.20467567E+02 0.83495517E+01 -0.13526197E+01 -0.35183427E+01 -0.36152167E+01 -0.51367475E+01 -0.28587000E-01 -0.11486661E-04 -0.27329265E-01 -0.12222822E-04 0.22982680E+03 0.60506617E-03 -0.10877487E-02 -0.11352238E-04 -0.10614415E-02 -0.11077684E-04 -0.63624211E-01 -0.21422054E-04 0.72941785E+01 -0.19561967E+01 -0.20813670E+01 -0.14544989E+03 -0.43800301E+02 0.11508061E+02 0.62339408E+01 -0.19081462E+01 -0.19094757E+01 -0.36479617E+01 0.12330072E+02 -0.19974504E+01 -0.33067529E+01 -0.35183427E+01 -0.24586833E+03 0.37819564E+02 0.19453216E+02 0.10537847E+02 -0.17071130E+01 -0.32255284E+01 -0.32277759E+01 -0.61665103E+01 -0.51644733E-01 -0.11356095E-04 -0.12405304E-01 -0.11352238E-04 0.22982524E+03 0.60513208E-03 -0.11533051E-02 -0.12036414E-04 -0.10709075E-02 -0.11176475E-04 -0.63794897E-01 -0.21708012E-04 0.10488328E+02 -0.19090161E+01 -0.19081462E+01 -0.14859170E+03 -0.43809625E+02 0.11378192E+02 0.61945942E+01 -0.19983706E+01 -0.19088204E+01 -0.36489216E+01 0.17729469E+02 -0.28721199E+01 -0.32270008E+01 -0.32255284E+01 -0.25117942E+03 0.38656718E+02 0.19233694E+02 0.10471342E+02 -0.16963254E+01 -0.33780457E+01 -0.32266700E+01 -0.61681371E+01 -0.76275901E-01 -0.12342249E-04 -0.41889144E-02 -0.12036414E-04 0.25280021E+03 0.64834342E-03 -0.12183070E-02 -0.12714803E-04 -0.63493138E-01 -0.19998318E-04 0.18367232E+02 -0.20494640E+01 -0.19983706E+01 -0.16345444E+03 -0.48199513E+02 0.95205031E+01 -0.21469161E+01 -0.33203392E+01 0.31047948E+02 -0.50296385E+01 -0.34644117E+01 -0.33780457E+01 -0.27630321E+03 0.42501223E+02 0.16093452E+02 -0.36291456E+01 -0.56126982E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.14512306E-02 -0.15145699E-04 0.29870923E+03 0.74286310E-03 -0.12253255E-02 -0.12788052E-04 -0.62497635E-01 -0.16162266E-04 0.29235106E+01 -0.26169199E+01 -0.17516579E+03 -0.56914730E+02 0.76454607E+01 0.70861485E+00 -0.22168790E+01 -0.28052857E+01 0.49418988E+01 -0.80058804E+00 -0.44236383E+01 -0.29610005E+03 0.45417038E+02 0.12923878E+02 0.11978417E+01 -0.19405045E+00 -0.37474097E+01 -0.47420516E+01 -0.11919839E-02 -0.12440083E-04 -0.65872756E-01 -0.12788052E-04 0.24133995E+03 0.63226544E-03 -0.10868674E-02 -0.11343040E-04 -0.26363345E-02 -0.11284175E-04 -0.63248693E-01 -0.20025997E-04 0.43947349E+01 -0.21386753E+01 -0.22168790E+01 -0.14570455E+03 -0.42188136E+02 0.11743620E+02 0.27719884E+01 -0.19550432E+01 -0.19561966E+01 -0.34716727E+01 0.74288598E+01 -0.12034742E+01 -0.36152167E+01 -0.37474097E+01 -0.24629897E+03 0.44227243E+02 0.19851412E+02 0.46857691E+01 -0.75909392E+00 -0.33048051E+01 -0.33067548E+01 -0.58685156E+01 -0.12781218E-01 -0.11077684E-04 -0.41053693E-01 -0.11343040E-04 0.22983246E+03 0.60332626E-03 -0.10707159E-02 -0.11174475E-04 -0.16420732E-02 -0.11077758E-04 -0.63744100E-01 -0.21148424E-04 0.57477390E+01 -0.19094757E+01 -0.19550432E+01 -0.14206599E+03 -0.43793757E+02 0.11332200E+02 0.43873821E+01 -0.19082874E+01 -0.19093383E+01 -0.36451450E+01 0.97159725E+01 -0.15739818E+01 -0.32277759E+01 -0.33048051E+01 -0.24014821E+03 0.36909200E+02 0.19155942E+02 0.74164266E+01 -0.12014568E+01 -0.32257672E+01 -0.32275438E+01 -0.61617491E+01 -0.12881402E-01 -0.11176475E-04 -0.12486327E-01 -0.11174475E-04 0.22979623E+03 0.60487171E-03 -0.11582667E-02 -0.12088195E-04 -0.11079653E-02 -0.11563228E-04 -0.63757781E-01 -0.21366055E-04 0.75932097E+01 -0.19088204E+01 -0.19082874E+01 -0.14534879E+03 -0.43800643E+02 0.11511560E+02 0.58342629E+01 -0.20408938E+01 -0.19998514E+01 -0.36487932E+01 0.12835562E+02 -0.20793411E+01 -0.32266700E+01 -0.32257672E+01 -0.24569759E+03 0.37791073E+02 0.19459139E+02 0.98622379E+01 -0.15976672E+01 -0.34499269E+01 -0.33805488E+01 -0.61679201E+01 -0.28942638E-01 -0.12714803E-04 -0.17989387E-01 -0.12088195E-04 0.26426011E+03 0.66172256E-03 -0.63402179E-01 -0.18793556E-04 0.90579294E+01 -0.21469161E+01 -0.20408938E+01 -0.16075354E+03 -0.50380740E+02 0.73665337E+01 -0.31730689E+01 0.15311518E+02 -0.24804263E+01 -0.36291456E+01 -0.34499269E+01 -0.27173768E+03 0.41683042E+02 0.12452383E+02 -0.53637519E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.10812271E-02 -0.11284175E-04 0.22980627E+03 0.59156273E-03 -0.10508456E-02 -0.10967101E-04 -0.15430391E-01 -0.10935180E-04 -0.63775482E-01 -0.20866851E-04 0.34945548E+01 -0.19561966E+01 -0.13702239E+03 -0.43781862E+02 0.94233865E+01 0.15805871E+01 -0.19089412E+01 -0.19095203E+01 -0.36438231E+01 0.59071955E+01 -0.95696878E+00 -0.33067548E+01 -0.23162265E+03 0.35557344E+02 0.15929293E+02 0.26718245E+01 -0.43283697E+00 -0.32268743E+01 -0.32278531E+01 -0.61595186E+01 -0.10614486E-02 -0.11077758E-04 -0.41015050E-01 -0.10967101E-04 0.22983972E+03 0.60301883E-03 -0.11082774E-02 -0.11566485E-04 -0.14084164E-01 -0.10968606E-04 -0.63794062E-01 -0.20933286E-04 0.45370145E+01 -0.19093383E+01 -0.19089412E+01 -0.13962158E+03 -0.43787669E+02 0.11376364E+02 0.31452839E+01 -0.20002494E+01 -0.19092098E+01 -0.36437176E+01 0.76693654E+01 -0.12424395E+01 -0.32275438E+01 -0.32268743E+01 -0.23601620E+03 0.36254915E+02 0.19230594E+02 0.53167851E+01 -0.86132074E+00 -0.33812198E+01 -0.32273259E+01 -0.61593344E+01 -0.30386974E-02 -0.11563228E-04 -0.15614702E-01 -0.11566485E-04 0.25276665E+03 0.63354621E-03 -0.63580760E-01 -0.19161880E-04 0.62052888E+01 -0.19998514E+01 -0.20002494E+01 -0.15133049E+03 -0.48172242E+02 0.73192863E+01 -0.33137845E+01 0.10489420E+02 -0.16992821E+01 -0.33805488E+01 -0.33812198E+01 -0.25580907E+03 0.39248992E+02 0.12372520E+02 -0.56016213E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.10477870E-02 -0.10935180E-04 0.22979553E+03 0.58009517E-03 -0.10433945E-02 -0.10889337E-04 -0.63870563E-01 -0.20759632E-04 0.22605796E+01 -0.19095203E+01 -0.13474317E+03 -0.43777519E+02 0.74661549E+01 0.52937606E+00 -0.19090927E+01 -0.36426386E+01 0.38212837E+01 -0.61905167E+00 -0.32278531E+01 -0.22776985E+03 0.34943889E+02 0.12620788E+02 0.89485729E+00 -0.14496775E+00 -0.32271302E+01 -0.61575162E+01 -0.10509899E-02 -0.10968606E-04 -0.42359559E-01 -0.10889337E-04 0.22983197E+03 0.58014818E-03 -0.63888929E-01 -0.20783011E-04 0.33115470E+01 -0.19092098E+01 -0.19090927E+01 -0.13525858E+03 -0.43782057E+02 0.74668641E+01 -0.36436564E+01 0.55978351E+01 -0.90685487E+00 -0.32273259E+01 -0.32271302E+01 -0.22864096E+03 0.35074011E+02 0.12621981E+02 -0.61592331E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.25994143E+01 -0.94695072E-01 0.19983945E+03 0.26103739E+00 -0.18307631E+00 -0.30282569E-01 -0.26654401E+01 -0.56301327E-01 0.10350072E+02 -0.90991269E+00 -0.13370690E+03 -0.28933988E+02 0.20907142E+01 -0.63656354E+00 0.11613324E+02 -0.54102785E+00 0.17495750E+02 -0.18416690E+01 -0.15381153E+01 -0.22601800E+03 0.26839463E+02 0.35341416E+01 -0.10760470E+01 0.19631152E+02 -0.20664493E+01 -0.91455284E+00 -0.20304410E+01 -0.57589129E-01 -0.50296613E+00 -0.30282569E-01 0.18993261E+03 0.39513066E+00 -0.15909447E+00 -0.17631713E-01 -0.20257365E+01 -0.30138742E-01 -0.16231279E+01 -0.17988385E+00 0.11063571E+02 -0.12106635E+01 0.15421811E+01 -0.63656354E+00 -0.13058767E+03 -0.29175140E+02 0.40757323E+01 -0.68751686E+00 0.12447368E+02 -0.63364510E+00 -0.90410623E+00 0.18701860E+02 -0.22185372E+01 -0.20465056E+01 0.26069029E+01 -0.30924792E+00 -0.10760470E+01 -0.22074539E+03 0.28144064E+02 0.68896171E+01 -0.11621777E+01 0.21041031E+02 -0.24960249E+01 -0.10711137E+01 -0.15283012E+01 -0.15798380E+01 -0.37800198E-01 -0.30421249E+00 -0.17631713E-01 0.17737888E+03 0.25785878E+00 -0.10992009E+00 -0.97964493E-02 -0.15190962E+01 -0.17293696E-01 -0.10753633E+01 -0.95840005E-01 0.10271379E+02 -0.14740605E+01 0.76804050E+00 -0.68751686E+00 -0.12169148E+03 -0.28598581E+02 0.49391117E+01 -0.72186927E+00 0.11326966E+02 -0.67444889E+00 -0.13780428E+01 0.17362727E+02 -0.22457823E+01 -0.24917501E+01 0.12982948E+01 -0.16792798E+00 -0.11621777E+01 -0.20570714E+03 0.27549954E+02 0.83490693E+01 -0.12202478E+01 0.19147090E+02 -0.24765803E+01 -0.11400876E+01 -0.23294416E+01 -0.12449286E+01 -0.23819524E-01 -0.21725091E+00 -0.97964493E-02 0.16530078E+03 0.17101052E+00 -0.10736056E+01 -0.96005376E-02 -0.77598780E+00 -0.48389152E-01 0.99607313E+01 -0.17553192E+01 0.39035433E+00 -0.72186927E+00 -0.11383567E+03 -0.27734053E+02 0.50443281E+01 0.10369892E+02 -0.70754460E+00 -0.18565169E+01 0.16837620E+02 -0.22908186E+01 -0.29671916E+01 0.65985496E+00 -0.89775633E-01 -0.12202478E+01 -0.19242782E+03 0.26733771E+02 0.85269322E+01 0.17529266E+02 -0.23849195E+01 -0.11960334E+01 -0.31382562E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.94341750E+00 -0.15588662E-01 0.27372638E+03 0.18675300E+00 -0.31063380E+00 -0.17255584E-01 -0.15953616E+01 -0.17181733E-01 -0.91320914E+00 -0.56946019E-01 0.77871889E+01 -0.10375061E+01 -0.17821273E+03 -0.46024490E+02 0.40170978E+01 -0.92429644E+00 0.15256565E+02 -0.11435802E+01 -0.90660211E+00 0.13163464E+02 -0.17642359E+01 -0.17538002E+01 -0.30125080E+03 0.41622307E+02 0.67905012E+01 -0.15624298E+01 0.25789698E+02 -0.34564694E+01 -0.19331079E+01 -0.15325202E+01 -0.13679222E+01 -0.37420658E-01 -0.15570059E+00 -0.17255584E-01 0.27429668E+03 0.22662886E+00 -0.45924620E+00 -0.50896157E-01 -0.23447556E+01 -0.41112199E-01 0.72414355E+01 -0.83688804E+00 0.66831393E-02 -0.92429644E+00 -0.17646757E+03 -0.43113782E+02 0.35454112E+01 -0.85993164E+00 0.14043798E+02 -0.91950682E+00 0.12240915E+02 -0.14746526E+01 -0.14146747E+01 0.11297172E-01 -0.13609606E-02 -0.15624298E+01 -0.29830062E+03 0.38450812E+02 0.59931604E+01 -0.14536284E+01 0.23739623E+02 -0.28598919E+01 -0.15543334E+01 -0.15307554E+01 -0.46029227E-01 -0.42528600E+00 -0.50896157E-01 0.27499971E+03 0.27845349E+00 -0.37315851E+00 -0.50886177E-01 -0.26999874E+01 -0.50646805E-01 0.73587639E+01 -0.77776517E+00 0.35203495E+00 -0.85993164E+00 -0.17669933E+03 -0.42206845E+02 0.33582000E+01 -0.85997629E+00 0.13811176E+02 -0.85583973E+00 0.12439255E+02 -0.14685408E+01 -0.13147342E+01 0.59507987E+00 -0.70253332E-01 -0.14536284E+01 -0.29869255E+03 0.37696049E+02 0.56767002E+01 -0.14537028E+01 0.23346412E+02 -0.27562069E+01 -0.14467115E+01 -0.15171271E+01 -0.45988738E-01 -0.43522813E+00 -0.50886177E-01 0.27494106E+03 0.26592512E+00 -0.28159209E+00 -0.38399619E-01 -0.27363301E+01 -0.50655485E-01 0.72782798E+01 -0.77727817E+00 0.37276885E+00 -0.85997629E+00 -0.17682748E+03 -0.42207454E+02 0.34315562E+01 -0.93341499E+00 0.13998636E+02 -0.85619956E+00 0.12303195E+02 -0.14525767E+01 -0.13139100E+01 0.63012799E+00 -0.74396062E-01 -0.14537028E+01 -0.29890894E+03 0.37723230E+02 0.58006993E+01 -0.15778447E+01 0.23663276E+02 -0.27938047E+01 -0.14473186E+01 -0.13225046E+01 -0.35749077E-01 -0.42846889E+00 -0.38399619E-01 0.26894547E+03 0.21794486E+00 -0.23129015E+00 -0.25632829E-01 -0.23927782E+01 -0.38254744E-01 0.70173118E+01 -0.86906437E+00 0.53178770E+00 -0.93341499E+00 -0.17415171E+03 -0.42499768E+02 0.37247494E+01 -0.98752534E+00 0.14529641E+02 -0.93002484E+00 0.11862064E+02 -0.14575026E+01 -0.14690664E+01 0.89893392E+00 -0.11045283E+00 -0.15778447E+01 -0.29438605E+03 0.38216679E+02 0.62963151E+01 -0.16693115E+01 0.24560905E+02 -0.30178208E+01 -0.15721140E+01 -0.11990370E+01 -0.26535070E-01 -0.48675089E+00 -0.25632829E-01 0.25345377E+03 0.27783541E+00 -0.16380963E+00 -0.14599267E-01 -0.20431895E+01 -0.25273315E-01 -0.11895630E+01 -0.10601787E+00 0.75441924E+01 -0.10223718E+01 0.16053408E+01 -0.98752534E+00 -0.16708346E+03 -0.41094302E+02 0.47692005E+01 -0.10151535E+01 0.15172454E+02 -0.97381837E+00 -0.76576743E+00 0.12752693E+02 -0.16457484E+01 -0.17282160E+01 0.27136660E+01 -0.35020145E+00 -0.16693115E+01 -0.28243766E+03 0.37822306E+02 0.80618517E+01 -0.17160154E+01 0.25647495E+02 -0.33098362E+01 -0.16461413E+01 -0.12944525E+01 -0.94429877E+00 -0.17904448E-01 -0.32832762E+00 -0.14599267E-01 0.23061226E+03 0.19055436E+00 -0.27684053E+00 -0.13444978E-01 -0.14800182E+01 -0.14389328E-01 -0.81124421E+00 -0.50587676E-01 0.70004257E+01 -0.12450844E+01 0.77100684E+00 -0.10151535E+01 -0.15247358E+03 -0.38737952E+02 0.53963467E+01 0.33671755E-01 -0.93492686E+00 0.14324093E+02 -0.10007156E+01 -0.11961635E+01 0.11833520E+02 -0.15965280E+01 -0.21046906E+01 0.13033100E+01 -0.17583702E+00 -0.17160154E+01 -0.25774134E+03 0.35691370E+02 0.91219845E+01 0.56918735E-01 -0.76792327E-02 -0.15804004E+01 0.24213447E+02 -0.32667749E+01 -0.16916096E+01 -0.20219947E+01 -0.49113639E+00 -0.88105909E-02 -0.19213504E+01 -0.56301327E-01 -0.45882599E+00 -0.13444978E-01 0.21517023E+03 0.11397561E+00 -0.96336002E-01 -0.28229337E-02 -0.74843137E+00 -0.60525091E-02 -0.88396792E+00 -0.25902910E-01 0.43571752E+01 -0.15144038E+01 -0.54102785E+00 -0.93492686E+00 -0.13784731E+03 -0.37353073E+02 0.66361713E+01 -0.10486939E+01 0.12460168E+02 -0.10404125E+01 -0.15525563E+01 0.73653644E+01 -0.10349868E+01 -0.25599466E+01 -0.91455284E+00 -0.15804004E+01 -0.23301694E+03 0.33533235E+02 0.11217779E+02 -0.17727122E+01 0.21062655E+02 -0.29597410E+01 -0.17587122E+01 -0.26244395E+01 -0.35135249E+00 -0.47336046E-02 -0.17041409E+01 -0.30138742E-01 -0.20094568E+00 -0.28229337E-02 0.19779559E+03 0.53736241E-01 -0.10674129E+00 -0.18877829E-02 -0.45062396E+00 -0.27784901E-02 -0.61217237E+00 -0.10826631E-01 0.31476727E+01 -0.17586124E+01 -0.63364510E+00 0.15631499E+01 -0.10486939E+01 -0.12762179E+03 -0.35250430E+02 0.74250632E+01 -0.99184626E+00 0.11194629E+02 -0.10323390E+01 -0.19560092E+01 0.53208259E+01 -0.77296038E+00 -0.29727583E+01 -0.10711137E+01 0.26423486E+01 -0.38385597E+00 -0.17727122E+01 -0.21573187E+03 0.31772134E+02 0.12551325E+02 -0.16766156E+01 0.18923400E+02 -0.27490166E+01 -0.17450659E+01 -0.33064380E+01 -0.28222379E+00 -0.37533603E-02 -0.97784090E+00 -0.17293696E-01 -0.15896989E+00 -0.18877829E-02 0.18041258E+03 0.33488050E-01 -0.78484528E-01 -0.13880454E-02 -0.35805095E+00 -0.18557042E-02 -0.38579490E+00 -0.68230113E-02 0.27004002E+01 -0.19721237E+01 -0.67444889E+00 0.20088489E+01 -0.99184626E+00 -0.11678376E+03 -0.32598054E+02 0.78000515E+01 -0.93479640E+00 0.96689609E+01 -0.97512180E+00 -0.22480915E+01 0.45647529E+01 -0.68172614E+00 -0.33336753E+01 -0.11400876E+01 0.33957556E+01 -0.50714144E+00 -0.16766156E+01 -0.19741111E+03 0.29396479E+02 0.13185199E+02 -0.15801798E+01 0.16344398E+02 -0.24409657E+01 -0.16483446E+01 -0.38001718E+01 -0.24677947E+00 -0.31688925E-02 -0.54284512E+00 -0.96005376E-02 -0.11892199E+00 -0.13880454E-02 0.16891509E+03 0.22088858E-01 -0.28875352E+00 -0.13818955E-02 -0.34495919E+00 -0.61008077E-02 0.26224513E+01 -0.21342173E+01 -0.70754460E+00 0.15524766E+01 -0.93479640E+00 -0.10842997E+03 -0.30770477E+02 0.71518116E+01 0.80561138E+01 -0.93077878E+00 -0.24410548E+01 0.44329917E+01 -0.67205137E+00 -0.36076809E+01 -0.11960334E+01 0.26243064E+01 -0.39785068E+00 -0.15801798E+01 -0.18329003E+03 0.27455917E+02 0.12089422E+02 0.13618055E+02 -0.20645273E+01 -0.15733884E+01 -0.41263590E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.22967574E+00 -0.25591232E-02 -0.97151014E+00 -0.17181733E-01 0.27223071E+03 0.32932197E-01 -0.17210740E+00 -0.28294990E-02 -0.53250509E+00 -0.28194601E-02 -0.38467931E+00 -0.68032816E-02 0.32697759E+01 -0.12998960E+01 -0.11435802E+01 -0.17317694E+03 -0.49368972E+02 0.67511947E+01 0.49197405E+00 -0.14371314E+01 0.14275476E+02 -0.14322317E+01 -0.14328639E+01 0.55272291E+01 -0.82353642E+00 -0.21973442E+01 -0.19331079E+01 -0.29273829E+03 0.43512859E+02 0.11412219E+02 0.83163294E+00 -0.12391019E+00 -0.24293269E+01 0.24131264E+02 -0.35954678E+01 -0.24210445E+01 -0.24221131E+01 -0.24668124E+00 -0.28842481E-02 -0.23246153E+01 -0.41112199E-01 -0.15998893E+00 -0.28294990E-02 0.27395310E+03 0.63605256E-01 -0.18438923E+00 -0.31910365E-02 -0.55027657E+00 -0.31808633E-02 -0.54619795E+00 -0.96598344E-02 0.31960331E+01 -0.12865738E+01 -0.91950682E+00 -0.14371314E+01 -0.17264244E+03 -0.49216982E+02 0.78573807E+01 0.16264263E+00 -0.14233134E+01 0.14143033E+02 -0.14189740E+01 -0.13664069E+01 0.54025700E+01 -0.79723475E+00 -0.21748226E+01 -0.15543334E+01 -0.24293269E+01 -0.29183455E+03 0.43218287E+02 0.13282108E+02 0.27493090E+00 -0.40570407E-01 -0.24059670E+01 0.23907365E+02 -0.35279108E+01 -0.23986317E+01 -0.23097726E+01 -0.28443899E+00 -0.35153406E-02 -0.28637324E+01 -0.50646805E-01 -0.18043142E+00 -0.31910365E-02 0.27481093E+03 0.78662068E-01 -0.24138800E+00 -0.42690898E-02 -0.59699022E+00 -0.38802399E-02 -0.70088362E+00 -0.12395542E-01 0.32664290E+01 -0.12614183E+01 -0.85583973E+00 -0.14233134E+01 -0.17281288E+03 -0.48921717E+02 0.76431732E+01 -0.13833851E+01 0.14403206E+02 -0.13924364E+01 -0.13213394E+01 0.55215716E+01 -0.79947677E+00 -0.21323014E+01 -0.14467115E+01 -0.24059670E+01 -0.29212289E+03 0.42950807E+02 0.12920016E+02 -0.23384726E+01 0.24347179E+02 -0.35252652E+01 -0.23537745E+01 -0.22335922E+01 -0.26456607E+00 -0.38554926E-02 -0.17286792E+01 -0.50655485E-01 -0.15451154E+00 -0.42690898E-02 0.27349579E+03 0.82507420E-01 -0.14526412E+00 -0.42566742E-02 -0.76581908E+00 -0.42558043E-02 -0.49287455E+00 -0.14442702E-01 0.30876061E+01 -0.12494341E+01 -0.85619956E+00 0.24181193E+00 -0.13833851E+01 -0.17276544E+03 -0.48774953E+02 0.75456821E+01 -0.13835616E+01 0.14291331E+02 -0.13792433E+01 -0.12884342E+01 0.52192858E+01 -0.77639466E+00 -0.21120419E+01 -0.14473186E+01 0.40875861E+00 -0.60804872E-01 -0.23384726E+01 -0.29204251E+03 0.42945063E+02 0.12755213E+02 -0.23387725E+01 0.24158050E+02 -0.35936298E+01 -0.23314713E+01 -0.21779671E+01 -0.25348871E+00 -0.38426087E-02 -0.13054890E+01 -0.38254744E-01 -0.17752046E+00 -0.42566742E-02 0.27306577E+03 0.69051934E-01 -0.11080353E+00 -0.32468757E-02 -0.78112229E+00 -0.42450288E-02 -0.49257780E+00 -0.14434007E-01 0.28481953E+01 -0.12490543E+01 -0.93002484E+00 0.75067591E+00 -0.13835616E+01 -0.17340412E+03 -0.48777713E+02 0.76252238E+01 -0.13893338E+01 0.14659879E+02 -0.13799393E+01 -0.12878855E+01 0.48145894E+01 -0.71633806E+00 -0.21114013E+01 -0.15721140E+01 0.12689425E+01 -0.18879944E+00 -0.23387725E+01 -0.29312233E+03 0.43110071E+02 0.12889677E+02 -0.23485284E+01 0.24781060E+02 -0.36870468E+01 -0.23326495E+01 -0.21770417E+01 -0.24545835E+00 -0.31193424E-02 -0.14290341E+01 -0.25273315E-01 -0.21351350E+00 -0.32468757E-02 0.26218126E+03 0.45701364E-01 -0.10206592E+00 -0.18050962E-02 -0.57719046E+00 -0.32392722E-02 -0.46913868E+00 -0.82969956E-02 0.26556692E+01 -0.13348595E+01 -0.97381837E+00 0.11211317E+01 -0.13893338E+01 -0.16777298E+03 -0.47196986E+02 0.79181472E+01 -0.13662471E+01 0.15059125E+02 -0.13862673E+01 -0.14623719E+01 0.44891401E+01 -0.66023896E+00 -0.22564449E+01 -0.16461413E+01 0.18951598E+01 -0.27873005E+00 -0.23485284E+01 -0.28360325E+03 0.41945986E+02 0.13384829E+02 -0.23095040E+01 0.25455928E+02 -0.37439226E+01 -0.23433446E+01 -0.24719924E+01 -0.16964017E+00 -0.19490968E-02 -0.81361864E+00 -0.14389328E-01 -0.14452863E+00 -0.18050962E-02 0.24486254E+03 0.26182592E-01 -0.54021312E-01 -0.95539891E-03 -0.47203252E+00 -0.17830369E-02 -0.26316000E+00 -0.46541406E-02 0.22969720E+01 -0.14753468E+01 -0.10007156E+01 0.16297685E+01 -0.13662471E+01 -0.15774793E+03 -0.41064603E+02 0.81507424E+01 -0.12936026E+01 0.14196280E+02 -0.13497327E+01 -0.16601180E+01 0.38828015E+01 -0.59213620E+00 -0.24939263E+01 -0.16916096E+01 0.27549606E+01 -0.42013785E+00 -0.23095040E+01 -0.26665710E+03 0.46264109E+02 0.13778014E+02 -0.21867046E+01 0.23997392E+02 -0.36596577E+01 -0.22815881E+01 -0.28062634E+01 -0.13642991E+00 -0.12270051E-02 -0.57993932E+00 -0.60525091E-02 -0.11300694E+00 -0.95539891E-03 0.22278356E+03 0.13701012E-01 -0.53377101E-01 -0.55706758E-03 -0.22680976E+00 -0.94287598E-03 -0.32536038E+00 -0.33956081E-02 0.18522376E+01 -0.16614562E+01 -0.10404125E+01 0.20830028E+01 -0.12936026E+01 -0.14455120E+03 -0.41118626E+02 0.83866352E+01 -0.12207824E+01 0.13404257E+02 -0.12768153E+01 -0.18889917E+01 0.31310206E+01 -0.47319693E+00 -0.28085241E+01 -0.17587122E+01 0.35211060E+01 -0.53215124E+00 -0.21867046E+01 -0.24434921E+03 0.36879671E+02 0.14176761E+02 -0.20636106E+01 0.22658544E+02 -0.34244273E+01 -0.21583274E+01 -0.31931494E+01 -0.94691775E-01 -0.83846689E-03 -0.26622936E+00 -0.27784901E-02 -0.79317551E-01 -0.55706758E-03 0.20593401E+03 0.71190537E-02 -0.32430064E-01 -0.33845482E-03 -0.16328562E+00 -0.54926603E-03 -0.14818824E+00 -0.15465596E-02 0.14134890E+01 -0.18375694E+01 -0.10323390E+01 0.25500288E+01 -0.12207824E+01 -0.13389236E+03 -0.38434575E+02 0.85689023E+01 -0.11452500E+01 0.12028529E+02 -0.12038403E+01 -0.21248446E+01 0.23893618E+01 -0.37068624E+00 -0.31062273E+01 -0.17450659E+01 0.43105686E+01 -0.66874278E+00 -0.20636106E+01 -0.22633164E+03 0.34516930E+02 0.14484871E+02 -0.19359292E+01 0.20333025E+02 -0.31544711E+01 -0.20349717E+01 -0.35918374E+01 -0.59815559E-01 -0.59869776E-03 -0.17780986E+00 -0.18557042E-02 -0.61814214E-01 -0.33845482E-03 0.18949353E+03 0.49610741E-02 -0.10790809E-01 -0.11261776E-03 -0.10917736E+00 -0.33334856E-03 -0.12089323E+00 -0.12616964E-02 0.11849396E+01 -0.20259409E+01 -0.97512180E+00 0.28854936E+01 -0.11452500E+01 -0.12295136E+03 -0.35577035E+02 0.87141966E+01 -0.10875644E+01 0.10289212E+02 -0.11280965E+01 -0.23482642E+01 0.20030206E+01 -0.31551711E+00 -0.34246482E+01 -0.16483446E+01 0.48776351E+01 -0.76832827E+00 -0.19359292E+01 -0.20783683E+03 0.31890305E+02 0.14730469E+02 -0.18384188E+01 0.17392873E+02 -0.27397367E+01 -0.19069330E+01 -0.39695031E+01 -0.10052266E-02 -0.10490999E-04 -0.13241047E+00 -0.13818955E-02 -0.39817283E-01 -0.11261776E-03 0.17843031E+03 0.28591254E-02 -0.23448881E-01 -0.11074615E-03 -0.78631371E-01 -0.82063256E-03 0.10530149E+01 -0.21889664E+01 -0.93077878E+00 0.28496034E+01 -0.10875644E+01 -0.11210207E+03 -0.33750151E+02 0.78225303E+01 0.58141667E+01 -0.10695946E+01 -0.25418704E+01 0.17800163E+01 -0.28562166E+00 -0.37002288E+01 -0.15733884E+01 0.48169695E+01 -0.77293156E+00 -0.18384188E+01 -0.18949733E+03 0.29257887E+02 0.13223205E+02 0.98282675E+01 -0.15770451E+01 -0.18080426E+01 -0.42967777E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.72977776E-03 -0.76162909E-05 -0.27015503E+00 -0.28194601E-02 0.27046663E+03 0.51151597E-02 -0.37651590E-01 -0.35388657E-03 -0.15377477E+00 -0.35321712E-03 -0.89063470E-01 -0.92950667E-03 0.16788203E+01 -0.14261365E+01 -0.14322317E+01 -0.17189519E+03 -0.46745499E+02 0.76639625E+01 0.36624285E+00 -0.15827589E+01 0.14741648E+02 -0.15799292E+01 -0.16372305E+01 0.28378778E+01 -0.45011231E+00 -0.24107412E+01 -0.24210445E+01 -0.29057162E+03 0.51757860E+02 0.12955162E+02 0.61909691E+00 -0.98194198E-01 -0.26754957E+01 0.24919282E+02 -0.39524166E+01 -0.26707124E+01 -0.27675744E+01 -0.73412139E-03 -0.76616229E-05 -0.30478396E+00 -0.31808633E-02 -0.33908703E-01 -0.35388657E-03 0.27060496E+03 0.63467067E-02 -0.54179127E-01 -0.51886286E-03 -0.18816192E+00 -0.51772590E-03 -0.10603352E+00 -0.11066138E-02 0.17171980E+01 -0.14116883E+01 -0.14189740E+01 -0.15827589E+01 -0.17228586E+03 -0.50782874E+02 0.91689950E+01 0.43654628E+00 -0.15665785E+01 0.15021144E+02 -0.15633187E+01 -0.16200209E+01 0.29027491E+01 -0.45568920E+00 -0.23863159E+01 -0.23986317E+01 -0.26754957E+01 -0.29123177E+03 0.44566443E+02 0.15499259E+02 0.73793721E+00 -0.11584536E+00 -0.26481421E+01 0.25391720E+02 -0.39861297E+01 -0.26426316E+01 -0.27384818E+01 -0.83648948E-01 -0.69066782E-03 -0.37179683E+00 -0.38802399E-02 -0.49716401E-01 -0.51886286E-03 0.27088887E+03 0.89254441E-02 -0.75229391E-01 -0.76641004E-03 -0.23217630E+00 -0.76427333E-03 -0.15613218E+00 -0.16294661E-02 0.17659413E+01 -0.13900576E+01 -0.13924364E+01 -0.15665785E+01 -0.17267578E+03 -0.50522390E+02 0.90250451E+01 0.17603575E+00 -0.15423978E+01 0.15619168E+02 -0.15382633E+01 -0.15896856E+01 0.29851472E+01 -0.46135374E+00 -0.23497534E+01 -0.23537745E+01 -0.26481421E+01 -0.29189114E+03 0.44401261E+02 0.15255934E+02 0.29757084E+00 -0.45989498E-01 -0.26072693E+01 0.26402642E+02 -0.40805217E+01 -0.26002803E+01 -0.26872046E+01 -0.90841256E-01 -0.76505808E-03 -0.40778265E+00 -0.42558043E-02 -0.73435877E-01 -0.76641004E-03 0.27102069E+03 0.10247861E-01 -0.89236815E-01 -0.93131578E-03 -0.24653057E+00 -0.84683365E-03 -0.19183742E+00 -0.20021021E-02 0.17265057E+01 -0.13827379E+01 -0.13792433E+01 -0.15423978E+01 -0.17309385E+03 -0.50435532E+02 0.89420690E+01 -0.15260234E+01 0.16251500E+02 -0.15306042E+01 -0.15754464E+01 0.29184835E+01 -0.44868031E+00 -0.23373788E+01 -0.23314713E+01 -0.26072693E+01 -0.29259767E+03 0.44420332E+02 0.15115667E+02 -0.25795900E+01 0.27471520E+02 -0.42234023E+01 -0.25873318E+01 -0.26631324E+01 -0.96814191E-01 -0.83952900E-03 -0.40675017E+00 -0.42450288E-02 -0.93438877E-01 -0.93131578E-03 0.27107150E+03 0.10687625E-01 -0.65512219E-01 -0.68371516E-03 -0.25906107E+00 -0.92907918E-03 -0.22745387E+00 -0.23738115E-02 0.16122468E+01 -0.13756968E+01 -0.13799393E+01 0.41368427E+00 -0.15260234E+01 -0.17385172E+03 -0.50348460E+02 0.89215598E+01 -0.15502175E+01 0.16708277E+02 -0.15225090E+01 -0.15615681E+01 0.27253420E+01 -0.41677580E+00 -0.23254778E+01 -0.23326495E+01 0.69929187E+00 -0.10693995E+00 -0.25795900E+01 -0.29387895E+03 0.44526891E+02 0.15081003E+02 -0.26204856E+01 0.28243671E+02 -0.43191932E+01 -0.25736492E+01 -0.26396747E+01 -0.65999328E-01 -0.61583367E-03 -0.31038059E+00 -0.32392722E-02 -0.75844300E-01 -0.68371516E-03 0.27077148E+03 0.76019344E-02 -0.41026695E-01 -0.42817315E-03 -0.23560074E+00 -0.68240063E-03 -0.12282236E+00 -0.12818297E-02 0.14359568E+01 -0.13964088E+01 -0.13862673E+01 0.10137104E+01 -0.15502175E+01 -0.17428890E+03 -0.50608681E+02 0.90132706E+01 -0.15252253E+01 0.16724953E+02 -0.15474048E+01 -0.16021115E+01 0.24273393E+01 -0.37711731E+00 -0.23604874E+01 -0.23433446E+01 0.17135748E+01 -0.26622512E+00 -0.26204856E+01 -0.29461773E+03 0.44916084E+02 0.15236023E+02 -0.25782408E+01 0.28271838E+02 -0.43923811E+01 -0.26157309E+01 -0.27082075E+01 -0.77207549E-03 -0.80577291E-05 -0.17084703E+00 -0.17830369E-02 -0.58311841E-01 -0.42817315E-03 0.25425503E+03 0.44242257E-02 -0.10246567E-01 -0.10693781E-03 -0.19127099E+00 -0.42747906E-03 -0.10092811E+00 -0.10533314E-02 0.12813488E+01 -0.15089297E+01 -0.13497327E+01 0.16975120E+01 -0.15252253E+01 -0.16491776E+03 -0.47810756E+02 0.91070254E+01 -0.14596526E+01 0.16134038E+02 -0.15229139E+01 -0.17352467E+01 0.21659920E+01 -0.34166937E+00 -0.25506948E+01 -0.22815881E+01 0.28694743E+01 -0.45263855E+00 -0.25782408E+01 -0.27877699E+03 0.42765198E+02 0.15394514E+02 -0.24673954E+01 0.27272978E+02 -0.43021124E+01 -0.25743337E+01 -0.29332610E+01 -0.81186756E-03 -0.84730171E-05 -0.90344491E-01 -0.94287598E-03 -0.34337972E-01 -0.10693781E-03 0.23782966E+03 0.24260529E-02 -0.65885284E-03 -0.68760863E-05 -0.11179913E+00 -0.10565836E-03 -0.66503128E-01 -0.69405673E-03 0.10325500E+01 -0.16449913E+01 -0.12768153E+01 0.23644677E+01 -0.14596526E+01 -0.15480489E+03 -0.45058371E+02 0.90804599E+01 -0.13549230E+01 0.14912651E+02 -0.14423564E+01 -0.18967026E+01 0.17454215E+01 -0.28089742E+00 -0.27806916E+01 -0.21583274E+01 0.39968939E+01 -0.64323556E+00 -0.24673954E+01 -0.26168204E+03 0.40473282E+02 0.15349602E+02 -0.22903617E+01 0.25208332E+02 -0.40568740E+01 -0.24381578E+01 -0.32061840E+01 -0.87710119E-03 -0.91538248E-05 -0.52629573E-01 -0.54926603E-03 -0.44043340E-01 -0.68760863E-05 0.21612747E+03 0.10941948E-02 -0.59104318E-03 -0.61683940E-05 -0.82149322E-01 -0.67098090E-05 -0.16242420E-01 -0.10967924E-04 0.83364392E+00 -0.18224369E+01 -0.12038403E+01 0.30148106E+01 -0.13549230E+01 -0.14190275E+03 -0.41054366E+02 0.90787282E+01 -0.12428850E+01 0.13969117E+02 -0.13223121E+01 -0.21277579E+01 0.14091917E+01 -0.22830455E+00 -0.30806474E+01 -0.20349717E+01 0.50962357E+01 -0.82564623E+00 -0.22903617E+01 -0.23987241E+03 0.37214192E+02 0.15346681E+02 -0.21009714E+01 0.23613395E+02 -0.38256296E+01 -0.22352363E+01 -0.35967619E+01 -0.93215578E-03 -0.97283995E-05 -0.31940792E-01 -0.33334856E-03 -0.58247628E-01 -0.61683940E-05 0.19996790E+03 0.83949727E-03 -0.52533485E-03 -0.54826322E-05 -0.90193798E-01 -0.60039162E-05 -0.50112401E-01 -0.11599637E-04 0.72120326E+00 -0.19705921E+01 -0.11280965E+01 0.39142685E+01 -0.12428850E+01 -0.13385425E+03 -0.37975522E+02 0.90385088E+01 -0.11456522E+01 0.14440091E+02 -0.12098873E+01 -0.23371655E+01 0.12191212E+01 -0.19751333E+00 -0.33310866E+01 -0.19069330E+01 0.66166751E+01 -0.10719866E+01 -0.21009714E+01 -0.22626707E+03 0.35133565E+02 0.15278686E+02 -0.19366105E+01 0.24409514E+02 -0.39546552E+01 -0.20451922E+01 -0.39507414E+01 -0.98487380E-03 -0.10278589E-04 -0.10611475E-01 -0.11074615E-03 -0.93439445E-01 -0.54826322E-05 0.18369762E+03 0.56796279E-03 -0.50293461E-01 -0.12178326E-04 0.71032899E+00 -0.21455762E+01 -0.10695946E+01 0.69641265E+01 -0.11456522E+01 -0.11314811E+03 -0.34895594E+02 0.69094057E+01 -0.25446960E+01 0.12007401E+01 -0.19453863E+00 -0.36268820E+01 -0.18080426E+01 0.11772159E+02 -0.19072734E+01 -0.19366105E+01 -0.19126556E+03 0.29589117E+02 0.11679659E+02 -0.43015541E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.74924889E-03 -0.78195004E-05 -0.33844558E-01 -0.35321712E-03 0.27006466E+03 0.10190183E-02 -0.23272008E-01 -0.86914551E-05 -0.81983186E-01 -0.86631152E-05 -0.26950785E-01 -0.92959444E-05 0.11331974E+01 -0.14582423E+01 -0.15799292E+01 -0.17259416E+03 -0.47092408E+02 0.79812487E+01 0.65042611E+00 -0.16170433E+01 0.15723926E+02 -0.16119602E+01 -0.17083509E+01 0.19155568E+01 -0.31033210E+00 -0.24650128E+01 -0.26707124E+01 -0.29175317E+03 0.52338123E+02 0.13491503E+02 0.10994803E+01 -0.17812263E+00 -0.27334499E+01 0.26579724E+02 -0.43060803E+01 -0.27248575E+01 -0.28877963E+01 -0.75103977E-03 -0.78381908E-05 -0.49607460E-01 -0.51772590E-03 -0.83279784E-03 -0.86914551E-05 0.27006462E+03 0.11924069E-02 -0.25815780E-01 -0.87442691E-05 -0.78661667E-01 -0.87145283E-05 -0.93601400E-02 -0.93569795E-05 0.11448642E+01 -0.14589760E+01 -0.15633187E+01 -0.16170433E+01 -0.17344824E+03 -0.51330777E+02 0.95657797E+01 0.10439707E+01 -0.16170724E+01 0.16170540E+02 -0.16117717E+01 -0.16918757E+01 0.19352772E+01 -0.31352611E+00 -0.24662515E+01 -0.26426316E+01 -0.27334499E+01 -0.29319672E+03 0.45408629E+02 0.16169985E+02 0.17647269E+01 -0.28589598E+00 -0.27334974E+01 0.27334664E+02 -0.44283740E+01 -0.27245372E+01 -0.28599448E+01 -0.75361219E-03 -0.78650378E-05 -0.73231142E-01 -0.76427333E-03 -0.83785838E-03 -0.87442691E-05 0.27012596E+03 0.20389723E-02 -0.10518080E-01 -0.24119375E-04 -0.84096921E-01 -0.24033219E-04 -0.55354421E-01 -0.57770378E-03 0.11600652E+01 -0.14583174E+01 -0.15382633E+01 -0.16170724E+01 -0.17424625E+03 -0.51313295E+02 0.95203559E+01 0.80556735E+00 -0.16156055E+01 0.17189845E+02 -0.16100400E+01 -0.16753377E+01 0.19609742E+01 -0.31739229E+00 -0.24651397E+01 -0.26002803E+01 -0.27334974E+01 -0.29454586E+03 0.45613128E+02 0.16093208E+02 0.13617310E+01 -0.22040215E+00 -0.27310196E+01 0.29057715E+02 -0.47031187E+01 -0.27216116E+01 -0.28319909E+01 -0.75594456E-03 -0.78893794E-05 -0.81141907E-01 -0.84683365E-03 -0.23110703E-02 -0.24119375E-04 0.27017949E+03 0.23944515E-02 -0.10675461E-01 -0.10662713E-03 -0.11909565E+00 -0.10624358E-03 -0.63785526E-01 -0.66569460E-03 0.11939511E+01 -0.14501622E+01 -0.15306042E+01 -0.16156055E+01 -0.17463575E+03 -0.51226801E+02 0.94771723E+01 0.44261743E-01 -0.16074876E+01 0.18305960E+02 -0.16019100E+01 -0.16656929E+01 0.20182535E+01 -0.32502469E+00 -0.24513525E+01 -0.25873318E+01 -0.27310196E+01 -0.29520408E+03 0.45626707E+02 0.16020203E+02 0.74820002E-01 -0.12049203E-01 -0.27172951E+01 0.30944375E+02 -0.49833605E+01 -0.27078668E+01 -0.28156854E+01 -0.75745833E-03 -0.79051779E-05 -0.89022509E-01 -0.92907918E-03 -0.10216799E-01 -0.10662713E-03 0.27022719E+03 0.27344592E-02 -0.10210680E-01 -0.10656327E-03 -0.14191900E+00 -0.18843431E-03 -0.72246429E-01 -0.75399642E-03 0.11859610E+01 -0.14428372E+01 -0.15225090E+01 -0.16074876E+01 -0.17527966E+03 -0.51139888E+02 0.94366858E+01 -0.16073277E+01 0.19000849E+02 -0.15938227E+01 -0.16570018E+01 0.20047484E+01 -0.32122225E+00 -0.24389721E+01 -0.25736492E+01 -0.27172951E+01 -0.29629274E+03 0.45709042E+02 0.15951770E+02 -0.27170249E+01 0.32119036E+02 -0.51464557E+01 -0.26941978E+01 -0.28009959E+01 -0.75306130E-03 -0.78592885E-05 -0.65386264E-01 -0.68240063E-03 -0.20434374E-01 -0.10656327E-03 0.27017970E+03 0.22144193E-02 -0.83475666E-03 -0.87118981E-05 -0.12621266E+00 -0.10619059E-03 -0.63781487E-01 -0.66565245E-03 0.11138329E+01 -0.14504481E+01 -0.15474048E+01 0.10039705E+01 -0.16073277E+01 -0.17621607E+03 -0.51226311E+02 0.94953093E+01 -0.16164755E+01 0.19005981E+02 -0.16019098E+01 -0.16660338E+01 0.18828219E+01 -0.30321541E+00 -0.24518359E+01 -0.26157309E+01 0.16971106E+01 -0.27330792E+00 -0.27170249E+01 -0.29787545E+03 0.46058279E+02 0.16050862E+02 -0.27324901E+01 0.32127690E+02 -0.51739417E+01 -0.27078666E+01 -0.28162617E+01 -0.74869979E-03 -0.78137698E-05 -0.40960189E-01 -0.42747906E-03 -0.33836202E-01 -0.87118981E-05 0.27009668E+03 0.11015790E-02 -0.78804909E-03 -0.82244368E-05 -0.10977257E+00 -0.86890117E-05 -0.10376518E-01 -0.93263373E-05 0.10105250E+01 -0.14587762E+01 -0.15229139E+01 0.18318018E+01 -0.16164755E+01 -0.17638804E+03 -0.51330268E+02 0.94573617E+01 -0.15490538E+01 0.18456170E+02 -0.16124359E+01 -0.16919846E+01 0.17081915E+01 -0.27673724E+00 -0.24659153E+01 -0.25743337E+01 0.30964777E+01 -0.50164789E+00 -0.27324901E+01 -0.29816634E+03 0.46214953E+02 0.15986723E+02 -0.26185188E+01 0.31198310E+02 -0.50543129E+01 -0.27256617E+01 -0.28601308E+01 -0.80683750E-03 -0.84205212E-05 -0.10123973E-01 -0.10565836E-03 -0.66563982E-01 -0.82244368E-05 0.24853926E+03 0.72852564E-03 -0.71484597E-03 -0.74604560E-05 -0.10755802E+00 -0.79657624E-05 -0.49089751E-01 -0.99785368E-05 0.95135559E+00 -0.15845640E+01 -0.14423564E+01 0.25614310E+01 -0.15490538E+01 -0.16295395E+03 -0.47227537E+02 0.93810030E+01 -0.14198346E+01 0.16763446E+02 -0.15005276E+01 -0.18794010E+01 0.16081704E+01 -0.26053543E+00 -0.26785451E+01 -0.24381578E+01 0.43298401E+01 -0.70146590E+00 -0.26185188E+01 -0.27545719E+03 0.42694757E+02 0.15857638E+02 -0.24000884E+01 0.28336913E+02 -0.45907875E+01 -0.25364900E+01 -0.31769365E+01 -0.87588529E-03 -0.91411352E-05 -0.64292048E-03 -0.67098090E-05 -0.58069268E-01 -0.74604560E-05 0.22691115E+03 0.57844776E-03 -0.64440876E-03 -0.67253413E-05 -0.90980477E-01 -0.72877828E-05 -0.49472007E-01 -0.10817669E-04 0.87183274E+00 -0.17360007E+01 -0.13223121E+01 0.27416608E+01 -0.14198346E+01 -0.14900934E+03 -0.43123039E+02 0.92191644E+01 -0.12903395E+01 0.15127805E+02 -0.13871457E+01 -0.20587232E+01 0.14737461E+01 -0.23875883E+00 -0.29345355E+01 -0.22352363E+01 0.46345034E+01 -0.75082716E+00 -0.24000884E+01 -0.25188539E+03 0.39038658E+02 0.15584074E+02 -0.21811882E+01 0.25572042E+02 -0.41428785E+01 -0.23448311E+01 -0.34800657E+01 -0.95981471E-03 -0.10017061E-04 -0.57528325E-03 -0.60039162E-05 -0.44446802E-01 -0.67253413E-05 0.20529453E+03 0.52095283E-03 -0.81520667E-01 -0.65501878E-05 -0.49415207E-01 -0.11860249E-04 0.82470459E+00 -0.19187718E+01 -0.12098873E+01 0.22942588E+01 -0.12903395E+01 -0.13459675E+03 -0.39017438E+02 0.79557264E+01 0.13617892E+02 -0.12568843E+01 -0.22754922E+01 0.13940796E+01 -0.22585332E+00 -0.32434895E+01 -0.20451922E+01 0.38782123E+01 -0.62830496E+00 -0.21811882E+01 -0.22752218E+03 0.35257103E+02 0.13448350E+02 0.23019668E+02 -0.37293910E+01 -0.21246357E+01 -0.38464892E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.78247898E-03 -0.81663047E-05 -0.83008238E-03 -0.86631152E-05 0.27001834E+03 0.67542648E-03 -0.19974614E-01 -0.90183575E-05 -0.70525855E-01 -0.85828473E-05 -0.48509484E-01 -0.96623255E-05 0.10519100E+01 -0.14603618E+01 -0.16119602E+01 -0.17386680E+03 -0.47111932E+02 0.79679799E+01 0.11004158E+01 -0.16174652E+01 0.16653300E+02 -0.15395618E+01 -0.17328999E+01 0.17781486E+01 -0.28806540E+00 -0.24685955E+01 -0.27248575E+01 -0.29390444E+03 0.52638811E+02 0.13469073E+02 0.18601429E+01 -0.30134873E+00 -0.27341631E+01 0.28150739E+02 -0.45605041E+01 -0.26024753E+01 -0.29292939E+01 -0.78482076E-03 -0.81907446E-05 -0.83500867E-03 -0.87145283E-05 -0.86412098E-03 -0.90183575E-05 0.27003674E+03 0.68480065E-03 -0.29835450E-01 -0.90455668E-05 -0.78257894E-01 -0.88081726E-05 -0.48060852E-01 -0.96879349E-05 0.11450184E+01 -0.14601662E+01 -0.16117717E+01 -0.16174652E+01 -0.17544405E+03 -0.51350908E+02 0.96198756E+01 0.20692633E+01 -0.16173997E+01 0.17168040E+02 -0.15751537E+01 -0.17321883E+01 0.19355381E+01 -0.31356263E+00 -0.24682635E+01 -0.27245372E+01 -0.27341631E+01 -0.29657046E+03 0.45905440E+02 0.16261429E+02 0.34978806E+01 -0.56666650E+00 -0.27340508E+01 0.29020837E+02 -0.47014575E+01 -0.26626383E+01 -0.29280891E+01 -0.78940871E-03 -0.82386264E-05 -0.23028150E-02 -0.24033219E-04 -0.86672812E-03 -0.90455668E-05 0.27006740E+03 0.70053882E-03 -0.36297248E-01 -0.90947386E-05 -0.10191037E+00 -0.90508544E-05 -0.47232910E-01 -0.97375877E-05 0.12957864E+01 -0.14600938E+01 -0.16100400E+01 -0.16173997E+01 -0.17750451E+03 -0.51350998E+02 0.96521019E+01 0.19262750E+01 -0.16173879E+01 0.19220924E+02 -0.16098024E+01 -0.17316471E+01 0.21903974E+01 -0.35484929E+00 -0.24681426E+01 -0.27216116E+01 -0.27340508E+01 -0.30005362E+03 0.46469243E+02 0.16315911E+02 0.32561752E+01 -0.52750769E+00 -0.27340325E+01 0.32491049E+02 -0.52636228E+01 -0.27212100E+01 -0.29271763E+01 -0.79420309E-03 -0.82886627E-05 -0.10180047E-01 -0.10624358E-03 -0.87143967E-03 -0.90947386E-05 0.27006765E+03 0.78304509E-03 -0.16336949E-01 -0.91531613E-05 -0.11435344E+00 -0.91176109E-05 -0.46196229E-01 -0.98051430E-05 0.14523774E+01 -0.14608747E+01 -0.16019100E+01 -0.16173879E+01 -0.17848422E+03 -0.51349972E+02 0.96472855E+01 0.74175981E+00 -0.16174298E+01 0.21227252E+02 -0.16113827E+01 -0.17325699E+01 0.24550965E+01 -0.39773011E+00 -0.24694602E+01 -0.27078668E+01 -0.27340325E+01 -0.30170946E+03 0.46739878E+02 0.16307760E+02 0.12538697E+01 -0.20312916E+00 -0.27341007E+01 0.35882516E+02 -0.58130322E+01 -0.27238788E+01 -0.29287341E+01 -0.79591745E-03 -0.83065546E-05 -0.18055398E-01 -0.18843431E-03 -0.87703761E-03 -0.91531613E-05 0.27007190E+03 0.86537164E-03 -0.87636085E-03 -0.91460984E-05 -0.12596991E+00 -0.91484399E-05 -0.45679259E-01 -0.98382960E-05 0.15262413E+01 -0.14608630E+01 -0.15938227E+01 -0.16174298E+01 -0.17895839E+03 -0.51349336E+02 0.96391433E+01 -0.16173685E+01 0.22368532E+02 -0.16113755E+01 -0.17325536E+01 0.25799584E+01 -0.41795678E+00 -0.24694428E+01 -0.26941978E+01 -0.27341007E+01 -0.30251126E+03 0.46871070E+02 0.16294003E+02 -0.27339979E+01 0.37811766E+02 -0.61255577E+01 -0.27238692E+01 -0.29287086E+01 -0.79366279E-03 -0.82830240E-05 -0.10174970E-01 -0.10619059E-03 -0.18953762E-01 -0.91460984E-05 0.27007945E+03 0.78294893E-03 -0.86954137E-03 -0.90749271E-05 -0.12342382E+00 -0.91135260E-05 -0.46118381E-01 -0.97986799E-05 0.14663627E+01 -0.14609828E+01 -0.16019098E+01 0.99902844E+00 -0.16173685E+01 -0.17965018E+03 -0.51349843E+02 0.96476569E+01 -0.16171212E+01 0.22121760E+02 -0.16118470E+01 -0.17326971E+01 0.24787378E+01 -0.40156009E+00 -0.24696437E+01 -0.27078666E+01 0.16887565E+01 -0.27358167E+00 -0.27339979E+01 -0.30368046E+03 0.47059527E+02 0.16308390E+02 -0.27335816E+01 0.37394598E+02 -0.60579939E+01 -0.27246643E+01 -0.29289491E+01 -0.78813993E-03 -0.82253849E-05 -0.83256372E-03 -0.86890117E-05 -0.41060224E-01 -0.90749271E-05 0.27008865E+03 0.68481087E-03 -0.83543184E-03 -0.87189446E-05 -0.11984362E+00 -0.90443172E-05 -0.46864971E-01 -0.97207651E-05 0.13171960E+01 -0.14603466E+01 -0.16124359E+01 0.23948027E+01 -0.16171212E+01 -0.17976978E+03 -0.51350607E+02 0.96064392E+01 -0.15667697E+01 0.20995709E+02 -0.16118921E+01 -0.17321429E+01 0.22265881E+01 -0.36071267E+00 -0.24685699E+01 -0.27256617E+01 0.40481744E+01 -0.65581405E+00 -0.27335816E+01 -0.30388283E+03 0.47090596E+02 0.16238723E+02 -0.26484659E+01 0.35491147E+02 -0.57496518E+01 -0.27247424E+01 -0.29280144E+01 -0.83063190E-03 -0.86688503E-05 -0.76326343E-03 -0.79657624E-05 -0.61690204E-01 -0.87189446E-05 0.25390840E+03 0.64576394E-03 -0.77640669E-03 -0.81029315E-05 -0.11373980E+00 -0.86082212E-05 -0.47159864E-01 -0.10248069E-04 0.11837465E+01 -0.15528349E+01 -0.15005276E+01 0.30200314E+01 -0.15667697E+01 -0.16878018E+03 -0.48271778E+02 0.94839287E+01 -0.14698187E+01 0.18820856E+02 -0.15470819E+01 -0.18415082E+01 0.20010037E+01 -0.32416910E+00 -0.26249103E+01 -0.25364900E+01 0.51050579E+01 -0.82703595E+00 -0.26484659E+01 -0.28530584E+03 0.44204439E+02 0.16031624E+02 -0.24845815E+01 0.31814754E+02 -0.51540934E+01 -0.26151855E+01 -0.31128835E+01 -0.87771886E-03 -0.91602712E-05 -0.69830077E-03 -0.72877828E-05 -0.69078878E-01 -0.81029315E-05 0.23770616E+03 0.60635441E-03 -0.71017836E-03 -0.74117426E-05 -0.98724622E-01 -0.79912181E-05 -0.47971359E-01 -0.10835706E-04 0.10382496E+01 -0.16573901E+01 -0.13871457E+01 0.32285571E+01 -0.14698187E+01 -0.15688330E+03 -0.45193359E+02 0.92900489E+01 -0.13554128E+01 0.16168101E+02 -0.14497408E+01 -0.19654957E+01 0.17550571E+01 -0.28432625E+00 -0.28016522E+01 -0.23448311E+01 0.54575529E+01 -0.88414531E+00 -0.24845815E+01 -0.26519553E+03 0.41068716E+02 0.15703897E+02 -0.22911882E+01 0.27330557E+02 -0.44276594E+01 -0.24506419E+01 -0.33224740E+01 -0.95919609E-03 -0.10010604E-04 -0.62762590E-03 -0.65501878E-05 -0.47692092E-01 -0.74117426E-05 0.21604354E+03 0.54800677E-03 -0.48856002E-01 -0.71352826E-05 -0.48565204E-01 -0.11844695E-04 0.95949762E+00 -0.18263584E+01 -0.12568843E+01 0.25058817E+01 -0.13554128E+01 -0.14020691E+03 -0.41086240E+02 0.79143095E+01 0.12699265E+02 -0.13050280E+01 -0.21660390E+01 0.16219336E+01 -0.26276103E+00 -0.30872741E+01 -0.21246357E+01 0.42359396E+01 -0.68624254E+00 -0.22911882E+01 -0.23700561E+03 0.36671012E+02 0.13378339E+02 0.21466823E+02 -0.34777282E+01 -0.22060178E+01 -0.36614697E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.94909644E-03 -0.99051999E-05 0.23751600E+03 0.59348746E-03 -0.81308798E-03 -0.84857540E-05 -0.74546262E-03 -0.77799852E-05 -0.49070637E-01 -0.11738265E-04 0.96736796E+00 -0.16717298E+01 -0.14417444E+03 -0.45215223E+02 0.64070392E+01 -0.14551388E+01 0.67886956E+01 -0.12892139E+01 -0.19859020E+01 0.16352377E+01 -0.26490482E+00 -0.28258900E+01 -0.24371230E+03 0.37533536E+02 0.10830453E+02 -0.24597666E+01 0.11475603E+02 -0.18590219E+01 -0.21792857E+01 -0.33569658E+01 -0.89387850E-03 -0.93289205E-05 -0.82239126E-03 -0.85828473E-05 -0.24458134E-01 -0.84857540E-05 0.24836450E+03 0.63543396E-03 -0.24687892E-01 -0.88644260E-05 -0.79467502E-03 -0.82935881E-05 -0.48017324E-01 -0.11047996E-04 0.11078724E+01 -0.15953249E+01 -0.15395618E+01 0.48579944E+01 -0.14551388E+01 -0.16231943E+03 -0.47264376E+02 0.93809026E+01 0.11591144E+01 -0.15200077E+01 0.12566956E+02 -0.13712112E+01 -0.18943762E+01 0.18727475E+01 -0.30338303E+00 -0.26967372E+01 -0.26024753E+01 0.82119536E+01 -0.13303274E+01 -0.24597666E+01 -0.27438477E+03 0.42428957E+02 0.15857478E+02 0.19593670E+01 -0.31741530E+00 -0.25694210E+01 0.21243182E+02 -0.34413720E+01 -0.23178955E+01 -0.32022536E+01 -0.85917158E-03 -0.89667033E-05 -0.84398148E-03 -0.88081726E-05 -0.84937157E-03 -0.88644260E-05 0.25919759E+03 0.66122729E-03 -0.50848390E-01 -0.92733182E-05 -0.38161872E-01 -0.86210888E-05 -0.46123540E-01 -0.10607112E-04 0.13706750E+01 -0.15271880E+01 -0.15751537E+01 -0.15200077E+01 -0.17047620E+03 -0.49318400E+02 0.94987930E+01 0.36763866E+01 -0.15847634E+01 0.16599150E+02 -0.14735359E+01 -0.18126331E+01 0.23169875E+01 -0.37534895E+00 -0.25815568E+01 -0.26626383E+01 -0.25694210E+01 -0.28817279E+03 0.44577014E+02 0.16056750E+02 0.62145599E+01 -0.10067506E+01 -0.26788823E+01 0.28059187E+02 -0.45455510E+01 -0.24908634E+01 -0.30640727E+01 -0.83206675E-03 -0.86838251E-05 -0.86723476E-03 -0.90508544E-05 -0.88855081E-03 -0.92733182E-05 0.27004009E+03 0.68734928E-03 -0.48725905E-01 -0.95533495E-05 -0.91979919E-01 -0.91876557E-05 -0.43192237E-01 -0.10255506E-04 0.17787051E+01 -0.14635822E+01 -0.16098024E+01 -0.15847634E+01 -0.18161181E+03 -0.51373691E+02 0.95744591E+01 0.39218115E+01 -0.16178102E+01 0.20880731E+02 -0.15561203E+01 -0.17366396E+01 0.30067231E+01 -0.48708231E+00 -0.24740393E+01 -0.27212100E+01 -0.26788823E+01 -0.30699661E+03 0.47537372E+02 0.16184664E+02 0.66294301E+01 -0.10739526E+01 -0.27347463E+01 0.35296787E+02 -0.57179994E+01 -0.26304658E+01 -0.29356156E+01 -0.83935795E-03 -0.87599193E-05 -0.87363124E-03 -0.91176109E-05 -0.91538284E-03 -0.95533495E-05 0.27008309E+03 0.68833418E-03 -0.28041727E-01 -0.96454470E-05 -0.16072546E+00 -0.95827761E-05 -0.39367327E-01 -0.10326069E-04 0.23223633E+01 -0.14603090E+01 -0.16113827E+01 -0.16178102E+01 -0.18423016E+03 -0.51374787E+02 0.96524961E+01 0.18876594E+01 -0.16178115E+01 0.24991137E+02 -0.16075376E+01 -0.17319037E+01 0.39257207E+01 -0.63595464E+00 -0.24685050E+01 -0.27238788E+01 -0.27347463E+01 -0.31142250E+03 0.48251452E+02 0.16316571E+02 0.31908977E+01 -0.51691558E+00 -0.27347471E+01 0.42244995E+02 -0.68435583E+01 -0.27173801E+01 -0.29276085E+01 -0.84416373E-03 -0.88100746E-05 -0.87658522E-03 -0.91484399E-05 -0.92420744E-03 -0.96454470E-05 0.27007521E+03 0.68862876E-03 -0.92584909E-03 -0.96625799E-05 -0.18218975E+00 -0.96351775E-05 -0.37136019E-01 -0.10375283E-04 0.26636120E+01 -0.14603067E+01 -0.16113755E+01 -0.16178115E+01 -0.18480023E+03 -0.51374772E+02 0.96536146E+01 -0.16178126E+01 0.27107692E+02 -0.16086679E+01 -0.17318990E+01 0.45025698E+01 -0.72939997E+00 -0.24685025E+01 -0.27238692E+01 -0.27347471E+01 -0.31238630E+03 0.48407342E+02 0.16318467E+02 -0.27347488E+01 0.45822842E+02 -0.74231342E+01 -0.27192922E+01 -0.29276020E+01 -0.84070669E-03 -0.87739954E-05 -0.87323983E-03 -0.91135260E-05 -0.21590804E-01 -0.96625799E-05 0.27009410E+03 0.68843280E-03 -0.91766119E-03 -0.95771274E-05 -0.17948756E+00 -0.96173852E-05 -0.38450156E-01 -0.10338482E-04 0.24505236E+01 -0.14594767E+01 -0.16118470E+01 0.12533309E+01 -0.16178126E+01 -0.18481019E+03 -0.51375126E+02 0.96540106E+01 -0.16177334E+01 0.26077818E+02 -0.16104834E+01 -0.17309160E+01 0.41423626E+01 -0.67104929E+00 -0.24670980E+01 -0.27246643E+01 0.21186294E+01 -0.34321107E+00 -0.27347488E+01 -0.31240296E+03 0.48409390E+02 0.16319131E+02 -0.27346166E+01 0.44081918E+02 -0.71411270E+01 -0.27223596E+01 -0.29259386E+01 -0.83289178E-03 -0.86924355E-05 -0.86660839E-03 -0.90443172E-05 -0.44701745E-01 -0.95771274E-05 0.27008965E+03 0.68782746E-03 -0.89809299E-03 -0.93729048E-05 -0.14792916E+00 -0.95404218E-05 -0.41432319E-01 -0.10254566E-04 0.20051029E+01 -0.14604292E+01 -0.16118921E+01 0.35260769E+01 -0.16177334E+01 -0.18431844E+03 -0.51374246E+02 0.96407722E+01 -0.16011305E+01 0.23757471E+02 -0.16117570E+01 -0.17320887E+01 0.33894259E+01 -0.54907849E+00 -0.24687096E+01 -0.27247424E+01 0.59604802E+01 -0.96558282E+00 -0.27346166E+01 -0.31157189E+03 0.48277121E+02 0.16296759E+02 -0.27065491E+01 0.40159629E+02 -0.65057592E+01 -0.27245140E+01 -0.29279228E+01 -0.84007217E-03 -0.87673732E-05 -0.82482254E-03 -0.86082212E-05 -0.64392667E-01 -0.93729048E-05 0.26468463E+03 0.67401653E-03 -0.84943775E-03 -0.88651167E-05 -0.11755223E+00 -0.93363636E-05 -0.44120055E-01 -0.10353917E-04 0.16041890E+01 -0.14913157E+01 -0.15470819E+01 0.44628450E+01 -0.16011305E+01 -0.17920248E+03 -0.50346702E+02 0.95433280E+01 -0.15344165E+01 0.21205997E+02 -0.15951116E+01 -0.17686457E+01 0.27117191E+01 -0.43929488E+00 -0.25209182E+01 -0.26151855E+01 0.75439876E+01 -0.12221159E+01 -0.27065491E+01 -0.30292365E+03 0.46920720E+02 0.16132032E+02 -0.25937775E+01 0.35846591E+02 -0.58070999E+01 -0.26963746E+01 -0.29897163E+01 -0.88398968E-03 -0.92257162E-05 -0.76570254E-03 -0.79912181E-05 -0.80443630E-01 -0.88651167E-05 0.24846584E+03 0.63445574E-03 -0.76536868E-03 -0.79877338E-05 -0.72952815E-01 -0.86533326E-05 -0.46164921E-01 -0.10907693E-04 0.13215054E+01 -0.15915783E+01 -0.14497408E+01 0.49241295E+01 -0.15344165E+01 -0.16654788E+03 -0.47265374E+02 0.93684860E+01 -0.14015808E+01 0.17675979E+02 -0.14979855E+01 -0.18879020E+01 0.22338727E+01 -0.36188685E+00 -0.26904039E+01 -0.24506419E+01 0.83237484E+01 -0.13484453E+01 -0.25937775E+01 -0.28153254E+03 0.43584773E+02 0.15836487E+02 -0.23692308E+01 0.29879475E+02 -0.48404679E+01 -0.25321947E+01 -0.31913095E+01 -0.97629545E-03 -0.10189061E-04 -0.68368851E-03 -0.71352826E-05 -0.92297563E-01 -0.79877338E-05 0.22143450E+03 0.56275922E-03 -0.17879426E-01 -0.77108176E-05 -0.47265566E-01 -0.12053366E-04 0.11575908E+01 -0.17831636E+01 -0.13050280E+01 0.45828135E+01 -0.14015808E+01 -0.14260298E+03 -0.42130994E+02 0.79625911E+01 0.97432456E+01 -0.13531654E+01 -0.21149439E+01 0.19567904E+01 -0.31700217E+00 -0.30142581E+01 -0.22060178E+01 0.77467837E+01 -0.12549874E+01 -0.23692308E+01 -0.24105594E+03 0.37240289E+02 0.13459956E+02 0.16469973E+02 -0.26681535E+01 -0.22873895E+01 -0.35750987E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.11469225E-02 -0.11969802E-04 -0.71538059E-01 -0.77799852E-05 0.19983026E+03 0.51535618E-03 -0.43887336E-01 -0.75037232E-05 -0.64507151E-03 -0.67322581E-05 -0.48488816E-01 -0.14188647E-04 0.10287243E+01 -0.19802948E+01 -0.12892139E+01 -0.12404451E+03 -0.38042021E+02 0.79546088E+01 0.69714899E+00 -0.12435723E+01 0.76305992E+01 -0.10858122E+01 -0.23514563E+01 0.17389544E+01 -0.28170320E+00 -0.33474880E+01 -0.21792857E+01 -0.20968470E+03 0.32281529E+02 0.13446461E+02 0.11784598E+01 -0.19090548E+00 -0.21021332E+01 0.12898756E+02 -0.20895436E+01 -0.18354556E+01 -0.39748983E+01 -0.10671973E-02 -0.11137754E-04 -0.62085766E-02 -0.82935881E-05 -0.71899175E-03 -0.75037232E-05 0.21597555E+03 0.56090580E-03 -0.61745967E-01 -0.81998813E-05 -0.71997856E-03 -0.75140220E-05 -0.46791177E-01 -0.13190472E-04 0.12852983E+01 -0.18368744E+01 -0.13712112E+01 -0.12435723E+01 -0.14018058E+03 -0.41122058E+02 0.91927650E+01 0.38809383E+01 -0.13559021E+01 0.11021295E+02 -0.11995306E+01 -0.21810716E+01 0.21726682E+01 -0.35196233E+00 -0.31050525E+01 -0.23178955E+01 -0.21021332E+01 -0.23696125E+03 0.36574131E+02 0.15539449E+02 0.65603381E+01 -0.10627448E+01 -0.22920168E+01 0.18630397E+02 -0.30180392E+01 -0.20276865E+01 -0.36868835E+01 -0.98095071E-03 -0.10237645E-04 -0.82605548E-03 -0.86210888E-05 -0.78569623E-03 -0.81998813E-05 0.23762407E+03 0.61174842E-03 -0.96016617E-01 -0.89917060E-05 -0.38034348E-01 -0.80120757E-05 -0.42697007E-01 -0.12107049E-04 0.18502484E+01 -0.16671745E+01 -0.14735359E+01 -0.13559021E+01 -0.16037733E+03 -0.45233550E+02 0.92621788E+01 0.65768912E+01 -0.14703690E+01 0.15556959E+02 -0.13103950E+01 -0.19797396E+01 0.31276573E+01 -0.50666325E+00 -0.28181894E+01 -0.24908634E+01 -0.22920168E+01 -0.27110161E+03 0.41924961E+02 0.15656777E+02 0.11117568E+02 -0.18009847E+01 -0.24855097E+01 0.26297461E+02 -0.42600436E+01 -0.22150898E+01 -0.33465496E+01 -0.93784308E-03 -0.97877547E-05 -0.88034279E-03 -0.91876557E-05 -0.86156728E-03 -0.89917060E-05 0.25387027E+03 0.65172112E-03 -0.11131295E+00 -0.97550158E-05 -0.86572045E-01 -0.89907933E-05 -0.35557201E-01 -0.11539199E-04 0.28964717E+01 -0.15621511E+01 -0.15561203E+01 -0.14703690E+01 -0.17753410E+03 -0.48317530E+02 0.94613899E+01 0.71354518E+01 -0.15677348E+01 0.21809515E+02 -0.14451929E+01 -0.18544138E+01 0.48961958E+01 -0.79314774E+00 -0.26406602E+01 -0.26304658E+01 -0.24855097E+01 -0.30010364E+03 0.46486840E+02 0.15993531E+02 0.12061768E+02 -0.19539178E+01 -0.26500988E+01 0.36866804E+02 -0.59721515E+01 -0.24429541E+01 -0.31347010E+01 -0.90089319E-03 -0.94021289E-05 -0.91820244E-03 -0.95827761E-05 -0.93470610E-03 -0.97550158E-05 0.27005098E+03 0.69134172E-03 -0.49570185E-01 -0.10246668E-04 -0.14764679E+00 -0.99586297E-05 -0.26542630E-01 -0.11035480E-04 0.42818111E+01 -0.14688418E+01 -0.16075376E+01 -0.15677348E+01 -0.19255353E+03 -0.51400549E+02 0.95838566E+01 0.39993039E+01 -0.16182239E+01 0.29278995E+02 -0.15730491E+01 -0.17427167E+01 0.72379693E+01 -0.11724858E+01 -0.24829287E+01 -0.27173801E+01 -0.26500988E+01 -0.32549230E+03 0.50465801E+02 0.16200543E+02 0.67604194E+01 -0.10951270E+01 -0.27354441E+01 0.49493185E+02 -0.80174499E+01 -0.26590806E+01 -0.29458861E+01 -0.91065197E-03 -0.95039760E-05 -0.92322343E-03 -0.96351775E-05 -0.98181522E-03 -0.10246668E-04 0.27005242E+03 0.69243691E-03 -0.98558489E-03 -0.10286010E-04 -0.20590679E+00 -0.10280249E-04 -0.19502765E-01 -0.11119317E-04 0.54598407E+01 -0.14671910E+01 -0.16086679E+01 -0.16182239E+01 -0.19454466E+03 -0.51401676E+02 0.96671848E+01 -0.16181589E+01 0.34093072E+02 -0.16091451E+01 -0.17400448E+01 0.92293147E+01 -0.14950565E+01 -0.24801396E+01 -0.27192922E+01 -0.27354441E+01 -0.32885829E+03 0.51007865E+02 0.16341406E+02 -0.27353340E+01 0.57630928E+02 -0.93356331E+01 -0.27200988E+01 -0.29413717E+01 -0.90248425E-03 -0.94187340E-05 -0.92151861E-03 -0.96173852E-05 -0.24568362E-01 -0.10286010E-04 0.27006275E+03 0.69209336E-03 -0.97191607E-03 -0.10143356E-04 -0.18675828E+00 -0.10220960E-04 -0.24154394E-01 -0.11043669E-04 0.46256579E+01 -0.14648449E+01 -0.16104834E+01 0.23189631E+01 -0.16181589E+01 -0.19259145E+03 -0.51400420E+02 0.96626938E+01 -0.16179695E+01 0.30653316E+02 -0.16082163E+01 -0.17372681E+01 0.78192072E+01 -0.12666381E+01 -0.24761723E+01 -0.27223596E+01 0.39199728E+01 -0.63499882E+00 -0.27353340E+01 -0.32555639E+03 0.50476322E+02 0.16333809E+02 -0.27350156E+01 0.51816332E+02 -0.83937590E+01 -0.27185272E+01 -0.29366758E+01 -0.88562662E-03 -0.92428001E-05 -0.91414414E-03 -0.95404218E-05 -0.76561930E-01 -0.10143356E-04 0.27010278E+03 0.69121367E-03 -0.95611433E-03 -0.99784417E-05 -0.16525313E+00 -0.10082749E-04 -0.32290073E-01 -0.10869548E-04 0.33381173E+01 -0.14618491E+01 -0.16117570E+01 0.58761202E+01 -0.16179695E+01 -0.19042826E+03 -0.51399319E+02 0.96569757E+01 -0.16173807E+01 0.26218808E+02 -0.16085433E+01 -0.17337240E+01 0.56427535E+01 -0.91408041E+00 -0.24711096E+01 -0.27245140E+01 0.99329935E+01 -0.16090646E+01 -0.27350156E+01 -0.32189992E+03 0.49887176E+02 0.16324150E+02 -0.27340189E+01 0.44320273E+02 -0.71795256E+01 -0.27190816E+01 -0.29306871E+01 -0.86975225E-03 -0.90771279E-05 -0.89459169E-03 -0.93363636E-05 -0.94315298E-01 -0.99784417E-05 0.27010058E+03 0.68985677E-03 -0.90942543E-03 -0.94911753E-05 -0.13796283E+00 -0.99224252E-05 -0.38943053E-01 -0.10703731E-04 0.23525033E+01 -0.14625507E+01 -0.15951116E+01 0.68457526E+01 -0.16173807E+01 -0.18773039E+03 -0.51398707E+02 0.95914529E+01 -0.15672576E+01 0.23535825E+02 -0.16085332E+01 -0.17348672E+01 0.39766696E+01 -0.64419486E+00 -0.24722944E+01 -0.26963746E+01 0.11572054E+02 -0.18745984E+01 -0.27340189E+01 -0.31733928E+03 0.49150588E+02 0.16213383E+02 -0.26492923E+01 0.39784937E+02 -0.64449045E+01 -0.27190631E+01 -0.29326171E+01 -0.90582650E-03 -0.94536151E-05 -0.82914502E-03 -0.86533326E-05 -0.12133851E+00 -0.94911753E-05 0.25395488E+03 0.64999981E-03 -0.81695519E-03 -0.85261140E-05 -0.15291237E+00 -0.92566637E-05 -0.42703690E-01 -0.11163654E-04 0.18001589E+01 -0.15542434E+01 -0.14979855E+01 0.73708350E+01 -0.15672576E+01 -0.17841532E+03 -0.48316631E+02 0.94500405E+01 -0.14529925E+01 0.23550095E+02 -0.15287703E+01 -0.18433836E+01 0.30429885E+01 -0.49294985E+00 -0.26272931E+01 -0.25321947E+01 0.12459659E+02 -0.20184063E+01 -0.26492923E+01 -0.30159326E+03 0.46731329E+02 0.15974347E+02 -0.24561369E+01 0.39809080E+02 -0.64488840E+01 -0.25842333E+01 -0.31160556E+01 -0.95879409E-03 -0.10006409E-04 -0.73883512E-03 -0.77108176E-05 -0.14722774E+00 -0.85261140E-05 0.23224678E+03 0.58100696E-03 -0.45977340E-01 -0.11828495E-04 0.13378595E+01 -0.16997381E+01 -0.13531654E+01 0.11432940E+02 -0.14529925E+01 -0.14606883E+03 -0.44202421E+02 0.65265189E+01 -0.20156766E+01 0.22615161E+01 -0.36636200E+00 -0.28732354E+01 -0.22873895E+01 0.19326230E+02 -0.31308183E+01 -0.24561369E+01 -0.24691459E+03 0.38060785E+02 0.11032421E+02 -0.34072979E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.14028493E-02 -0.14640770E-04 -0.12626206E-01 -0.67322581E-05 0.16737565E+03 0.44266306E-03 -0.41726548E-01 -0.65970170E-05 -0.56705978E-03 -0.59180924E-05 -0.48243544E-01 -0.17355340E-04 0.10597904E+01 -0.23587909E+01 -0.10858122E+01 -0.10603673E+03 -0.31887467E+02 0.82435414E+01 0.28951741E+01 -0.10641238E+01 0.60116601E+01 -0.93182338E+00 -0.27994161E+01 0.17914685E+01 -0.29020548E+00 -0.39872974E+01 -0.18354556E+01 -0.17924437E+03 0.27588098E+02 0.13934873E+02 0.48939990E+01 -0.79279391E+00 -0.17987936E+01 0.10162103E+02 -0.16461903E+01 -0.15751531E+01 -0.47321305E+01 -0.12576456E-02 -0.13125358E-04 -0.92589174E-02 -0.75140220E-05 -0.63211298E-03 -0.65970170E-05 0.18902105E+03 0.49862145E-03 -0.95628774E-01 -0.73856317E-05 -0.14988432E-01 -0.65290539E-05 -0.44944929E-01 -0.15540863E-04 0.15156651E+01 -0.20902235E+01 -0.11995306E+01 -0.10641238E+01 -0.12523525E+03 -0.36002030E+02 0.90609038E+01 0.65392851E+01 -0.11792028E+01 0.87142602E+01 -0.10425703E+01 -0.24812165E+01 0.25620804E+01 -0.41503644E+00 -0.35333138E+01 -0.20276865E+01 -0.17987936E+01 -0.21169766E+03 0.32657959E+02 0.15316551E+02 0.11054008E+02 -0.17906604E+01 -0.19933245E+01 0.14730585E+02 -0.23862365E+01 -0.17623608E+01 -0.41942484E+01 -0.11872176E-02 -0.12390340E-04 -0.76770106E-03 -0.80120757E-05 -0.70767646E-03 -0.73856317E-05 0.20524886E+03 0.53797809E-03 -0.12557096E+00 -0.83489597E-05 -0.42672522E-01 -0.73950702E-05 -0.36136438E-01 -0.14627561E-04 0.27846523E+01 -0.19272396E+01 -0.13103950E+01 -0.11792028E+01 -0.14376079E+03 -0.39087761E+02 0.91712597E+01 0.10042669E+02 -0.13057448E+01 0.13170317E+02 -0.11567119E+01 -0.22875832E+01 0.47071732E+01 -0.76251491E+00 -0.32578037E+01 -0.22150898E+01 -0.19933245E+01 -0.24301308E+03 0.37590468E+02 0.15503089E+02 0.16976116E+02 -0.27499606E+01 -0.22072296E+01 0.22263089E+02 -0.36063975E+01 -0.19553045E+01 -0.38669288E+01 -0.10819594E-02 -0.11291817E-04 -0.86147983E-03 -0.89907933E-05 -0.79998062E-03 -0.83489597E-05 0.23233074E+03 0.60306568E-03 -0.15408543E+00 -0.96579554E-05 -0.13601395E+00 -0.85524443E-05 -0.19913327E-01 -0.13258716E-04 0.51966535E+01 -0.16980784E+01 -0.14451929E+01 -0.13057448E+01 -0.17083276E+03 -0.44233502E+02 0.92379422E+01 0.11851465E+02 -0.14681910E+01 0.20530332E+02 -0.13003019E+01 -0.20154729E+01 0.87844231E+01 -0.14229619E+01 -0.28704318E+01 -0.24429541E+01 -0.22072296E+01 -0.28877570E+03 0.44762455E+02 0.15615816E+02 0.20033716E+02 -0.32452005E+01 -0.24818300E+01 0.34704472E+02 -0.56216716E+01 -0.21980304E+01 -0.34069554E+01 -0.26456252E-01 -0.10330459E-04 -0.95421598E-03 -0.99586297E-05 -0.92540597E-03 -0.96579554E-05 0.25933862E+03 0.66893971E-03 -0.10266790E+00 -0.10736130E-04 -0.21242437E+00 -0.10013213E-04 -0.11620610E-02 -0.12127795E-04 0.90270468E+01 -0.15257493E+01 -0.15730491E+01 -0.14681910E+01 -0.19814194E+03 -0.49379196E+02 0.94479177E+01 0.79992192E+01 -0.15855539E+01 0.32370162E+02 -0.14790745E+01 -0.18107620E+01 0.15259307E+02 -0.24717635E+01 -0.25791245E+01 -0.26590806E+01 -0.24818300E+01 -0.33493888E+03 0.51999266E+02 0.15970750E+02 0.13521870E+02 -0.21903262E+01 -0.26802181E+01 0.54718480E+02 -0.88635174E+01 -0.25002256E+01 -0.30609100E+01 -0.67715004E-01 -0.10068303E-04 -0.98503287E-03 -0.10280249E-04 -0.10287145E-02 -0.10736130E-04 0.27021955E+03 0.69634780E-03 -0.10557024E-02 -0.11017788E-04 -0.36415174E+00 -0.11100880E-04 -0.11272357E-02 -0.11764342E-04 0.13074018E+02 -0.14613155E+01 -0.16091451E+01 -0.15855539E+01 -0.21305004E+03 -0.51438365E+02 0.96248333E+01 -0.16186598E+01 0.45035434E+02 -0.16113632E+01 -0.17330264E+01 0.22100320E+02 -0.35798534E+01 -0.24702077E+01 -0.27200988E+01 -0.26802181E+01 -0.36013979E+03 0.55982322E+02 0.16269814E+02 -0.27361804E+01 0.76127896E+02 -0.12331347E+02 -0.27238483E+01 -0.29295078E+01 -0.31451497E-01 -0.99726638E-05 -0.97935191E-03 -0.10220960E-04 -0.43788619E-01 -0.11017788E-04 0.27009141E+03 0.69600893E-03 -0.10320963E-02 -0.10771424E-04 -0.22408230E+00 -0.10960101E-04 -0.11200582E-02 -0.11689435E-04 0.95237157E+01 -0.14651993E+01 -0.16082163E+01 0.57618926E+01 -0.16186598E+01 -0.20458147E+03 -0.51433248E+02 0.96644380E+01 -0.16184823E+01 0.34348042E+02 -0.16104571E+01 -0.17376559E+01 0.16098875E+02 -0.26077513E+01 -0.24767708E+01 -0.27185272E+01 0.97398956E+01 -0.15777018E+01 -0.27361804E+01 -0.34582425E+03 0.53676628E+02 0.16336756E+02 -0.27358825E+01 0.58061886E+02 -0.94050628E+01 -0.27223145E+01 -0.29373322E+01 -0.94927803E-03 -0.99070950E-05 -0.96610888E-03 -0.10082749E-04 -0.98287232E-01 -0.10771424E-04 0.27003821E+03 0.69496775E-03 -0.10100503E-02 -0.10541342E-04 -0.12446857E+00 -0.10709992E-04 -0.16260742E-01 -0.11586719E-04 0.58398884E+01 -0.14678694E+01 -0.16085433E+01 0.10345519E+02 -0.16184823E+01 -0.19723158E+03 -0.51426699E+02 0.96690332E+01 -0.16180395E+01 0.26089067E+02 -0.16094869E+01 -0.17408475E+01 0.98717472E+01 -0.15990822E+01 -0.24812864E+01 -0.27190816E+01 0.17488065E+02 -0.28328170E+01 -0.27358825E+01 -0.33340025E+03 0.51680985E+02 0.16344532E+02 -0.27351320E+01 0.44100959E+02 -0.71437259E+01 -0.27206767E+01 -0.29427286E+01 -0.92465410E-03 -0.96501086E-05 -0.95074694E-03 -0.99224252E-05 -0.12181232E+00 -0.10541342E-04 0.27003369E+03 0.69347917E-03 -0.97504882E-03 -0.10176051E-04 -0.79817295E-01 -0.10486731E-04 -0.30551219E-01 -0.11345441E-04 0.36187819E+01 -0.14681648E+01 -0.16085332E+01 0.95462132E+01 -0.16180395E+01 -0.18982629E+03 -0.51424648E+02 0.96365862E+01 -0.15848009E+01 0.21701004E+02 -0.16099108E+01 -0.17413736E+01 0.61171845E+01 -0.99091094E+00 -0.24817839E+01 -0.27190631E+01 0.16136907E+02 -0.26139865E+01 -0.27351320E+01 -0.32088212E+03 0.49659240E+02 0.16289676E+02 -0.26789474E+01 0.36683350E+02 -0.59422651E+01 -0.27213913E+01 -0.29436164E+01 -0.94686439E-03 -0.98819052E-05 -0.88695501E-03 -0.92566637E-05 -0.10010991E+00 -0.10176051E-04 0.25920303E+03 0.65708136E-03 -0.58725439E-01 -0.10028607E-04 -0.36772028E-01 -0.11644704E-04 0.26940643E+01 -0.15292250E+01 -0.15287703E+01 0.62274337E+01 -0.15848009E+01 -0.17666489E+03 -0.49368903E+02 0.80239023E+01 0.18983067E+02 -0.15621015E+01 -0.18134713E+01 0.45540463E+01 -0.73770750E+00 -0.25850020E+01 -0.25842333E+01 0.10526854E+02 -0.17052394E+01 -0.26789474E+01 -0.29863434E+03 0.46145579E+02 0.13563604E+02 0.32088976E+02 -0.51980760E+01 -0.26405763E+01 -0.30654918E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.16444165E-02 -0.17161875E-04 -0.43774437E-02 -0.59180924E-05 0.14578467E+03 0.39539125E-03 -0.52525336E-01 -0.58435869E-05 -0.16373276E-02 -0.52194194E-05 -0.48402572E-01 -0.20336349E-04 0.10288629E+01 -0.26992882E+01 -0.93182338E+00 -0.91799685E+02 -0.27783778E+02 0.85786460E+01 0.42579789E+01 -0.92019439E+00 0.28539434E+01 -0.82194276E+00 -0.32022787E+01 0.17391889E+01 -0.28173234E+00 -0.45628743E+01 -0.15751531E+01 -0.15517811E+03 0.23849486E+02 0.14501334E+02 0.71976838E+01 -0.11659574E+01 -0.15554957E+01 0.48243035E+01 -0.78149195E+00 -0.13894113E+01 -0.54131281E+01 -0.15090144E-02 -0.15748757E-04 -0.62560088E-03 -0.65290539E-05 -0.55992081E-03 -0.58435869E-05 0.16202622E+03 0.43815254E-03 -0.10683496E+00 -0.66625540E-05 -0.12933066E-01 -0.59343868E-05 -0.42824486E-01 -0.18637995E-04 0.18112808E+01 -0.24314260E+01 -0.10425703E+01 -0.92019439E+00 -0.10877024E+03 -0.30872090E+02 0.92324532E+01 0.88405414E+01 -0.10313028E+01 0.51659370E+01 -0.91863870E+00 -0.28848554E+01 0.30617890E+01 -0.49597554E+00 -0.41100826E+01 -0.17623608E+01 -0.15554957E+01 -0.18386522E+03 0.28349994E+02 0.15606538E+02 0.14944051E+02 -0.24207689E+01 -0.17433142E+01 0.87324999E+01 -0.14145672E+01 -0.15528669E+01 -0.48765596E+01 -0.13821334E-02 -0.14424569E-04 -0.70858084E-03 -0.73950702E-05 -0.63839260E-03 -0.66625540E-05 0.18368970E+03 0.48940519E-03 -0.19026575E+00 -0.77383422E-05 -0.30179617E-01 -0.68637821E-05 -0.27383811E-01 -0.17008204E-04 0.40665688E+01 -0.21501943E+01 -0.11567119E+01 -0.10313028E+01 -0.13193041E+03 -0.34991172E+02 0.90855690E+01 0.14042325E+02 -0.11612148E+01 0.84795271E+01 -0.10300719E+01 -0.25521445E+01 0.68741223E+01 -0.11135093E+01 -0.36346854E+01 -0.19553045E+01 -0.17433142E+01 -0.22301501E+03 0.34492949E+02 0.15358235E+02 0.23737128E+02 -0.38450744E+01 -0.19629160E+01 0.14333783E+02 -0.23218674E+01 -0.17412321E+01 -0.43141417E+01 -0.33803668E-01 -0.13399561E-04 -0.81947810E-03 -0.85524443E-05 -0.74147247E-03 -0.77383422E-05 0.20530217E+03 0.54275019E-03 -0.19002003E+00 -0.91776761E-05 -0.57100965E-01 -0.82919913E-05 -0.15092283E-02 -0.15750990E-04 0.97233247E+01 -0.19272400E+01 -0.13003019E+01 -0.11612148E+01 -0.16066937E+03 -0.39109356E+02 0.91921782E+01 0.18701559E+02 -0.13200215E+01 0.14512037E+02 -0.11927259E+01 -0.22862821E+01 0.16436308E+02 -0.26623687E+01 -0.32578065E+01 -0.21980304E+01 -0.19629160E+01 -0.27159550E+03 0.42164769E+02 0.15538456E+02 0.31613115E+02 -0.51207224E+01 -0.22313643E+01 0.24531147E+02 -0.39735786E+01 -0.20161839E+01 -0.38647313E+01 -0.14724815E+00 -0.12115562E-04 -0.95944604E-03 -0.10013213E-04 -0.87938657E-03 -0.91776761E-05 0.23794610E+03 0.62205494E-03 -0.22289853E+00 -0.11041321E-04 -0.19544122E+00 -0.99884456E-05 -0.13508199E-02 -0.14097767E-04 0.20895887E+02 -0.16625969E+01 -0.14790745E+01 -0.13200215E+01 -0.20170899E+03 -0.45295405E+02 0.93258634E+01 0.16827796E+02 -0.15150411E+01 0.27679249E+02 -0.13707856E+01 -0.19732535E+01 0.35322382E+02 -0.57213681E+01 -0.28104518E+01 -0.25002256E+01 -0.22313643E+01 -0.34096864E+03 0.53084456E+02 0.15764430E+02 0.28445687E+02 -0.46075103E+01 -0.25610236E+01 0.46788972E+02 -0.75786762E+01 -0.23171744E+01 -0.33355854E+01 -0.31161847E+00 -0.11064451E-04 -0.10636641E-02 -0.11100880E-04 -0.10579573E-02 -0.11041321E-04 0.27055967E+03 0.70111889E-03 -0.11344195E-02 -0.11839315E-04 -0.49982639E+00 -0.11934851E-04 -0.12195763E-02 -0.12728050E-04 0.37096615E+02 -0.14650651E+01 -0.16113632E+01 -0.15150411E+01 -0.25296939E+03 -0.51474670E+02 0.95348012E+01 -0.16191856E+01 0.60983824E+02 -0.15804774E+01 -0.17378832E+01 0.62708117E+02 -0.10156920E+02 -0.24765460E+01 -0.27238483E+01 -0.25610236E+01 -0.42761945E+03 0.66818708E+02 0.16117624E+02 -0.27370696E+01 0.10308706E+03 -0.16697151E+02 -0.26716390E+01 -0.29377177E+01 -0.13855821E+00 -0.10693079E-04 -0.10501750E-02 -0.10960101E-04 -0.18446945E+00 -0.11839315E-04 0.27028462E+03 0.70049918E-03 -0.10916982E-02 -0.11393456E-04 -0.20698907E+00 -0.11803048E-04 -0.11897661E-02 -0.12416937E-04 0.20050906E+02 -0.14625411E+01 -0.16104571E+01 0.16483139E+02 -0.16191856E+01 -0.22180181E+03 -0.51467914E+02 0.96658244E+01 -0.16189908E+01 0.30368874E+02 -0.16144318E+01 -0.17344354E+01 0.33894031E+02 -0.54899961E+01 -0.24722779E+01 -0.27223145E+01 0.27863080E+02 -0.45131313E+01 -0.27370696E+01 -0.37493354E+03 0.58303482E+02 0.16339100E+02 -0.27367420E+01 0.51335512E+02 -0.83150859E+01 -0.27290339E+01 -0.29318876E+01 -0.34524809E-01 -0.10286721E-04 -0.10262100E-02 -0.10709992E-04 -0.19838020E+00 -0.11393456E-04 0.27011203E+03 0.69824186E-03 -0.10595532E-02 -0.11057976E-04 -0.11455620E+00 -0.11360162E-04 -0.11553500E-02 -0.12057755E-04 0.98107963E+01 -0.14617749E+01 -0.16094869E+01 0.18634428E+02 -0.16189908E+01 -0.20385159E+03 -0.51459003E+02 0.96625734E+01 -0.16185609E+01 0.20494516E+02 -0.16143877E+01 -0.17335935E+01 0.16584170E+02 -0.26862973E+01 -0.24709843E+01 -0.27206767E+01 0.31499637E+02 -0.51022988E+01 -0.27367420E+01 -0.34459073E+03 0.53412258E+02 0.16333612E+02 -0.27360136E+01 0.34643930E+02 -0.56116100E+01 -0.27289610E+01 -0.29304664E+01 -0.96823731E-03 -0.10104963E-04 -0.10048176E-02 -0.10486731E-04 -0.16675602E+00 -0.11057976E-04 0.27004389E+03 0.69663137E-03 -0.10295369E-02 -0.10744713E-04 -0.87898661E-01 -0.11036116E-04 -0.19894113E-01 -0.11840431E-04 0.52180375E+01 -0.14611605E+01 -0.16099108E+01 0.13966226E+02 -0.16185609E+01 -0.19120414E+03 -0.51454603E+02 0.96458946E+01 -0.16020081E+01 0.17101421E+02 -0.16155050E+01 -0.17329727E+01 0.88205643E+01 -0.14287813E+01 -0.24699439E+01 -0.27213913E+01 0.23608493E+02 -0.38241739E+01 -0.27360136E+01 -0.32321126E+03 0.49961416E+02 0.16305411E+02 -0.27080345E+01 0.28908223E+02 -0.46826404E+01 -0.27308478E+01 -0.29294150E+01 -0.96550868E-03 -0.10076485E-04 -0.96092110E-03 -0.10028607E-04 -0.12038901E+00 -0.10744713E-04 0.26457226E+03 0.67214879E-03 -0.47733116E-01 -0.10724002E-04 -0.30770786E-01 -0.11852882E-04 0.35314347E+01 -0.14901284E+01 -0.15621015E+01 0.84202293E+01 -0.16020081E+01 -0.17582806E+03 -0.50425341E+02 0.80261255E+01 0.12055848E+02 -0.15990651E+01 -0.17671616E+01 0.59695372E+01 -0.96697473E+00 -0.25189130E+01 -0.26405763E+01 0.14233556E+02 -0.23056207E+01 -0.27080345E+01 -0.29721975E+03 0.45800144E+02 0.13567363E+02 0.20379205E+02 -0.33011229E+01 -0.27030597E+01 -0.29872100E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.22242274E-02 -0.23213044E-04 0.10797413E+03 0.31185895E-03 -0.13479570E-01 -0.45005320E-05 -0.39297606E-03 -0.41012760E-05 -0.52332926E-01 -0.27518009E-04 0.53852628E+00 -0.36425216E+01 -0.64387337E+02 -0.18888764E+02 0.93186480E+01 0.18825568E+01 -0.70652571E+00 -0.64747945E+00 -0.43198103E+01 0.91032483E+00 -0.14746373E+00 -0.61573185E+01 -0.10884036E+03 0.19535090E+02 0.15752243E+02 0.31822740E+01 -0.51549731E+00 -0.11943111E+01 -0.10944993E+01 -0.73022073E+01 -0.18738628E-02 -0.19556480E-04 -0.50011433E-03 -0.52194194E-05 -0.43123198E-03 -0.45005320E-05 0.12959451E+03 0.36533244E-03 -0.56913742E-01 -0.52950538E-05 -0.43554724E-03 -0.45455680E-05 -0.49675742E-01 -0.23182994E-04 0.87410339E+00 -0.30369940E+01 -0.82194276E+00 -0.70652571E+00 -0.80993831E+02 -0.24701508E+02 0.97001595E+01 0.55783043E+01 -0.82297257E+00 0.18469536E+00 -0.70596904E+00 -0.36029813E+01 0.14775837E+01 -0.23935269E+00 -0.51337324E+01 -0.13894113E+01 -0.11943111E+01 -0.13691191E+03 0.21021639E+02 0.16397142E+02 0.94295614E+01 -0.15274876E+01 -0.13911522E+01 0.31220889E+00 -0.50574491E-01 -0.11933695E+01 -0.60904761E+01 -0.17108231E-02 -0.17854924E-04 -0.56862107E-03 -0.59343868E-05 -0.50736147E-03 -0.52950538E-05 0.14582182E+03 0.40265233E-03 -0.10932543E+00 -0.60680834E-05 -0.52222217E-03 -0.54501468E-05 -0.42453271E-01 -0.21133029E-04 0.18863610E+01 -0.27015410E+01 -0.91863870E+00 -0.82297257E+00 -0.97152630E+02 -0.27792393E+02 0.93935802E+01 0.10289578E+02 -0.92035445E+00 0.13299976E+01 -0.82190450E+00 -0.32050468E+01 0.31887047E+01 -0.51652764E+00 -0.45666848E+01 -0.15528669E+01 -0.13911522E+01 -0.16422681E+03 0.25293396E+02 0.15878907E+02 0.17393503E+02 -0.28175155E+01 -0.15557672E+01 0.22482280E+01 -0.36418296E+00 -0.13893474E+01 -0.54178110E+01 -0.16091390E-02 -0.16793702E-04 -0.65767387E-03 -0.68637821E-05 -0.58143161E-03 -0.60680834E-05 0.16206276E+03 0.44204789E-03 -0.19328197E+00 -0.72681221E-05 -0.61959745E-03 -0.64663993E-05 -0.19960069E-01 -0.19781345E-04 0.52167878E+01 -0.24309664E+01 -0.10300719E+01 -0.92035445E+00 -0.11684341E+03 -0.30885659E+02 0.92656855E+01 0.16984846E+02 -0.10598049E+01 0.17085869E+01 -0.93682947E+00 -0.28841868E+01 0.88184523E+01 -0.14284351E+01 -0.41093030E+01 -0.17412321E+01 -0.15557672E+01 -0.19751197E+03 0.30525937E+02 0.15662705E+02 0.28711166E+02 -0.46507071E+01 -0.17914930E+01 0.28881934E+01 -0.46783688E+00 -0.15836155E+01 -0.48754260E+01 -0.82984683E-01 -0.14670850E-04 -0.79452202E-03 -0.82919913E-05 -0.69641692E-03 -0.72681221E-05 0.19459037E+03 0.51894309E-03 -0.29625002E+00 -0.89874061E-05 -0.76037108E-03 -0.79355766E-05 -0.16482663E-02 -0.17202053E-04 0.14531280E+02 -0.20267265E+01 -0.11927259E+01 -0.10598049E+01 -0.15383473E+03 -0.37069915E+02 0.90252440E+01 0.27552567E+02 -0.12416079E+01 0.24164380E+00 -0.10954366E+01 -0.24047730E+01 0.24563675E+02 -0.39787347E+01 -0.34259784E+01 -0.20161839E+01 -0.17914930E+01 -0.26004222E+03 0.40341763E+02 0.15256271E+02 0.46574860E+02 -0.75440262E+01 -0.20988139E+01 0.40847468E+00 -0.66163242E-01 -0.18517261E+01 -0.40650283E+01 -0.37175945E+00 -0.13821958E-04 -0.95707288E-03 -0.99884456E-05 -0.86115528E-03 -0.89874061E-05 0.22200070E+03 0.58719055E-03 -0.45948004E+00 -0.11123200E-04 -0.91943302E-03 -0.95956190E-05 -0.15255790E-02 -0.15921633E-04 0.42979748E+02 -0.17801773E+01 -0.13707856E+01 -0.12416079E+01 -0.21221385E+03 -0.42232058E+02 0.91999729E+01 0.42257388E+02 -0.14325391E+01 -0.12577860E+01 -0.21123227E+01 0.72652915E+02 -0.11767451E+02 -0.30092095E+01 -0.23171744E+01 -0.20988139E+01 -0.35872605E+03 0.56042433E+02 0.15551625E+02 0.71431844E+02 -0.11569677E+02 -0.24215624E+01 -0.21261600E+01 -0.35706677E+01 -0.12680469E+01 -0.12867217E-04 -0.11435735E-02 -0.11934851E-04 -0.10658028E-02 -0.11123200E-04 0.26110786E+03 0.68404619E-03 -0.11789649E-02 -0.12304211E-04 -0.11386170E-02 -0.11883122E-04 -0.13844402E-02 -0.14448644E-04 0.13131564E+03 -0.15208751E+01 -0.15804774E+01 -0.14325391E+01 -0.37165501E+03 -0.49462685E+02 0.98205637E+01 -0.15868194E+01 -0.15019716E+01 -0.18034786E+01 0.22197596E+03 -0.35950514E+02 -0.25708872E+01 -0.26716390E+01 -0.24215624E+01 -0.62824561E+03 0.99286469E+02 0.16600677E+02 -0.26823581E+01 -0.25389328E+01 -0.30486002E+01 -0.31361874E+00 -0.11318731E-04 -0.11309445E-02 -0.11803048E-04 -0.47911884E+00 -0.12304211E-04 0.27051663E+03 0.70413969E-03 -0.11386034E-02 -0.11882980E-04 -0.11879351E-02 -0.12397828E-04 -0.12479521E-02 -0.13024193E-04 0.37277203E+02 -0.14597647E+01 -0.16144318E+01 0.47530409E+02 -0.15868194E+01 -0.23966453E+03 -0.51497262E+02 0.96341451E+01 -0.16195096E+01 -0.16167865E+01 -0.17310373E+01 0.63013350E+02 -0.10206158E+02 -0.24675848E+01 -0.27290339E+01 0.80345359E+02 -0.13013393E+02 -0.26823581E+01 -0.40512869E+03 0.63118938E+02 0.16285550E+02 -0.27376190E+01 -0.27330142E+01 -0.29261433E+01 -0.75290694E-01 -0.10714810E-04 -0.10885080E-02 -0.11360162E-04 -0.29111676E+00 -0.11882980E-04 0.27010717E+03 0.70134261E-03 -0.10989148E-02 -0.11468772E-04 -0.11510559E-02 -0.12012940E-04 -0.11995862E-02 -0.12519425E-04 0.13815885E+02 -0.14603184E+01 -0.16143877E+01 0.28543428E+02 -0.16195096E+01 -0.20363473E+03 -0.51482107E+02 0.96675806E+01 -0.16191732E+01 0.63963030E+01 -0.16165621E+01 -0.17318408E+01 0.23354372E+02 -0.37828194E+01 -0.24685221E+01 -0.27289610E+01 0.48249810E+02 -0.78152526E+01 -0.27376190E+01 -0.34422415E+03 0.53294295E+02 0.16342077E+02 -0.27370489E+01 0.10812310E+02 -0.17513217E+01 -0.27326365E+01 -0.29275037E+01 -0.12372172E-02 -0.10334473E-04 -0.10574586E-02 -0.11036116E-04 -0.19358587E+00 -0.11468772E-04 0.27002973E+03 0.69906204E-03 -0.10680400E-02 -0.11146549E-04 -0.76600454E-01 -0.11452271E-04 -0.11850076E-01 -0.12257771E-04 0.65236915E+01 -0.14590786E+01 -0.16155050E+01 0.17385177E+02 -0.16191732E+01 -0.19245925E+03 -0.51474884E+02 0.96658804E+01 -0.16190032E+01 0.13660612E+02 -0.16169162E+01 -0.17304186E+01 0.11027642E+02 -0.17862458E+01 -0.24664250E+01 -0.27308478E+01 0.29387887E+02 -0.47602190E+01 -0.27370489E+01 -0.32533292E+03 0.50253828E+02 0.16339196E+02 -0.27367630E+01 0.23091886E+02 -0.37403991E+01 -0.27332335E+01 -0.29250977E+01 -0.97247768E-03 -0.10149217E-04 -0.10275524E-02 -0.10724002E-04 -0.16140711E+00 -0.11146549E-04 0.26993957E+03 0.67529411E-03 -0.27057739E-01 -0.11922981E-04 0.40892497E+01 -0.14602675E+01 -0.15990651E+01 0.13440870E+02 -0.16190032E+01 -0.17242606E+03 -0.51470763E+02 0.64157856E+01 -0.17316662E+01 0.69124677E+01 -0.11196955E+01 -0.24684361E+01 -0.27030597E+01 0.22720447E+02 -0.36803039E+01 -0.27367630E+01 -0.29146900E+03 0.44779759E+02 0.10845244E+02 -0.29272085E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.22121759E-02 -0.23087268E-04 -0.22899062E-01 -0.41012760E-05 0.10799645E+03 0.31521981E-03 -0.13641424E-01 -0.41010484E-05 -0.38641520E-03 -0.40328039E-05 -0.52763589E-01 -0.27373634E-04 0.47833739E+00 -0.36436389E+01 0.96773944E+00 -0.64747945E+00 -0.66273133E+02 -0.20584062E+02 0.99100283E+01 0.28622958E+01 -0.64748607E+00 -0.64756021E+00 -0.43215522E+01 0.80858152E+00 -0.13098277E+00 -0.61592072E+01 0.16358668E+01 -0.26499537E+00 -0.10944993E+01 -0.11202810E+03 0.17184991E+02 0.16751912E+02 0.48384248E+01 -0.78378034E+00 -0.10945105E+01 -0.10946358E+01 -0.73051519E+01 -0.22492247E-02 -0.23473926E-04 -0.23565069E-01 -0.45455680E-05 -0.39295426E-03 -0.41010484E-05 0.10803119E+03 0.32114201E-03 -0.52755570E-01 -0.45491599E-05 -0.39523853E-03 -0.41248881E-05 -0.51145261E-01 -0.27822909E-04 0.71202527E+00 -0.36437574E+01 -0.70596904E+00 -0.64748607E+00 -0.68419519E+02 -0.20587619E+02 0.10674876E+02 0.57477272E+01 -0.70659250E+00 -0.64748172E+00 -0.43212757E+01 0.12036068E+01 -0.19497134E+00 -0.61594038E+01 -0.11933695E+01 -0.10945105E+01 -0.11565628E+03 0.17763824E+02 0.18044799E+02 0.97159521E+01 -0.15738796E+01 -0.11944232E+01 -0.10945024E+01 -0.73046794E+01 -0.19323577E-02 -0.20166959E-04 -0.22917029E-01 -0.54501468E-05 -0.43589141E-03 -0.45491599E-05 0.12965391E+03 0.36728552E-03 -0.10653696E+00 -0.55503435E-05 -0.44507975E-03 -0.46450536E-05 -0.45466010E-01 -0.23889507E-04 0.14723184E+01 -0.30366821E+01 -0.82190450E+00 -0.70659250E+00 -0.85348337E+02 -0.24709362E+02 0.97140832E+01 0.95303947E+01 -0.83709780E+00 -0.70625909E+00 -0.36027696E+01 0.24888069E+01 -0.40315204E+00 -0.51332074E+01 -0.13893474E+01 -0.11944232E+01 -0.14427283E+03 0.22194201E+02 0.16420685E+02 0.16110179E+02 -0.26096245E+01 -0.14150301E+01 -0.11938604E+01 -0.60901217E+01 -0.17307928E-02 -0.18063337E-04 -0.18186795E-01 -0.64663993E-05 -0.53182282E-03 -0.55503435E-05 0.15125413E+03 0.41747288E-03 -0.15298080E+00 -0.66764701E-05 -0.55931807E-03 -0.58372964E-05 -0.29380086E-01 -0.21328591E-04 0.37646537E+01 -0.26045985E+01 -0.93682947E+00 -0.83709780E+00 -0.10444681E+03 -0.28831816E+02 0.92932034E+01 0.13951809E+02 -0.96736793E+00 -0.85397505E+00 -0.30900922E+01 0.63637670E+01 -0.10308146E+01 -0.44028107E+01 -0.15836155E+01 -0.14150301E+01 -0.17655678E+03 0.27216494E+02 0.15709222E+02 0.23584125E+02 -0.38201994E+01 -0.16352378E+01 -0.14435584E+01 -0.52234888E+01 -0.35777127E-01 -0.16515382E-04 -0.47829871E-01 -0.79355766E-05 -0.63972601E-03 -0.66764701E-05 0.17290657E+03 0.46981893E-03 -0.19763276E+00 -0.80510325E-05 -0.68268354E-03 -0.71247943E-05 -0.18630208E-02 -0.19443328E-04 0.98677828E+01 -0.22800486E+01 -0.10954366E+01 -0.96736793E+00 -0.12699346E+03 -0.32957137E+02 0.91643487E+01 0.18014880E+02 -0.11115071E+01 -0.10013891E+01 -0.27048907E+01 0.16680500E+02 -0.27018452E+01 -0.38541941E+01 -0.18517261E+01 -0.16352378E+01 -0.21466975E+03 0.33175169E+02 0.15491414E+02 0.30452353E+02 -0.49325587E+01 -0.18788916E+01 -0.16927482E+01 -0.45723473E+01 -0.16926658E+00 -0.15045593E-04 -0.13140085E+00 -0.95956190E-05 -0.77143383E-03 -0.80510325E-05 0.20007792E+03 0.53619780E-03 -0.18912705E+00 -0.10034359E-04 -0.83448985E-03 -0.87091136E-05 -0.16801156E-02 -0.17534446E-04 0.23028724E+02 -0.19724001E+01 0.72474017E+01 -0.12577860E+01 -0.11115071E+01 -0.16054765E+03 -0.38115097E+02 0.91815998E+01 0.15687094E+02 -0.13153713E+01 -0.11802067E+01 -0.23400367E+01 0.38927728E+02 -0.63051332E+01 -0.33341428E+01 0.12251000E+02 -0.19842972E+01 -0.21261600E+01 -0.18788916E+01 -0.27138957E+03 0.42090424E+02 0.15520567E+02 0.26517446E+02 -0.42950369E+01 -0.22235022E+01 -0.19950201E+01 -0.39555957E+01 -0.34375572E+00 -0.12833632E-04 -0.42269746E+00 -0.11883122E-04 -0.96147224E-03 -0.10034359E-04 0.24350342E+03 0.64041493E-03 -0.11274298E-02 -0.11766367E-04 -0.10395140E-02 -0.10848838E-04 -0.14161375E-02 -0.14779451E-04 0.40238110E+02 -0.16222799E+01 0.35046687E+02 -0.15019716E+01 -0.13153713E+01 -0.21463638E+03 -0.46361346E+02 0.93417448E+01 -0.15345715E+01 -0.14383759E+01 -0.19239522E+01 0.68018501E+02 -0.11016657E+02 -0.27423019E+01 0.59242920E+02 -0.95953152E+01 -0.25389328E+01 -0.22235022E+01 -0.36282133E+03 0.56481337E+02 0.15791282E+02 -0.25940381E+01 -0.24314307E+01 -0.32522488E+01 -0.13674684E+00 -0.11187730E-04 -0.13342204E+00 -0.12397828E-04 -0.15808714E+00 -0.11766367E-04 0.27014495E+03 0.70391015E-03 -0.11531738E-02 -0.12035044E-04 -0.11615426E-02 -0.12122384E-04 -0.12461293E-02 -0.13005170E-04 0.19861190E+02 -0.14592005E+01 0.60085957E+01 -0.16167865E+01 0.15859809E+02 -0.15345715E+01 -0.19657855E+03 -0.51503173E+02 0.95834246E+01 -0.16197167E+01 -0.16168748E+01 -0.17304764E+01 0.33573335E+02 -0.54378591E+01 -0.24666309E+01 0.10156924E+02 -0.16451127E+01 -0.27330142E+01 0.26809404E+02 -0.43423080E+01 -0.25940381E+01 -0.33229618E+03 0.51308508E+02 0.16199811E+02 -0.27379691E+01 -0.27331625E+01 -0.29251949E+01 -0.40112686E-01 -0.10836605E-04 -0.15265340E-01 -0.12012940E-04 -0.17280484E+00 -0.12035044E-04 0.26995334E+03 0.70276120E-03 -0.11303636E-02 -0.11796986E-04 -0.11496815E-02 -0.11998596E-04 -0.12169571E-02 -0.12700715E-04 0.10345366E+02 -0.14584898E+01 -0.16165621E+01 0.16117870E+02 -0.16197167E+01 -0.18132328E+03 -0.51495627E+02 0.96666238E+01 -0.16196478E+01 -0.16167175E+01 -0.17296952E+01 0.17487807E+02 -0.28325578E+01 -0.24654311E+01 -0.27326365E+01 0.27245647E+02 -0.44130674E+01 -0.27379691E+01 -0.30650887E+03 0.47151643E+02 0.16340459E+02 -0.27378505E+01 -0.27328993E+01 -0.29238767E+01 -0.10327461E-02 -0.10778205E-04 -0.10973337E-02 -0.11452271E-04 -0.10388055E+00 -0.11796986E-04 0.26984629E+03 0.68987731E-03 -0.11378693E-02 -0.11875319E-04 -0.11707371E-01 -0.12603672E-04 0.63924356E+01 -0.14589556E+01 -0.16169162E+01 0.10114327E+02 -0.16196478E+01 -0.17561032E+03 -0.51490230E+02 0.80486866E+01 0.42357121E+01 -0.16171003E+01 -0.17302744E+01 0.10805765E+02 -0.17502718E+01 -0.24662167E+01 -0.27332335E+01 0.17097245E+02 -0.27693391E+01 -0.27378505E+01 -0.29685147E+03 0.45601587E+02 0.13605490E+02 0.71600424E+01 -0.11597532E+01 -0.27335442E+01 -0.29248541E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.20344545E-02 -0.21232487E-04 0.11337215E+03 0.31999143E-03 -0.11889087E-01 -0.40530144E-05 -0.42009502E-03 -0.43843017E-05 -0.52840465E-01 -0.25176046E-04 0.44623239E+00 -0.34702348E+01 -0.68660562E+02 -0.21608517E+02 0.89769714E+01 0.31445519E+01 -0.66272767E+00 -0.72523623E+00 -0.41163478E+01 0.75431073E+00 -0.12219412E+00 -0.58660810E+01 -0.11606375E+03 0.17802766E+02 0.15174662E+02 0.53155474E+01 -0.86108879E+00 -0.11202741E+01 -0.12259385E+01 -0.69582695E+01 -0.21762259E-02 -0.22712078E-04 -0.39250766E-01 -0.40328039E-05 -0.38835173E-03 -0.40530144E-05 0.10801808E+03 0.31834302E-03 -0.17943929E-01 -0.40306948E-05 -0.38955156E-03 -0.40655363E-05 -0.52961635E-01 -0.26928775E-04 0.45034387E+00 -0.36457717E+01 0.28889618E+01 -0.64756021E+00 -0.66272767E+00 -0.69213653E+02 -0.20583738E+02 0.10592832E+02 0.39090414E+01 -0.64726334E+00 -0.66324472E+00 -0.43239533E+01 0.76126127E+00 -0.12331862E+00 -0.61628125E+01 0.48835010E+01 -0.79109055E+00 -0.10946358E+01 -0.11202741E+01 -0.11699876E+03 0.17991234E+02 0.17906123E+02 0.66078435E+01 -0.10704211E+01 -0.10941339E+01 -0.11211489E+01 -0.73092107E+01 -0.22239246E-02 -0.23209883E-04 -0.34935035E-01 -0.41248881E-05 -0.38621311E-03 -0.40306948E-05 0.10803820E+03 0.31959802E-03 -0.48309404E-01 -0.41261489E-05 -0.38920994E-03 -0.40619711E-05 -0.52331484E-01 -0.27523332E-04 0.53879822E+00 -0.36426013E+01 0.18403586E+01 -0.64748172E+00 -0.64726334E+00 -0.69988742E+02 -0.20588667E+02 0.10555334E+02 0.56511986E+01 -0.64772801E+00 -0.64762352E+00 -0.43203223E+01 0.91078393E+00 -0.14753817E+00 -0.61574493E+01 0.31109401E+01 -0.50394217E+00 -0.10945024E+01 -0.10941339E+01 -0.11830889E+03 0.18191121E+02 0.17842726E+02 0.95527798E+01 -0.15474577E+01 -0.10949187E+01 -0.10947419E+01 -0.73030692E+01 -0.22975010E-02 -0.23977760E-04 -0.38165343E-01 -0.46450536E-05 -0.39535934E-03 -0.41261489E-05 0.10806751E+03 0.32261263E-03 -0.82053303E-01 -0.47339249E-05 -0.40135963E-03 -0.41887707E-05 -0.49200501E-01 -0.28415874E-04 0.98968364E+00 -0.36428105E+01 0.15903447E+01 -0.70625909E+00 -0.64772801E+00 -0.72373388E+02 -0.20592885E+02 0.10687176E+02 0.78410561E+01 -0.71982591E+00 -0.64769346E+00 -0.43205436E+01 0.16729612E+01 -0.27099783E+00 -0.61578069E+01 0.26883187E+01 -0.43547246E+00 -0.11938604E+01 -0.10949187E+01 -0.12233997E+03 0.18833227E+02 0.18065601E+02 0.13254521E+02 -0.21470590E+01 -0.12167937E+01 -0.10948610E+01 -0.73034469E+01 -0.19178555E-02 -0.20015607E-04 -0.57493821E-01 -0.58372964E-05 -0.45359522E-03 -0.47339249E-05 0.13507698E+03 0.38104181E-03 -0.11283663E+00 -0.60380577E-05 -0.48625713E-03 -0.50747994E-05 -0.40000201E-01 -0.23677654E-04 0.22545016E+01 -0.29196208E+01 0.23427932E+01 -0.85397505E+00 -0.71982591E+00 -0.92422249E+02 -0.25745523E+02 0.96008817E+01 0.10391003E+02 -0.88341743E+00 -0.75715025E+00 -0.34639961E+01 0.38110069E+01 -0.61731790E+00 -0.49353235E+01 0.39602548E+01 -0.64149352E+00 -0.14435584E+01 -0.12167937E+01 -0.15623046E+03 0.24065408E+02 0.16229320E+02 0.17564939E+02 -0.28452196E+01 -0.14933278E+01 -0.12798859E+01 -0.58555350E+01 -0.16695103E-02 -0.17423765E-04 -0.97878816E-01 -0.71247943E-05 -0.57855462E-03 -0.60380577E-05 0.16208701E+03 0.44396095E-03 -0.13546725E+00 -0.75417599E-05 -0.62223328E-03 -0.64939081E-05 -0.19986854E-01 -0.20530161E-04 0.51369605E+01 -0.24321780E+01 0.54105136E+01 -0.10013891E+01 -0.88341743E+00 -0.11526550E+03 -0.30899754E+02 0.92013852E+01 0.11804877E+02 -0.10600584E+01 -0.93536084E+00 -0.28855036E+01 0.86835180E+01 -0.14065417E+01 -0.41113536E+01 0.91459321E+01 -0.14814428E+01 -0.16927482E+01 -0.14933278E+01 -0.19484480E+03 0.30058278E+02 0.15554020E+02 0.19954964E+02 -0.32322717E+01 -0.17919227E+01 -0.15811340E+01 -0.48776553E+01 -0.36361006E-01 -0.14957052E-04 -0.17438127E+00 -0.87091136E-05 -0.72263635E-03 -0.75417599E-05 0.19451755E+03 0.52093730E-03 -0.11214604E+00 -0.94657299E-05 -0.77490891E-03 -0.80873000E-05 -0.16856987E-02 -0.17592714E-04 0.99422740E+01 -0.20270036E+01 0.12361556E+02 -0.11802067E+01 -0.10600584E+01 -0.14259383E+03 -0.37084526E+02 0.90899510E+01 0.88013890E+01 -0.12827506E+01 -0.11308285E+01 -0.24049276E+01 0.16806408E+02 -0.27222043E+01 -0.34264445E+01 0.20895960E+02 -0.33846061E+01 -0.19950201E+01 -0.17919227E+01 -0.24104046E+03 0.37227496E+02 0.15365644E+02 0.14877859E+02 -0.24098289E+01 -0.21683601E+01 -0.19115514E+01 -0.40652867E+01 -0.76291503E-01 -0.12512836E-04 -0.29356815E+00 -0.10848838E-04 -0.90698731E-03 -0.94657299E-05 0.23771689E+03 0.62461449E-03 -0.10893372E-02 -0.11368816E-04 -0.97283384E-03 -0.10152934E-04 -0.14038815E-02 -0.14651543E-04 0.13900146E+02 -0.16590973E+01 0.22350159E+02 -0.14383759E+01 -0.12827506E+01 -0.17251084E+03 -0.45327617E+02 0.92591950E+01 -0.15164090E+01 -0.13893235E+01 -0.19681342E+01 0.23496806E+02 -0.38058128E+01 -0.28045381E+01 0.37780708E+02 -0.61193978E+01 -0.24314307E+01 -0.21683601E+01 -0.29161233E+03 0.45009350E+02 0.15651739E+02 -0.25633354E+01 -0.23485125E+01 -0.33269340E+01 -0.33713512E-01 -0.10943588E-04 -0.18201594E+00 -0.12122384E-04 -0.17390544E-01 -0.11368816E-04 0.26994798E+03 0.70255065E-03 -0.11518031E-02 -0.12020739E-04 -0.11382751E-02 -0.11879554E-04 -0.12300748E-02 -0.12837617E-04 0.97211886E+01 -0.14597855E+01 0.11574085E+02 -0.16168748E+01 0.29635679E+01 -0.15164090E+01 -0.17910548E+03 -0.51505101E+02 0.95663979E+01 -0.16197874E+01 -0.16165056E+01 -0.17312366E+01 0.16432681E+02 -0.26616403E+01 -0.24676190E+01 0.19564815E+02 -0.31689595E+01 -0.27331625E+01 0.50096107E+01 -0.81141850E+00 -0.25633354E+01 -0.30275963E+03 0.46520833E+02 0.16171028E+02 -0.27380886E+01 -0.27325391E+01 -0.29264805E+01 -0.88675252E-02 -0.10837763E-04 -0.62403481E-01 -0.11998596E-04 -0.52988615E-01 -0.12020739E-04 0.26984590E+03 0.69097931E-03 -0.11396550E-02 -0.11893955E-04 -0.60311753E-02 -0.12854729E-04 0.72786198E+01 -0.14604714E+01 0.57891668E+00 -0.16167175E+01 0.51032672E+01 -0.16197874E+01 -0.16781140E+03 -0.51502392E+02 0.80545803E+01 -0.16197401E+01 -0.17320662E+01 0.12303779E+02 -0.19928854E+01 -0.24687808E+01 0.97860075E+00 -0.15850733E+00 -0.27328993E+01 0.86265627E+01 -0.13972740E+01 -0.27380886E+01 -0.28366839E+03 0.43435542E+02 0.13615461E+02 -0.27380070E+01 -0.29278847E+01 -0.10390959E-02 -0.10844475E-04 -0.21406402E-01 -0.11875319E-04 -0.62819843E-01 -0.11893955E-04 0.26981877E+03 0.67868937E-03 -0.17018529E-01 -0.12707884E-04 0.55196546E+01 -0.14591348E+01 -0.16171003E+01 0.52919592E+01 -0.16197401E+01 -0.16566496E+03 -0.51500595E+02 0.64322654E+01 -0.17304932E+01 0.93304182E+01 -0.15112923E+01 -0.24665199E+01 -0.27335442E+01 0.89455222E+01 -0.14489489E+01 -0.27380070E+01 -0.28003986E+03 0.42852774E+02 0.10873094E+02 -0.29252241E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.17627555E-02 -0.18396914E-04 -0.15354290E-01 -0.43843017E-05 0.12956429E+03 0.35694669E-03 -0.42519978E-03 -0.44375773E-05 -0.46811103E-03 -0.48854185E-05 -0.52523826E-01 -0.21820208E-04 0.47361598E+00 -0.30418515E+01 0.21429853E+01 -0.72523623E+00 -0.79601512E+02 -0.24693282E+02 0.89252988E+01 0.26163863E+01 -0.72388289E+00 -0.82228962E+00 -0.36092681E+01 0.80059990E+00 -0.12969360E+00 -0.51419423E+01 0.36224997E+01 -0.58682873E+00 -0.12259385E+01 -0.13455832E+03 0.20661564E+02 0.15087315E+02 0.44227367E+01 -0.71646354E+00 -0.12236508E+01 -0.13899972E+01 -0.61011032E+01 -0.20406251E-02 -0.21296887E-04 -0.36654252E-01 -0.40655363E-05 -0.12541000E-01 -0.44375773E-05 0.11342234E+03 0.32863431E-03 -0.17241399E-01 -0.40635890E-05 -0.41884696E-03 -0.43712764E-05 -0.52799427E-01 -0.25256853E-04 0.46115962E+00 -0.34731796E+01 0.27094703E+01 -0.66324472E+00 -0.72388289E+00 -0.72226180E+02 -0.21612590E+02 0.10370998E+02 0.39914205E+01 -0.66297106E+00 -0.72501701E+00 -0.41202759E+01 0.77954422E+00 -0.12628154E+00 -0.58710629E+01 0.45800887E+01 -0.74194717E+00 -0.11211489E+01 -0.12236508E+01 -0.12209113E+03 0.18769138E+02 0.17531134E+02 0.67470971E+01 -0.10929897E+01 -0.11206863E+01 -0.12255687E+01 -0.69649144E+01 -0.21901939E-02 -0.22857855E-04 -0.36900348E-01 -0.40619711E-05 -0.38936497E-03 -0.40635890E-05 0.10803430E+03 0.31865465E-03 -0.41747791E-01 -0.40605177E-05 -0.38233605E-03 -0.39902320E-05 -0.52785699E-01 -0.27102875E-04 0.47214194E+00 -0.36432492E+01 0.26576715E+01 -0.64762352E+00 -0.66297106E+00 -0.70405894E+02 -0.20588468E+02 0.10572209E+02 0.53173207E+01 -0.64743079E+00 -0.64753076E+00 -0.43210899E+01 0.79810807E+00 -0.12928706E+00 -0.61585434E+01 0.44925241E+01 -0.72775254E+00 -0.10947419E+01 -0.11206863E+01 -0.11901402E+03 0.18306083E+02 0.17871250E+02 0.89883915E+01 -0.14560467E+01 -0.10944161E+01 -0.10945853E+01 -0.73043660E+01 -0.22595035E-02 -0.23581201E-04 -0.43447644E-01 -0.41887707E-05 -0.38907069E-03 -0.40605177E-05 0.10804453E+03 0.32079552E-03 -0.51357459E-01 -0.43870749E-05 -0.39332922E-03 -0.41049617E-05 -0.51639411E-01 -0.27951990E-04 0.64480901E+00 -0.36444874E+01 0.29892049E+01 -0.64769346E+00 -0.64743079E+00 -0.72357808E+02 -0.20592914E+02 0.10590126E+02 0.67714276E+01 -0.67841061E+00 -0.64774506E+00 -0.43220435E+01 0.10899851E+01 -0.17656524E+00 -0.61606414E+01 0.50529519E+01 -0.81852092E+00 -0.10948610E+01 -0.10944161E+01 -0.12231364E+03 0.18829160E+02 0.17901548E+02 0.11446421E+02 -0.18541905E+01 -0.11467853E+01 -0.10949482E+01 -0.73059823E+01 -0.21297054E-02 -0.22226569E-04 -0.79778375E-01 -0.50747994E-05 -0.42036074E-03 -0.43870749E-05 0.11890076E+03 0.34570613E-03 -0.93184508E-01 -0.53491131E-05 -0.43647705E-03 -0.45552719E-05 -0.47033577E-01 -0.26336006E-04 0.12772920E+01 -0.33123752E+01 0.41842642E+01 -0.75715025E+00 -0.67841061E+00 -0.81623769E+02 -0.22658386E+02 0.10173885E+02 0.80234414E+01 -0.79812720E+00 -0.69594388E+00 -0.39293287E+01 0.21591329E+01 -0.34974716E+00 -0.55992353E+01 0.70730753E+01 -0.11457322E+01 -0.12798859E+01 -0.11467853E+01 -0.13797673E+03 0.21252222E+02 0.17197926E+02 0.13562817E+02 -0.21969729E+01 -0.13491533E+01 -0.11764226E+01 -0.66421333E+01 -0.17438404E-02 -0.18199507E-04 -0.10881623E+00 -0.64939081E-05 -0.51254132E-03 -0.53491131E-05 0.15129408E+03 0.41790688E-03 -0.10388809E+00 -0.69062408E-05 -0.56426636E-03 -0.58889390E-05 -0.37777033E-01 -0.21524741E-04 0.25773871E+01 -0.26129498E+01 0.67675836E+01 -0.93536084E+00 -0.79812720E+00 -0.10485422E+03 -0.28841163E+02 0.93164495E+01 0.87920353E+01 -0.99479200E+00 -0.87164905E+00 -0.31003240E+01 0.43568151E+01 -0.70572155E+00 -0.44169304E+01 0.11439923E+02 -0.18530510E+01 -0.15811340E+01 -0.13491533E+01 -0.17724558E+03 0.27304935E+02 0.15748525E+02 0.14862056E+02 -0.24073717E+01 -0.16815964E+01 -0.14734355E+01 -0.52407877E+01 -0.14815586E-02 -0.15462216E-04 -0.15796506E+00 -0.80873000E-05 -0.66174218E-03 -0.69062408E-05 0.18368457E+03 0.49431217E-03 -0.96520723E-01 -0.87060903E-05 -0.73050679E-03 -0.76238993E-05 -0.24271380E-01 -0.18212201E-04 0.45255625E+01 -0.21468502E+01 0.10780072E+02 -0.11308285E+01 -0.99479200E+00 -0.12856659E+03 -0.35024614E+02 0.91376521E+01 0.79663073E+01 -0.12173762E+01 -0.10973587E+01 -0.25465029E+01 0.76500063E+01 -0.12391313E+01 -0.36290334E+01 0.18222623E+02 -0.29516605E+01 -0.19115514E+01 -0.16815964E+01 -0.21732884E+03 0.33487759E+02 0.15446279E+02 0.13466238E+02 -0.21812317E+01 -0.20578516E+01 -0.18549738E+01 -0.43046060E+01 -0.12303848E-02 -0.12840853E-04 -0.20536677E+00 -0.10152934E-04 -0.83420016E-03 -0.87060903E-05 0.22682106E+03 0.59753006E-03 -0.43583597E-01 -0.10807959E-04 -0.92131834E-03 -0.96152951E-05 -0.15524926E-01 -0.15067541E-04 0.59457629E+01 -0.17380630E+01 0.13685122E+02 -0.13893235E+01 -0.12173762E+01 -0.15211895E+03 -0.43268319E+02 0.92315550E+01 0.24221967E+01 -0.14789555E+01 -0.13411889E+01 -0.20617751E+01 0.10050718E+02 -0.16279674E+01 -0.29380216E+01 0.23133330E+02 -0.37470265E+01 -0.23485125E+01 -0.20578516E+01 -0.25714188E+03 0.39525830E+02 0.15605019E+02 0.40944812E+01 -0.66320456E+00 -0.25000264E+01 -0.22671456E+01 -0.34852246E+01 -0.10395741E-02 -0.10849465E-04 -0.17507871E+00 -0.11879554E-04 -0.10355970E-02 -0.10807959E-04 0.26990596E+03 0.68922445E-03 -0.11115532E-02 -0.11600672E-04 -0.19985788E-01 -0.12725786E-04 0.51931919E+01 -0.14599415E+01 0.10116538E+02 -0.16165056E+01 -0.14789555E+01 -0.17015155E+03 -0.51508807E+02 0.78930001E+01 -0.16001767E+01 -0.17316203E+01 0.87785651E+01 -0.14219055E+01 -0.24678833E+01 0.17100984E+02 -0.27699267E+01 -0.27325391E+01 -0.25000264E+01 -0.28762397E+03 0.44061014E+02 0.13342320E+02 -0.27049376E+01 -0.29271289E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.13682081E-02 -0.14279239E-04 0.16193772E+03 0.42113976E-03 -0.52298365E-03 -0.54580940E-05 -0.57036811E-02 -0.56985528E-05 -0.51615507E-01 -0.16926631E-04 0.55238695E+00 -0.24305303E+01 -0.96325749E+02 -0.30856113E+02 0.72066814E+01 0.27981439E+01 -0.91859475E+00 -0.97071914E+00 -0.28833788E+01 0.93375490E+00 -0.15126664E+00 -0.41085685E+01 -0.16282905E+03 0.24983323E+02 0.12182174E+02 0.47299825E+01 -0.76624879E+00 -0.15527926E+01 -0.16409036E+01 -0.48740636E+01 -0.15401932E-02 -0.16074153E-04 -0.25316249E-01 -0.48854185E-05 -0.77146665E-02 -0.54580940E-05 0.14577699E+03 0.39679183E-03 -0.47447408E-03 -0.49518262E-05 -0.54925528E-02 -0.54636132E-05 -0.52014773E-01 -0.19060727E-04 0.52312342E+00 -0.27035268E+01 0.36040503E+01 -0.82228962E+00 -0.91859475E+00 -0.90858930E+02 -0.27776287E+02 0.93962922E+01 0.30620254E+01 -0.82121591E+00 -0.91952951E+00 -0.32080206E+01 0.88428709E+00 -0.14325203E+00 -0.45700380E+01 0.60922817E+01 -0.98693260E+00 -0.13899972E+01 -0.15527926E+01 -0.15358782E+03 0.23611475E+02 0.15883482E+02 0.51760440E+01 -0.83850459E+00 -0.13881823E+01 -0.15543716E+01 -0.54228342E+01 -0.17572603E-02 -0.18339563E-04 -0.14385499E-01 -0.43712764E-05 -0.52273750E-02 -0.49518262E-05 0.12957379E+03 0.36139659E-03 -0.85518109E-02 -0.42522785E-05 -0.45146567E-03 -0.47117000E-05 -0.52447066E-01 -0.21750669E-04 0.47974413E+00 -0.30402072E+01 0.30947403E+01 -0.72501701E+00 -0.82121591E+00 -0.81877839E+02 -0.24695931E+02 0.96944012E+01 0.39384884E+01 -0.70530200E+00 -0.79257688E+00 -0.36073107E+01 0.81095948E+00 -0.13137192E+00 -0.51391662E+01 0.52313490E+01 -0.84745588E+00 -0.12255687E+01 -0.13881823E+01 -0.13840630E+03 0.21278445E+02 0.16387415E+02 0.66576208E+01 -0.10785057E+01 -0.11922425E+01 -0.13397720E+01 -0.60977979E+01 -0.21547261E-02 -0.22487696E-04 -0.21837092E-01 -0.39902320E-05 -0.40744482E-03 -0.42522785E-05 0.10800479E+03 0.31791075E-03 -0.24076337E-01 -0.39845664E-05 -0.38464484E-03 -0.40143276E-05 -0.52925043E-01 -0.26665641E-04 0.45923005E+00 -0.36481002E+01 0.30465115E+01 -0.64753076E+00 -0.70530200E+00 -0.70290947E+02 -0.20585626E+02 0.10639977E+02 0.48224163E+01 -0.64663870E+00 -0.66305749E+00 -0.43270355E+01 0.77628199E+00 -0.12575274E+00 -0.61667448E+01 0.51498198E+01 -0.83423801E+00 -0.10945853E+01 -0.11922425E+01 -0.11881974E+03 0.18281811E+02 0.17985806E+02 0.81518075E+01 -0.13205409E+01 -0.10930774E+01 -0.11208317E+01 -0.73144156E+01 -0.22167704E-02 -0.23135219E-04 -0.39496526E-01 -0.41049617E-05 -0.38179319E-03 -0.39845664E-05 0.10802336E+03 0.31938638E-03 -0.31541777E-01 -0.41991334E-05 -0.38492957E-03 -0.40172991E-05 -0.52634792E-01 -0.27427728E-04 0.50941971E+00 -0.36492619E+01 0.35366700E+01 -0.64774506E+00 -0.64663870E+00 -0.71838586E+02 -0.20591437E+02 0.10583862E+02 0.58379544E+01 -0.66265230E+00 -0.64743050E+00 -0.43278193E+01 0.86112308E+00 -0.13949396E+00 -0.61687123E+01 0.59783870E+01 -0.96844330E+00 -0.10949482E+01 -0.10930774E+01 -0.12143595E+03 0.18690919E+02 0.17890960E+02 0.98684780E+01 -0.15986020E+01 -0.11201474E+01 -0.10944165E+01 -0.73157458E+01 -0.21803832E-02 -0.22755466E-04 -0.61991313E-01 -0.45552719E-05 -0.40235257E-03 -0.41991334E-05 0.11344473E+03 0.33287716E-03 -0.45095527E-01 -0.49208480E-05 -0.41622535E-03 -0.43439161E-05 -0.50597208E-01 -0.26957113E-04 0.78845270E+00 -0.34736169E+01 0.46147383E+01 -0.69594388E+00 -0.66265230E+00 -0.77174379E+02 -0.21627893E+02 0.10384961E+02 0.67286829E+01 -0.75184989E+00 -0.68011853E+00 -0.41183464E+01 0.13327994E+01 -0.21589688E+00 -0.58717972E+01 0.78007472E+01 -0.12636238E+01 -0.11764226E+01 -0.11201474E+01 -0.13045548E+03 0.20085606E+02 0.17554727E+02 0.11374157E+02 -0.18424714E+01 -0.12709260E+01 -0.11496714E+01 -0.69616488E+01 -0.18180626E-02 -0.18974124E-04 -0.12712021E+00 -0.58889390E-05 -0.47150582E-03 -0.49208480E-05 0.14053661E+03 0.39251933E-03 -0.11247037E+00 -0.64451798E-05 -0.52983208E-03 -0.55295673E-05 -0.45817235E-01 -0.22481667E-04 0.14265019E+01 -0.28041797E+01 0.67410271E+01 -0.87164905E+00 -0.75184989E+00 -0.96260607E+02 -0.26784777E+02 0.95539122E+01 0.75749029E+01 -0.95401471E+00 -0.84152480E+00 -0.33276778E+01 0.24113587E+01 -0.39060161E+00 -0.47401854E+01 0.11395032E+02 -0.18458133E+01 -0.14734355E+01 -0.12709260E+01 -0.16271893E+03 0.25043815E+02 0.16149932E+02 0.12804616E+02 -0.20741433E+01 -0.16126664E+01 -0.14225135E+01 -0.56251066E+01 -0.14398869E-02 -0.15027311E-04 -0.14525831E+00 -0.76238993E-05 -0.61756424E-03 -0.64451798E-05 0.18371826E+03 0.49185286E-03 -0.12848283E+00 -0.83665884E-05 -0.70272142E-03 -0.73339187E-05 -0.39784889E-01 -0.17755663E-04 0.22860263E+01 -0.21546054E+01 0.94717085E+01 -0.10973587E+01 -0.95401471E+00 -0.12836321E+03 -0.35025750E+02 0.90671103E+01 0.11312072E+02 -0.12043097E+01 -0.10972324E+01 -0.25556453E+01 0.38642962E+01 -0.62594283E+00 -0.36421424E+01 0.16010965E+02 -0.25934732E+01 -0.18549738E+01 -0.16126664E+01 -0.21698503E+03 0.33430196E+02 0.15327034E+02 0.19121914E+02 -0.30973879E+01 -0.20357636E+01 -0.18547602E+01 -0.43200606E+01 -0.12311274E-02 -0.12848602E-04 -0.14077561E+00 -0.96152951E-05 -0.80166977E-03 -0.83665884E-05 0.22139825E+03 0.57404826E-03 -0.67449494E-01 -0.10368966E-04 -0.32199498E-01 -0.15150297E-04 0.33587507E+01 -0.17813940E+01 0.77545697E+01 -0.13411889E+01 -0.12043097E+01 -0.14289282E+03 -0.42241754E+02 0.78912239E+01 0.48152646E+01 -0.14463522E+01 -0.21132209E+01 0.56776321E+01 -0.91964831E+00 -0.30112683E+01 0.13108325E+02 -0.21232529E+01 -0.22671456E+01 -0.20357636E+01 -0.24154602E+03 0.37042029E+02 0.13339323E+02 0.81397233E+01 -0.13184515E+01 -0.24449138E+01 -0.35721885E+01 -0.10423520E-02 -0.10878457E-04 -0.14048118E+00 -0.11600672E-04 -0.99353355E-03 -0.10368966E-04 0.26448201E+03 0.66438031E-03 -0.31922291E-01 -0.12812511E-04 0.33795222E+01 -0.14898504E+01 0.65452608E+01 -0.16001767E+01 -0.14463522E+01 -0.16166186E+03 -0.50484398E+02 0.63093915E+01 -0.17673253E+01 0.57127422E+01 -0.92532827E+00 -0.25184421E+01 0.11064105E+02 -0.17921216E+01 -0.27049376E+01 -0.24449138E+01 -0.27327311E+03 0.41773412E+02 0.10665392E+02 -0.29874848E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.13598413E-02 -0.14191919E-04 -0.54602393E-03 -0.56985528E-05 0.16194470E+03 0.42684968E-03 -0.54574734E-03 -0.56956662E-05 -0.88439480E-02 -0.56667857E-05 -0.51505774E-01 -0.16818596E-04 0.56215850E+00 -0.24292229E+01 0.13611340E+01 -0.97071914E+00 -0.96497379E+02 -0.30852941E+02 0.82246738E+01 0.15944959E+01 -0.96938615E+00 -0.97074826E+00 -0.28811403E+01 0.95027273E+00 -0.15394300E+00 -0.41063585E+01 0.23008609E+01 -0.37273661E+00 -0.16409036E+01 -0.16311917E+03 0.25038158E+02 0.13902989E+02 0.26953358E+01 -0.43664106E+00 -0.16386503E+01 -0.16409528E+01 -0.48702796E+01 -0.13713259E-02 -0.14311777E-04 -0.52351249E-03 -0.54636132E-05 -0.80473167E-02 -0.56956662E-05 0.16194053E+03 0.43210605E-03 -0.50176739E-03 -0.52366715E-05 -0.54167195E-03 -0.56531335E-05 -0.51855591E-01 -0.16968364E-04 0.52784843E+00 -0.24336098E+01 0.25778537E+01 -0.91952951E+00 -0.96938615E+00 -0.98694245E+02 -0.30856855E+02 0.90656151E+01 0.26143063E+01 -0.88078221E+00 -0.97084846E+00 -0.28880003E+01 0.89227438E+00 -0.14454689E+00 -0.41137712E+01 0.43576008E+01 -0.70592372E+00 -0.15543716E+01 -0.16386503E+01 -0.16683264E+03 0.25630146E+02 0.15324507E+02 0.44192202E+01 -0.71590595E+00 -0.14888732E+01 -0.16411213E+01 -0.48818723E+01 -0.16636560E-02 -0.17362667E-04 -0.12450066E-01 -0.47117000E-05 -0.23695041E-01 -0.52366715E-05 0.13498291E+03 0.37268180E-03 -0.19379559E-02 -0.43848042E-05 -0.45528563E-03 -0.47515669E-05 -0.52252131E-01 -0.20589990E-04 0.49816244E+00 -0.29189937E+01 0.28246275E+01 -0.79257688E+00 -0.88078221E+00 -0.84221274E+02 -0.25721199E+02 0.96051625E+01 0.34298592E+01 -0.73761286E+00 -0.80898352E+00 -0.34633279E+01 0.84209378E+00 -0.13641669E+00 -0.49342670E+01 0.47747504E+01 -0.77349535E+00 -0.13397720E+01 -0.14888732E+01 -0.14236764E+03 0.21881898E+02 0.16236566E+02 0.57978341E+01 -0.93923186E+00 -0.12468608E+01 -0.13675057E+01 -0.58544095E+01 -0.20178442E-02 -0.21059135E-04 -0.16712968E-01 -0.40143276E-05 -0.42014317E-03 -0.43848042E-05 0.11338744E+03 0.32763065E-03 -0.13111279E-01 -0.40079459E-05 -0.38802292E-03 -0.40495827E-05 -0.52868056E-01 -0.24974195E-04 0.45515115E+00 -0.34774202E+01 0.29823913E+01 -0.66305749E+00 -0.73761286E+00 -0.72722891E+02 -0.21611440E+02 0.10346880E+02 0.42195423E+01 -0.66202847E+00 -0.67953492E+00 -0.41247997E+01 0.76938705E+00 -0.12463713E+00 -0.58782276E+01 0.50414313E+01 -0.81668844E+00 -0.11208317E+01 -0.12468608E+01 -0.12293071E+03 0.18908185E+02 0.17490356E+02 0.71327105E+01 -0.11554659E+01 -0.11190923E+01 -0.11486850E+01 -0.69725578E+01 -0.21727911E-02 -0.22676231E-04 -0.27603420E-01 -0.40172991E-05 -0.38403337E-03 -0.40079459E-05 0.10800416E+03 0.31814256E-03 -0.20496111E-01 -0.41087426E-05 -0.37683306E-03 -0.39328003E-05 -0.52989792E-01 -0.26884237E-04 0.46107399E+00 -0.36531824E+01 0.36138554E+01 -0.64743050E+00 -0.66202847E+00 -0.71102064E+02 -0.20588297E+02 0.10606735E+02 0.50681113E+01 -0.66219948E+00 -0.64715713E+00 -0.43324235E+01 0.77939948E+00 -0.12625714E+00 -0.61753395E+01 0.61088611E+01 -0.98959181E+00 -0.10944165E+01 -0.11190923E+01 -0.12019093E+03 0.18497248E+02 0.17929624E+02 0.85671354E+01 -0.13878147E+01 -0.11193820E+01 -0.10939544E+01 -0.73235287E+01 -0.21290183E-02 -0.22219399E-04 -0.40318724E-01 -0.43439161E-05 -0.39369150E-03 -0.41087426E-05 0.11341229E+03 0.33117479E-03 -0.29311834E-01 -0.47987089E-05 -0.40538554E-03 -0.42307869E-05 -0.52052241E-01 -0.26331117E-04 0.58499962E+00 -0.34773703E+01 0.45827496E+01 -0.68011853E+00 -0.66219948E+00 -0.76112701E+02 -0.21624608E+02 0.10374867E+02 0.58976992E+01 -0.75135589E+00 -0.67902624E+00 -0.41223643E+01 0.98888256E+00 -0.16018912E+00 -0.58781421E+01 0.77466736E+01 -0.12548840E+01 -0.11496714E+01 -0.11193820E+01 -0.12866081E+03 0.19803364E+02 0.17537663E+02 0.99694632E+01 -0.16149535E+01 -0.12700910E+01 -0.11478251E+01 -0.69684400E+01 -0.17730079E-02 -0.18503913E-04 -0.67527563E-01 -0.55295673E-05 -0.45980269E-03 -0.47987089E-05 0.14038514E+03 0.39070966E-03 -0.12654397E-01 -0.62646258E-05 -0.52024449E-03 -0.54295069E-05 -0.49917517E-01 -0.21910194E-04 0.86180402E+00 -0.28132636E+01 0.65958573E+01 -0.84152480E+00 -0.75135589E+00 -0.92621167E+02 -0.26781272E+02 0.95378830E+01 0.46401891E+01 -0.95341677E+00 -0.84106769E+00 -0.33342396E+01 0.14567935E+01 -0.23598159E+00 -0.47555408E+01 0.11149637E+02 -0.18060961E+01 -0.14225135E+01 -0.12700910E+01 -0.15656682E+03 0.24056464E+02 0.16122836E+02 0.78437756E+01 -0.12705895E+01 -0.16116557E+01 -0.14217408E+01 -0.56361987E+01 -0.13791639E-02 -0.14393578E-04 -0.20282098E+00 -0.73339187E-05 -0.60026392E-03 -0.62646258E-05 0.18365159E+03 0.48141925E-03 -0.68042328E-03 -0.71012052E-05 -0.47987493E-01 -0.17045630E-04 0.10974181E+01 -0.21496197E+01 0.11971675E+02 -0.10972324E+01 -0.95341677E+00 -0.11835743E+03 -0.35029675E+02 0.78370049E+01 -0.10825693E+01 -0.25502210E+01 0.18550741E+01 -0.30049472E+00 -0.36337143E+01 0.20236903E+02 -0.32780807E+01 -0.18547602E+01 -0.16116557E+01 -0.20007125E+03 0.30681916E+02 0.13247663E+02 -0.18299736E+01 -0.43108899E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.13515598E-02 -0.14105490E-04 -0.54298008E-03 -0.56667857E-05 0.16194398E+03 0.42654555E-03 -0.54097895E-03 -0.56459011E-05 -0.40204471E-02 -0.56321296E-05 -0.51494177E-01 -0.16715752E-04 0.56322181E+00 -0.24295537E+01 0.15190409E+01 -0.97074826E+00 -0.96038303E+02 -0.30849071E+02 0.82257191E+01 0.97113107E+00 -0.96953747E+00 -0.97089198E+00 -0.28815324E+01 0.95207014E+00 -0.15423474E+00 -0.41069176E+01 0.25677867E+01 -0.41597978E+00 -0.16409528E+01 -0.16234315E+03 0.24921984E+02 0.13904756E+02 0.16416000E+01 -0.26593812E+00 -0.16389061E+01 -0.16411958E+01 -0.48709424E+01 -0.13581805E-02 -0.14174587E-04 -0.80863543E-02 -0.56531335E-05 -0.23869829E-01 -0.56459011E-05 0.16197244E+03 0.43178912E-03 -0.49605957E-03 -0.51771021E-05 -0.59434076E-02 -0.55576398E-05 -0.51778327E-01 -0.16804275E-04 0.53125815E+00 -0.24321006E+01 0.21436200E+01 -0.97084846E+00 -0.96953747E+00 -0.97548639E+02 -0.30853874E+02 0.90974374E+01 0.18954181E+01 -0.88134172E+00 -0.95439186E+00 -0.28857599E+01 0.89803826E+00 -0.14548135E+00 -0.41112205E+01 0.36235731E+01 -0.58701546E+00 -0.16411213E+01 -0.16389061E+01 -0.16489613E+03 0.25323854E+02 0.15378299E+02 0.32040130E+01 -0.51904706E+00 -0.14898192E+01 -0.16133028E+01 -0.48780844E+01 -0.16429276E-02 -0.17146335E-04 -0.55463550E-02 -0.47515669E-05 -0.22403983E-01 -0.51771021E-05 0.13497725E+03 0.37205450E-03 -0.42127940E-03 -0.43966624E-05 -0.44144999E-03 -0.46071718E-05 -0.52196358E-01 -0.20331213E-04 0.49785899E+00 -0.29175561E+01 0.24475345E+01 -0.80898352E+00 -0.88134172E+00 -0.83065857E+02 -0.25717348E+02 0.96022467E+01 0.26464787E+01 -0.73769417E+00 -0.79248720E+00 -0.34613003E+01 0.84158084E+00 -0.13633455E+00 -0.49318369E+01 0.41373122E+01 -0.67023700E+00 -0.13675057E+01 -0.14898192E+01 -0.14041452E+03 0.21575094E+02 0.16231637E+02 0.44736076E+01 -0.72471622E+00 -0.12469982E+01 -0.13396204E+01 -0.58509821E+01 -0.19853381E-02 -0.20719887E-04 -0.86747483E-02 -0.40495827E-05 -0.32578681E-02 -0.43966624E-05 0.11337756E+03 0.32671386E-03 -0.41423520E-02 -0.39426131E-05 -0.37298957E-03 -0.38926879E-05 -0.52842909E-01 -0.24571963E-04 0.44971537E+00 -0.34760615E+01 0.27778289E+01 -0.67953492E+00 -0.73769417E+00 -0.71634305E+02 -0.21607397E+02 0.10343291E+02 0.33352763E+01 -0.66160067E+00 -0.66299625E+00 -0.41229794E+01 0.76019829E+00 -0.12314977E+00 -0.58759299E+01 0.46956385E+01 -0.76067890E+00 -0.11486850E+01 -0.12469982E+01 -0.12109054E+03 0.18620214E+02 0.17484288E+02 0.56379468E+01 -0.91332988E+00 -0.11183689E+01 -0.11207281E+01 -0.69694796E+01 -0.21301373E-02 -0.22231077E-04 -0.17026601E-01 -0.39328003E-05 -0.37777331E-03 -0.39426131E-05 0.10798437E+03 0.31684869E-03 -0.65332251E-02 -0.40245300E-05 -0.36867044E-03 -0.38476115E-05 -0.53129053E-01 -0.26355745E-04 0.44145583E+00 -0.36567886E+01 0.35077310E+01 -0.64715713E+00 -0.66160067E+00 -0.70246557E+02 -0.20583992E+02 0.10613731E+02 0.43322745E+01 -0.66227664E+00 -0.64698723E+00 -0.43366092E+01 0.74623694E+00 -0.12088658E+00 -0.61814354E+01 0.59294684E+01 -0.96054362E+00 -0.10939544E+01 -0.11183689E+01 -0.11874478E+03 0.18273817E+02 0.17941450E+02 0.73232768E+01 -0.11863335E+01 -0.11195124E+01 -0.10936672E+01 -0.73306042E+01 -0.20781249E-02 -0.21688252E-04 -0.32182024E-01 -0.42307869E-05 -0.38562242E-03 -0.40245300E-05 0.11343962E+03 0.32966748E-03 -0.59885713E-01 -0.46855457E-05 -0.40055791E-03 -0.41804036E-05 -0.52581036E-01 -0.25718390E-04 0.51242768E+00 -0.34803075E+01 0.44354063E+01 -0.67902624E+00 -0.66227664E+00 -0.77100192E+02 -0.21620543E+02 0.10397991E+02 0.70993032E+01 -0.75202197E+00 -0.69450959E+00 -0.41274186E+01 0.86620710E+00 -0.14031909E+00 -0.58831074E+01 0.74976051E+01 -0.12145561E+01 -0.11478251E+01 -0.11195124E+01 -0.13033007E+03 0.20084135E+02 0.17576753E+02 0.12000653E+02 -0.19440162E+01 -0.12712170E+01 -0.11739984E+01 -0.69769843E+01 -0.17388043E-02 -0.18146949E-04 -0.57052761E-02 -0.54295069E-05 -0.44895961E-03 -0.46855457E-05 0.14033051E+03 0.38410423E-03 -0.11692933E-01 -0.60745924E-05 -0.51128589E-01 -0.21493975E-04 0.67593607E+00 -0.28086301E+01 0.41559287E+01 -0.84106769E+00 -0.75202197E+00 -0.89553894E+02 -0.26774330E+02 0.86749636E+01 0.41888701E+01 -0.94098208E+00 -0.33292502E+01 0.11426023E+01 -0.18508882E+00 -0.47477083E+01 0.70251819E+01 -0.11380010E+01 -0.14217408E+01 -0.12712170E+01 -0.15138190E+03 0.23233965E+02 0.14664157E+02 0.70808660E+01 -0.11470212E+01 -0.15906361E+01 -0.56277646E+01 -0.13947605E-02 -0.14556352E-04 -0.82597725E-02 -0.71012052E-05 -0.58205529E-03 -0.60745924E-05 0.17807479E+03 0.46162173E-03 -0.50210142E-01 -0.17234427E-04 0.78644259E+00 -0.22165275E+01 0.57988949E+01 -0.10825693E+01 -0.94098208E+00 -0.10879048E+03 -0.33989894E+02 0.68709941E+01 -0.26270897E+01 0.13294014E+01 -0.21534613E+00 -0.37468149E+01 0.98024438E+01 -0.15878712E+01 -0.18299736E+01 -0.15906361E+01 -0.18389928E+03 0.28136886E+02 0.11614721E+02 -0.44408299E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.13447343E-02 -0.14034255E-04 -0.53965939E-03 -0.56321296E-05 0.16194250E+03 0.42059232E-03 -0.52827979E-03 -0.55133669E-05 -0.51491502E-01 -0.16632414E-04 0.55729081E+00 -0.24280655E+01 0.10590800E+01 -0.97089198E+00 -0.94979557E+02 -0.30846670E+02 0.72356360E+01 0.37497811E+00 -0.95329954E+00 -0.28799247E+01 0.94204439E+00 -0.15261097E+00 -0.41044020E+01 0.17902689E+01 -0.29002313E+00 -0.16411958E+01 -0.16055344E+03 0.24637981E+02 0.12231119E+02 0.63386300E+00 -0.10268565E+00 -0.16114575E+01 -0.48682248E+01 -0.13945990E-02 -0.14554666E-04 -0.53252193E-03 -0.55576398E-05 -0.21480390E-01 -0.55133669E-05 0.15656494E+03 0.41907539E-03 -0.47280605E-03 -0.49344178E-05 -0.48938068E-03 -0.51073982E-05 -0.51839685E-01 -0.17256323E-04 0.52039201E+00 -0.25147666E+01 0.16215986E+01 -0.95439186E+00 -0.95329954E+00 -0.93134441E+02 -0.29821783E+02 0.91453456E+01 0.11083786E+01 -0.84869448E+00 -0.88708335E+00 -0.29837693E+01 0.87967001E+00 -0.14250631E+00 -0.42509584E+01 0.27411483E+01 -0.44406532E+00 -0.16133028E+01 -0.16114575E+01 -0.15743434E+03 0.24170331E+02 0.15459282E+02 0.18736018E+01 -0.30352301E+00 -0.14346321E+01 -0.14995246E+01 -0.50437600E+01 -0.16936419E-02 -0.17675613E-04 -0.27509738E-02 -0.46071718E-05 -0.28855918E-01 -0.49344178E-05 0.12958883E+03 0.35951497E-03 -0.39681458E-03 -0.41413365E-05 -0.40048567E-03 -0.41796496E-05 -0.52323006E-01 -0.20957870E-04 0.48137961E+00 -0.30387763E+01 0.20158029E+01 -0.79248720E+00 -0.84869448E+00 -0.78577491E+02 -0.24685307E+02 0.97176880E+01 0.17006406E+01 -0.70527590E+00 -0.72489488E+00 -0.36047923E+01 0.81372409E+00 -0.13182259E+00 -0.51367475E+01 0.34075133E+01 -0.55201418E+00 -0.13396204E+01 -0.14346321E+01 -0.13282739E+03 0.20401186E+02 0.16426779E+02 0.28747629E+01 -0.46570909E+00 -0.11921984E+01 -0.12253623E+01 -0.60935410E+01 -0.20526183E-02 -0.21422054E-04 -0.10229231E-01 -0.38926879E-05 -0.11539562E-01 -0.41413365E-05 0.10799165E+03 0.31497476E-03 -0.36857629E-03 -0.38466289E-05 -0.35959229E-03 -0.37528679E-05 -0.52937329E-01 -0.25405001E-04 0.43884976E+00 -0.36479617E+01 0.24661872E+01 -0.66299625E+00 -0.70527590E+00 -0.66997482E+02 -0.20575274E+02 0.10639110E+02 0.21151711E+01 -0.64674675E+00 -0.64714282E+00 -0.43266793E+01 0.74183114E+00 -0.12017539E+00 -0.61665103E+01 0.41688401E+01 -0.67534503E+00 -0.11207281E+01 -0.11921984E+01 -0.11325247E+03 0.17405884E+02 0.17984341E+02 0.35754831E+01 -0.57922216E+00 -0.10932600E+01 -0.10939295E+01 -0.73138141E+01 -0.20800183E-02 -0.21708012E-04 -0.17480067E-01 -0.38476115E-05 -0.41808220E-02 -0.38466289E-05 0.10798712E+03 0.31546660E-03 -0.46396661E-03 -0.40290025E-05 -0.36280034E-03 -0.37863485E-05 -0.53056770E-01 -0.25735744E-04 0.42656881E+00 -0.36489216E+01 0.35522180E+01 -0.64698723E+00 -0.64674675E+00 -0.68038213E+02 -0.20579659E+02 0.10596529E+02 0.20882388E+01 -0.67748189E+00 -0.64687038E+00 -0.43272116E+01 0.72107192E+00 -0.11681147E+00 -0.61681371E+01 0.60046692E+01 -0.97273828E+00 -0.10936672E+01 -0.10932600E+01 -0.11501180E+03 0.17679983E+02 0.17912372E+02 0.35299588E+01 -0.57184267E+00 -0.11452154E+01 -0.10934697E+01 -0.73147185E+01 -0.19161989E-02 -0.19998318E-04 -0.25132937E-01 -0.41804036E-05 -0.38605096E-03 -0.40290025E-05 0.11877676E+03 0.33397726E-03 -0.41260535E-03 -0.43061361E-05 -0.52823657E-01 -0.23699441E-04 0.44637846E+00 -0.33203392E+01 0.62154245E+01 -0.69450959E+00 -0.67748189E+00 -0.74824506E+02 -0.22641647E+02 0.93592333E+01 -0.72755535E+00 -0.39368051E+01 0.75455772E+00 -0.12223526E+00 -0.56126982E+01 0.10506548E+02 -0.17020177E+01 -0.11739984E+01 -0.11452154E+01 -0.12648328E+03 0.19433192E+02 0.15820839E+02 -0.12298587E+01 -0.66547709E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.15486360E-02 -0.16162266E-04 -0.13177635E-02 -0.51073982E-05 0.14035733E+03 0.37303392E-03 -0.41502002E-03 -0.43313367E-05 -0.52088389E-01 -0.19158914E-04 0.49811720E+00 -0.28052857E+01 0.96498412E+00 -0.88708335E+00 -0.82325452E+02 -0.26735187E+02 0.77740211E+01 0.27443005E+00 -0.75114428E+00 -0.33275135E+01 0.84201672E+00 -0.13640684E+00 -0.47420516E+01 0.16312080E+01 -0.26425593E+00 -0.14995246E+01 -0.13916285E+03 0.21352282E+02 0.13141196E+02 0.46389624E+00 -0.75151254E-01 -0.12697334E+01 -0.56248248E+01 -0.19188510E-02 -0.20025997E-04 -0.91575328E-03 -0.41796496E-05 -0.25369610E-01 -0.43313367E-05 0.11339891E+03 0.32508782E-03 -0.36819004E-03 -0.38425978E-05 -0.42051555E-03 -0.38229533E-05 -0.52643162E-01 -0.23743447E-04 0.45778494E+00 -0.34716727E+01 0.14703649E+01 -0.72489488E+00 -0.75114428E+00 -0.67964341E+02 -0.21597166E+02 0.10393410E+02 0.95055489E+00 -0.66255674E+00 -0.66299206E+00 -0.41177292E+01 0.77383966E+00 -0.12536194E+00 -0.58685156E+01 0.24855048E+01 -0.40265152E+00 -0.12253623E+01 -0.12697334E+01 -0.11488692E+03 0.17640585E+02 0.17569019E+02 0.16068180E+01 -0.26030434E+00 -0.11199859E+01 -0.11207218E+01 -0.69606094E+01 -0.20263996E-02 -0.21148424E-04 -0.42983185E-02 -0.37528679E-05 -0.14398817E-01 -0.38425978E-05 0.10799211E+03 0.31387052E-03 -0.36281552E-03 -0.37865069E-05 -0.57231082E-03 -0.37528929E-05 -0.52986287E-01 -0.25073077E-04 0.41947629E+00 -0.36451450E+01 0.19446345E+01 -0.64714282E+00 -0.66255674E+00 -0.65831628E+02 -0.20572200E+02 0.10574418E+02 0.14859701E+01 -0.64683245E+00 -0.64709638E+00 -0.43233388E+01 0.70908224E+00 -0.11487093E+00 -0.61617491E+01 0.32872081E+01 -0.53252586E+00 -0.10939295E+01 -0.11199859E+01 -0.11128171E+03 0.17094281E+02 0.17874985E+02 0.25118822E+01 -0.40692347E+00 -0.10934048E+01 -0.10938507E+01 -0.73081667E+01 -0.20472526E-02 -0.21366055E-04 -0.43670855E-02 -0.37863485E-05 -0.42436261E-02 -0.37865069E-05 0.10797900E+03 0.31484536E-03 -0.39241329E-03 -0.40954026E-05 -0.89023778E-03 -0.39670213E-05 -0.53021985E-01 -0.25330574E-04 0.42670123E+00 -0.36487932E+01 0.25733037E+01 -0.64687038E+00 -0.64683245E+00 -0.66940390E+02 -0.20575438E+02 0.10641571E+02 0.19633149E+01 -0.69187750E+00 -0.67766514E+00 -0.43272245E+01 0.72129575E+00 -0.11684882E+00 -0.61679201E+01 0.43499125E+01 -0.70467922E+00 -0.10934697E+01 -0.10934048E+01 -0.11315604E+03 0.17389873E+02 0.17988511E+02 0.33187875E+01 -0.53763854E+00 -0.11695497E+01 -0.11455251E+01 -0.73147403E+01 -0.18007609E-02 -0.18793556E-04 -0.91781122E-02 -0.43061361E-05 -0.43665315E-02 -0.40954026E-05 0.12416444E+03 0.33985653E-03 -0.52728554E-01 -0.22272105E-04 0.43795089E+00 -0.31730689E+01 0.30722658E+01 -0.72755535E+00 -0.69187750E+00 -0.74777714E+02 -0.23666192E+02 0.83579258E+01 -0.37627684E+01 0.74031168E+00 -0.11992867E+00 -0.53637519E+01 0.51933545E+01 -0.84131068E+00 -0.12298587E+01 -0.11695497E+01 -0.12640416E+03 0.19383922E+02 0.14128229E+02 -0.63605797E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.19994199E-02 -0.20866851E-04 -0.36630774E-03 -0.38229533E-05 0.10798444E+03 0.30936880E-03 -0.35610536E-03 -0.37164766E-05 -0.52512808E-02 -0.37048953E-05 -0.52989099E-01 -0.24741284E-04 0.41131826E+00 -0.36438231E+01 0.11718104E+01 -0.66299206E+00 -0.64108336E+02 -0.20566613E+02 0.99250470E+01 0.53596728E+00 -0.64700011E+00 -0.64715796E+00 -0.43217700E+01 0.69529239E+00 -0.11263776E+00 -0.61595186E+01 0.19808284E+01 -0.32089530E+00 -0.11207218E+01 -0.10836873E+03 0.16636125E+02 0.16777299E+02 0.90599909E+00 -0.14677236E+00 -0.10936890E+01 -0.10939558E+01 -0.73055200E+01 -0.20057856E-02 -0.20933286E-04 -0.35959469E-03 -0.37528929E-05 -0.13898480E-01 -0.37164766E-05 0.10799500E+03 0.31337447E-03 -0.37552166E-03 -0.39191139E-05 -0.47921739E-02 -0.37167668E-05 -0.53004344E-01 -0.24821271E-04 0.40990778E+00 -0.36437176E+01 0.15360070E+01 -0.64709638E+00 -0.64700011E+00 -0.64988562E+02 -0.20569350E+02 0.10586380E+02 0.10571098E+01 -0.67798617E+00 -0.64705268E+00 -0.43212217E+01 0.69290745E+00 -0.11225128E+00 -0.61593344E+01 0.25964637E+01 -0.42062815E+00 -0.10938507E+01 -0.10936890E+01 -0.10985656E+03 0.16870519E+02 0.17895203E+02 0.17869368E+01 -0.28948447E+00 -0.11460667E+01 -0.10937772E+01 -0.73045892E+01 -0.18360530E-02 -0.19161880E-04 -0.38011205E-03 -0.39670213E-05 -0.41560972E-02 -0.39191139E-05 0.11876910E+03 0.32753322E-03 -0.52835255E-01 -0.22719784E-04 0.41682311E+00 -0.33137845E+01 0.21087471E+01 -0.67766514E+00 -0.67798617E+00 -0.70706098E+02 -0.22628834E+02 0.86024284E+01 -0.39304561E+01 0.70459778E+00 -0.11414460E+00 -0.56016213E+01 0.35646261E+01 -0.57746821E+00 -0.11455251E+01 -0.11460667E+01 -0.11952159E+03 0.18337250E+02 0.14541544E+02 -0.66440430E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.19891465E-02 -0.20759632E-04 -0.35499566E-03 -0.37048953E-05 0.10798140E+03 0.30528560E-03 -0.35354396E-03 -0.36897447E-05 -0.53043057E-01 -0.24614233E-04 0.39883469E+00 -0.36426386E+01 0.76395676E+00 -0.64715796E+00 -0.63334227E+02 -0.20564573E+02 0.92594774E+01 0.17939655E+00 -0.64701297E+00 -0.43203650E+01 0.67419016E+00 -0.10921948E+00 -0.61575162E+01 0.12913925E+01 -0.20920688E+00 -0.10939558E+01 -0.10706018E+03 0.16429162E+02 0.15652221E+02 0.30325193E+00 -0.49127116E-01 -0.10937107E+01 -0.73031450E+01 -0.19913866E-02 -0.20783011E-04 -0.35613316E-03 -0.37167668E-05 -0.14356213E-01 -0.36897447E-05 0.10799313E+03 0.30534932E-03 -0.53060893E-01 -0.24644423E-04 0.39904024E+00 -0.36436564E+01 0.11204141E+01 -0.64705268E+00 -0.64701297E+00 -0.63508591E+02 -0.20566709E+02 0.92615989E+01 -0.43215731E+01 0.67453723E+00 -0.10927570E+00 -0.61592331E+01 0.18939468E+01 -0.30682126E+00 -0.10937772E+01 -0.10937107E+01 -0.10735486E+03 0.16471721E+02 0.15655799E+02 -0.73051832E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.25971423E+01 -0.17988385E+00 0.20608732E+03 0.42725065E+00 -0.43744598E+00 -0.81460968E-01 -0.41557028E+01 -0.86020643E-01 0.67813736E+01 -0.90410623E+00 -0.13475629E+03 -0.27720556E+02 0.17489967E+01 0.44770925E+00 -0.40941591E+00 0.13190091E+02 -0.43240035E+00 0.11463234E+02 -0.10989584E+01 -0.15283012E+01 -0.22779204E+03 0.25292823E+02 0.29565041E+01 0.75680772E+00 -0.72553717E-01 -0.69207666E+00 0.22296530E+02 -0.21375259E+01 -0.73092956E+00 -0.15646243E+01 -0.95840005E-01 -0.59736957E+00 -0.81460968E-01 0.19213530E+03 0.33537638E+00 -0.29022544E+00 -0.38350367E-01 -0.24885005E+01 -0.40056499E-01 0.57342234E+01 -0.13780428E+01 -0.40941591E+00 -0.12662709E+03 -0.28872728E+02 0.29181068E+01 0.25214740E+00 -0.55141574E+00 0.13032447E+02 -0.57602974E+00 0.96931234E+01 -0.10942175E+01 -0.23294416E+01 -0.69207666E+00 -0.21405027E+03 0.26519672E+02 0.49327643E+01 0.42622967E+00 -0.48115337E-01 -0.93211241E+00 0.22030033E+02 -0.24868810E+01 -0.97371988E+00 -0.99109871E+00 -0.48389152E-01 -0.43030649E+00 -0.38350367E-01 0.17850343E+03 0.18406498E+00 -0.15899806E+01 -0.17817074E-01 0.49601271E+01 -0.18565169E+01 -0.55141574E+00 -0.11776387E+03 -0.29017221E+02 0.30948062E+01 0.11924609E+02 -0.68365407E+00 0.83845988E+01 -0.10812350E+01 -0.31382562E+01 -0.93211241E+00 -0.19906804E+03 0.26676978E+02 0.52314596E+01 0.20157360E+02 -0.25993900E+01 -0.11556488E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.10598457E+01 -0.56946019E-01 0.29681124E+03 0.19437580E+00 -0.32797939E+01 -0.57327535E-01 0.43202257E+01 -0.90660211E+00 -0.18942500E+03 -0.45507683E+02 0.18244089E+01 0.16991600E+02 -0.91275390E+00 0.73029095E+01 -0.84853454E+00 -0.15325202E+01 -0.32020402E+03 0.40208884E+02 0.30839808E+01 0.28722601E+02 -0.33373163E+01 -0.15429192E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.16396503E+01 -0.10601787E+00 0.27574247E+03 0.36499262E+00 -0.61507789E+00 -0.86551270E-01 -0.44085565E+01 -0.92258094E-01 0.50504538E+01 -0.76576743E+00 -0.17744806E+03 -0.38965438E+02 0.20616847E+01 0.90536898E+00 -0.62514227E+00 0.16821468E+02 -0.66644976E+00 0.85372823E+01 -0.86332697E+00 -0.12944525E+01 -0.29995803E+03 0.34751750E+02 0.34850699E+01 0.15304349E+01 -0.15476419E+00 -0.10567399E+01 0.28434994E+02 -0.28754695E+01 -0.11265661E+01 -0.93051390E+00 -0.50587676E-01 -0.78096942E+00 -0.86551270E-01 0.25031789E+03 0.28883617E+00 -0.32579693E+00 -0.34705689E-01 -0.26040483E+01 -0.37153598E-01 0.40955182E+01 -0.11961635E+01 -0.62514227E+00 -0.16186823E+03 -0.39385424E+02 0.35248979E+01 0.39373351E+00 -0.82061419E+00 0.16163394E+02 -0.87860497E+00 0.69230640E+01 -0.84521630E+00 -0.20219947E+01 -0.10567399E+01 -0.27362206E+03 0.35440174E+02 0.59584868E+01 0.66556713E+00 -0.81257112E-01 -0.13871662E+01 0.27322602E+02 -0.33357352E+01 -0.14851938E+01 -0.84718938E+00 -0.25902910E-01 -0.55655431E+00 -0.34705689E-01 0.23133653E+03 0.17179654E+00 -0.29991573E+00 -0.15280895E-01 -0.15088876E+01 -0.16257926E-01 0.42913868E+01 -0.15525563E+01 -0.82061419E+00 -0.15005877E+03 -0.38687284E+02 0.42679152E+01 0.15790958E+00 -0.91589138E+00 0.14485912E+02 -0.97455670E+00 0.72541553E+01 -0.95604276E+00 -0.26244395E+01 -0.13871662E+01 -0.25365918E+03 0.34830996E+02 0.72144801E+01 0.26693018E+00 -0.35179377E-01 -0.15482218E+01 0.24486970E+02 -0.32271970E+01 -0.16473896E+01 -0.44712793E+00 -0.10826631E-01 -0.29355577E+01 -0.86020643E-01 -0.52147888E+00 -0.15280895E-01 0.21531326E+03 0.12170622E+00 -0.10698811E+00 -0.31350724E-02 -0.73065393E+00 -0.58063662E-02 0.17302139E+01 -0.19560092E+01 -0.43240035E+00 -0.91589138E+00 -0.13496158E+03 -0.37418826E+02 0.53905033E+01 -0.10329256E+01 0.12199921E+02 -0.10491197E+01 0.29247536E+01 -0.41335937E+00 -0.33064380E+01 -0.73092956E+00 -0.15482218E+01 -0.22813906E+03 0.32922321E+02 0.91121048E+01 -0.17460565E+01 0.20622746E+02 -0.29146405E+01 -0.17734320E+01 -0.29366187E+00 -0.68230113E-02 -0.13669761E+01 -0.40056499E-01 -0.18661935E+00 -0.31350724E-02 0.19551180E+03 0.56089800E-01 -0.83317449E-01 -0.24414511E-02 -0.55883715E+00 -0.30823466E-02 0.13289956E+01 -0.22480915E+01 -0.57602974E+00 0.18415965E+01 -0.10329256E+01 -0.12451462E+03 -0.34875408E+02 0.58534598E+01 -0.97684548E+00 0.10400277E+02 -0.10156925E+01 0.22465328E+01 -0.33455223E+00 -0.38001718E+01 -0.97371988E+00 0.31130329E+01 -0.46359086E+00 -0.17460565E+01 -0.21047939E+03 0.30994421E+02 0.98946836E+01 -0.16512596E+01 0.17580618E+02 -0.26180942E+01 -0.17169257E+01 -0.38461282E+00 -0.61008077E-02 -0.10074344E+01 -0.17817074E-01 -0.18152092E+00 -0.24414511E-02 0.18327200E+03 0.29297710E-01 -0.37470591E+00 -0.24309867E-02 0.14905014E+01 -0.24410548E+01 -0.68365407E+00 0.16902004E+01 -0.97684548E+00 -0.11646374E+03 -0.32951383E+02 0.50780055E+01 0.90636068E+01 -0.97278993E+00 0.25195436E+01 -0.36847132E+00 -0.41263590E+01 -0.11556488E+01 0.28571148E+01 -0.41783950E+00 -0.16512596E+01 -0.19687031E+03 0.29082529E+02 0.85838604E+01 0.15321121E+02 -0.22406414E+01 -0.16444041E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.30967807E+00 -0.68032816E-02 -0.19563709E+01 -0.57327535E-01 0.29596269E+03 0.81607565E-01 -0.33311843E+00 -0.97613690E-02 -0.91982911E+00 -0.68459793E-02 0.17834780E+01 -0.14328639E+01 -0.91275390E+00 -0.18566944E+03 -0.52249143E+02 0.51741385E+01 -0.13807167E+01 0.15807417E+02 -0.14419946E+01 0.30147912E+01 -0.43302307E+00 -0.24221131E+01 -0.15429192E+01 -0.31385562E+03 0.45541410E+02 0.87463620E+01 -0.23339618E+01 0.26720858E+02 -0.38379931E+01 -0.24375476E+01 -0.47974428E+00 -0.96598344E-02 -0.34809373E+00 -0.97613690E-02 0.29481710E+03 0.11867912E+00 -0.23723633E+00 -0.97613843E-02 -0.13068024E+01 -0.97302577E-02 0.28271925E+01 -0.13664069E+01 0.63114563E+00 -0.13807167E+01 -0.18761480E+03 -0.51494702E+02 0.54655191E+01 -0.13361793E+01 0.16075890E+02 -0.13764911E+01 0.47790828E+01 -0.68126319E+00 -0.23097726E+01 0.10668878E+01 -0.15208596E+00 -0.23339618E+01 -0.31714383E+03 0.45386677E+02 0.92389084E+01 -0.22586774E+01 0.27174665E+02 -0.38737766E+01 -0.23268189E+01 -0.53440022E+00 -0.12395542E-01 -0.22070197E+00 -0.97613843E-02 0.29491118E+03 0.12905618E+00 -0.33024883E+00 -0.14606511E-01 -0.13780511E+01 -0.12496808E-01 0.32197658E+01 -0.13213394E+01 0.23582194E+00 -0.13361793E+01 -0.18821336E+03 -0.50966088E+02 0.52984249E+01 -0.13029946E+01 0.16674148E+02 -0.13322460E+01 0.54426922E+01 -0.75084820E+00 -0.22335922E+01 0.39863340E+00 -0.54993585E-01 -0.22586774E+01 -0.31815586E+03 0.44963881E+02 0.89564554E+01 -0.22025800E+01 0.28185979E+02 -0.38884051E+01 -0.22520286E+01 -0.58237589E+00 -0.14442702E-01 -0.34512318E+00 -0.14606511E-01 0.29515983E+03 0.13803140E+00 -0.33017192E+00 -0.14603109E-01 -0.14531784E+01 -0.14561047E-01 0.32091214E+01 -0.12884342E+01 0.24120100E+00 -0.13029946E+01 -0.18867034E+03 -0.50571975E+02 0.51990686E+01 -0.13029156E+01 0.17134703E+02 -0.12991028E+01 0.54246936E+01 -0.72975635E+00 -0.21779671E+01 0.40772578E+00 -0.54849268E-01 -0.22025800E+01 -0.31892805E+03 0.44643506E+02 0.87884993E+01 -0.22024485E+01 0.28964476E+02 -0.38964426E+01 -0.21960012E+01 -0.54870071E+00 -0.14434007E-01 -0.34452271E+00 -0.14603109E-01 0.29519042E+03 0.13772053E+00 -0.39655657E+00 -0.14302015E-01 -0.14513846E+01 -0.14563380E-01 0.26632591E+01 -0.12878855E+01 0.23108844E+00 -0.13029156E+01 -0.18840910E+03 -0.50572276E+02 0.51720305E+01 0.32512559E+00 -0.12760733E+01 0.17104165E+02 -0.12995346E+01 0.45019731E+01 -0.60564353E+00 -0.21770417E+01 0.39063189E+00 -0.52551108E-01 -0.22024485E+01 -0.31848675E+03 0.44584784E+02 0.87428003E+01 0.54959229E+00 -0.73935807E-01 -0.21570743E+01 0.28912880E+02 -0.38896053E+01 -0.21967333E+01 -0.34095124E+00 -0.82969956E-02 -0.31484183E+01 -0.92258094E-01 -0.48807342E+00 -0.14302015E-01 0.28583675E+03 0.12751677E+00 -0.13435734E+00 -0.39370728E-02 -0.97714131E+00 -0.78713173E-02 0.12994774E+01 -0.14623719E+01 -0.66644976E+00 -0.12760733E+01 -0.17893272E+03 -0.49860319E+02 0.62021635E+01 -0.14042632E+01 0.16275427E+02 -0.13874621E+01 0.21966357E+01 -0.30957355E+00 -0.24719924E+01 -0.11265661E+01 -0.21570743E+01 -0.30246773E+03 0.43576472E+02 0.10484134E+02 -0.23737664E+01 0.27511970E+02 -0.38772832E+01 -0.23453649E+01 -0.29504895E+00 -0.46541406E-02 -0.21007833E+01 -0.37153598E-01 -0.26304068E+00 -0.39370728E-02 0.26662637E+03 0.52795262E-01 -0.13656872E+00 -0.24152988E-02 -0.63341179E+00 -0.38897599E-02 0.11842029E+01 -0.16601180E+01 -0.87860497E+00 0.15518434E+01 -0.14042632E+01 -0.16978536E+03 -0.47687417E+02 0.66794454E+01 -0.13435779E+01 0.15780879E+02 -0.13875787E+01 0.20017766E+01 -0.28967534E+00 -0.28062634E+01 -0.14851938E+01 0.26232360E+01 -0.37960619E+00 -0.23737664E+01 -0.28700517E+03 0.42190864E+02 0.11290933E+02 -0.22711827E+01 0.26675998E+02 -0.38602604E+01 -0.23455630E+01 -0.22019369E+00 -0.33956081E-02 -0.91927516E+00 -0.16257926E-01 -0.18953279E+00 -0.24152988E-02 0.24169261E+03 0.26043391E-01 -0.53069369E-01 -0.93856322E-03 -0.51077148E+00 -0.23842212E-02 0.11119848E+01 -0.18889917E+01 -0.97455670E+00 0.20469679E+01 -0.13435779E+01 -0.15535403E+03 -0.43939068E+02 0.68279238E+01 -0.12894421E+01 0.14375670E+02 -0.13264689E+01 0.18796978E+01 -0.28178126E+00 -0.31931494E+01 -0.16473896E+01 0.34601925E+01 -0.51870963E+00 -0.22711827E+01 -0.26261028E+03 0.39136646E+02 0.11541916E+02 -0.21796728E+01 0.24300617E+02 -0.36428508E+01 -0.22422615E+01 -0.15634686E+00 -0.15465596E-02 -0.55635440E+00 -0.58063662E-02 -0.11556991E+00 -0.93856322E-03 0.22336393E+03 0.10440761E-01 -0.62428621E-01 -0.65153333E-03 -0.22303952E+00 -0.92559310E-03 0.79859598E+00 -0.21248446E+01 -0.10491197E+01 0.24947264E+01 -0.12894421E+01 -0.14421959E+03 -0.41297090E+02 0.69523798E+01 -0.12125901E+01 0.13195320E+02 -0.12717896E+01 0.13499466E+01 -0.20421983E+00 -0.35918374E+01 -0.17734320E+01 0.42170855E+01 -0.63796040E+00 -0.21796728E+01 -0.24378879E+03 0.36812861E+02 0.11752301E+02 -0.20497609E+01 0.22305368E+02 -0.33743546E+01 -0.21498331E+01 -0.12770622E+00 -0.12616964E-02 -0.29534429E+00 -0.30823466E-02 -0.93203764E-01 -0.65153333E-03 0.20543003E+03 0.65246799E-02 -0.35684063E-01 -0.37241503E-03 -0.17500042E+00 -0.64179336E-03 0.67186696E+00 -0.23482642E+01 -0.10156925E+01 0.30248844E+01 -0.12125901E+01 -0.13262705E+03 -0.38253343E+02 0.69288974E+01 -0.11534979E+01 0.11284571E+02 -0.11945971E+01 0.11357231E+01 -0.17486584E+00 -0.39695031E+01 -0.17169257E+01 0.51132610E+01 -0.78728226E+00 -0.20497609E+01 -0.22419261E+03 0.34089825E+02 0.11712602E+02 -0.19498729E+01 0.19075426E+02 -0.29370187E+01 -0.20193456E+01 -0.85011201E-01 -0.82063256E-03 -0.23293228E+00 -0.24309867E-02 -0.66743872E-01 -0.37241503E-03 0.19346372E+03 0.44624599E-02 -0.74440291E-01 -0.36626510E-03 0.62918306E+00 -0.25418704E+01 -0.97278993E+00 0.30489591E+01 -0.11534979E+01 -0.12100872E+03 -0.36306218E+02 0.58067595E+01 0.64090076E+01 -0.11345621E+01 0.10635711E+01 -0.16709874E+00 -0.42967777E+01 -0.16444041E+01 0.51539605E+01 -0.80974397E+00 -0.19498729E+01 -0.20455313E+03 0.31328710E+02 0.98157463E+01 0.10833787E+02 -0.17021073E+01 -0.19178638E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.98766101E-01 -0.92950667E-03 -0.65596805E+00 -0.68459793E-02 0.29352001E+03 0.10396617E-01 -0.93000819E-01 -0.94227837E-03 -0.25620509E+00 -0.94049579E-03 0.95313717E+00 -0.16372305E+01 -0.14419946E+01 -0.18558381E+03 -0.50099419E+02 0.64016278E+01 0.27167489E+00 -0.16596434E+01 0.16314945E+02 -0.16566787E+01 0.16111831E+01 -0.24736688E+00 -0.27675744E+01 -0.24375476E+01 -0.31371087E+03 0.55228420E+02 0.10821312E+02 0.45923923E+00 -0.70507554E-01 -0.28054613E+01 0.27578783E+02 -0.42342038E+01 -0.28004497E+01 -0.11706066E+00 -0.11066138E-02 -0.93233383E+00 -0.97302577E-02 -0.90287229E-01 -0.94227837E-03 0.29394698E+03 0.14768954E-01 -0.11206181E+00 -0.11217214E-02 -0.27705098E+00 -0.11192633E-02 0.10766425E+01 -0.16200209E+01 -0.13764911E+01 -0.16596434E+01 -0.18620080E+03 -0.54424641E+02 0.79428916E+01 0.40444868E+00 -0.16420458E+01 0.16672940E+02 -0.16386315E+01 0.18199554E+01 -0.27645389E+00 -0.27384818E+01 -0.23268189E+01 -0.28054613E+01 -0.31475365E+03 0.47565742E+02 0.13426657E+02 0.68367964E+00 -0.10385194E+00 -0.27757126E+01 0.28183922E+02 -0.42811790E+01 -0.27699410E+01 -0.12019010E+00 -0.16294661E-02 -0.70660953E+00 -0.12496808E-01 -0.63425720E-01 -0.11217214E-02 0.29394226E+03 0.19313937E-01 -0.99581074E-01 -0.16515049E-02 -0.53094432E+00 -0.16469005E-02 0.11063236E+01 -0.15896856E+01 -0.13322460E+01 -0.16420458E+01 -0.18614785E+03 -0.54087451E+02 0.77879090E+01 0.23826939E+00 -0.16111141E+01 0.16752403E+02 -0.16067971E+01 0.18701294E+01 -0.28829951E+00 -0.26872046E+01 -0.22520286E+01 -0.27757126E+01 -0.31466433E+03 0.47365100E+02 0.13164680E+02 0.40277057E+00 -0.62091190E-01 -0.27234273E+01 0.28318262E+02 -0.43655487E+01 -0.27161298E+01 -0.13991115E+00 -0.20021021E-02 -0.82332821E+00 -0.14561047E-01 -0.93381374E-01 -0.16515049E-02 0.29418307E+03 0.23420341E-01 -0.13599737E+00 -0.24051940E-02 -0.56806606E+00 -0.20241031E-02 0.10531180E+01 -0.15754464E+01 -0.12991028E+01 -0.16111141E+01 -0.18645872E+03 -0.53928425E+02 0.76666907E+01 -0.15821610E+01 0.17353461E+02 -0.15928640E+01 0.17801893E+01 -0.27197895E+00 -0.26631324E+01 -0.21960012E+01 -0.27234273E+01 -0.31518956E+03 0.47280929E+02 0.12959767E+02 -0.26744850E+01 0.29334266E+02 -0.44817162E+01 -0.26925751E+01 -0.15717120E+00 -0.23738115E-02 -0.82346008E+00 -0.14563380E-01 -0.14350652E+00 -0.24051940E-02 0.29422033E+03 0.23826699E-01 -0.73488376E-01 -0.12996855E-02 -0.59882884E+00 -0.23994175E-02 0.91004946E+00 -0.15615681E+01 -0.12995346E+01 0.28805878E+00 -0.15821610E+01 -0.18697054E+03 -0.53769714E+02 0.76521091E+01 -0.16243419E+01 0.17718613E+02 -0.15785190E+01 0.15383476E+01 -0.23291596E+00 -0.26396747E+01 -0.21967333E+01 0.48693456E+00 -0.73725097E-01 -0.26744850E+01 -0.31605500E+03 0.47247887E+02 0.12935123E+02 -0.27457858E+01 0.29951544E+02 -0.45348610E+01 -0.26683286E+01 -0.13041278E+00 -0.12818297E-02 -0.75421388E+00 -0.78713173E-02 -0.13407438E+00 -0.12996855E-02 0.29384226E+03 0.13481846E-01 -0.93191329E-01 -0.97258687E-03 -0.30950011E+00 -0.12972209E-02 0.74406680E+00 -0.16021115E+01 -0.13874621E+01 0.89881285E+00 -0.16243419E+01 -0.18788211E+03 -0.54236743E+02 0.78435408E+01 -0.16021489E+01 0.18189066E+02 -0.16214392E+01 0.12577697E+01 -0.18902202E+00 -0.27082075E+01 -0.23453649E+01 0.15193522E+01 -0.22833356E+00 -0.27457858E+01 -0.31759570E+03 0.47803050E+02 0.13258715E+02 -0.27082724E+01 0.30746777E+02 -0.46207335E+01 -0.27408791E+01 -0.10800179E+00 -0.10533314E-02 -0.37270901E+00 -0.38897599E-02 -0.11099011E+00 -0.97258687E-03 0.27579034E+03 0.81467754E-02 -0.53900889E-01 -0.56253407E-03 -0.27171014E+00 -0.97113407E-03 0.69758497E+00 -0.17352467E+01 -0.13875787E+01 0.17518766E+01 -0.16021489E+01 -0.17796595E+03 -0.51274641E+02 0.78678110E+01 -0.15372026E+01 0.17552672E+02 -0.15999259E+01 0.11791976E+01 -0.18038458E+00 -0.29332610E+01 -0.23455630E+01 0.29613722E+01 -0.45300793E+00 -0.27082724E+01 -0.30083364E+03 0.45592825E+02 0.13299746E+02 -0.25984856E+01 0.29671036E+02 -0.45388468E+01 -0.27045147E+01 -0.72669536E-01 -0.69405673E-03 -0.22845131E+00 -0.23842212E-02 -0.78869753E-01 -0.56253407E-03 0.25793638E+03 0.50683106E-02 -0.22847552E-01 -0.23844739E-03 -0.20865268E+00 -0.55588756E-03 0.60934250E+00 -0.18967026E+01 -0.13264689E+01 0.24509331E+01 -0.15372026E+01 -0.16719294E+03 -0.48357234E+02 0.77299432E+01 -0.14449656E+01 0.16255375E+02 -0.15192191E+01 0.10300319E+01 -0.16116763E+00 -0.32061840E+01 -0.22422615E+01 0.41430546E+01 -0.64825788E+00 -0.25984856E+01 -0.28262276E+03 0.43219585E+02 0.13066689E+02 -0.24425698E+01 0.27478068E+02 -0.42994544E+01 -0.25680863E+01 -0.10509246E-02 -0.10967924E-04 -0.88688480E-01 -0.92559310E-03 -0.54919468E-01 -0.23844739E-03 0.23420959E+03 0.19744794E-02 -0.64639159E-03 -0.67460351E-05 -0.13424802E+00 -0.23272242E-03 0.49940552E+00 -0.21277579E+01 -0.12717896E+01 0.31495184E+01 -0.14449656E+01 -0.15324261E+03 -0.44241303E+02 0.76061764E+01 -0.13462969E+01 0.15161974E+02 -0.14104398E+01 0.84419509E+00 -0.13465477E+00 -0.35967619E+01 -0.21498331E+01 0.53239458E+01 -0.84920502E+00 -0.24425698E+01 -0.25904131E+03 0.39933058E+02 0.12857479E+02 -0.22757787E+01 0.25629800E+02 -0.40881248E+01 -0.23842075E+01 -0.11114540E-02 -0.11599637E-04 -0.61495356E-01 -0.64179336E-03 -0.44340814E-01 -0.67460351E-05 0.21659033E+03 0.11787646E-02 -0.57061594E-03 -0.59552061E-05 -0.98060401E-01 -0.65671194E-05 0.38041292E+00 -0.23371655E+01 -0.11945971E+01 0.41481179E+01 -0.13462969E+01 -0.14447455E+03 -0.41136159E+02 0.74343623E+01 -0.12409730E+01 0.15597252E+02 -0.13107487E+01 0.64304949E+00 -0.10418182E+00 -0.39507414E+01 -0.20193456E+01 0.70119733E+01 -0.11360247E+01 -0.22757787E+01 -0.24421959E+03 0.37924460E+02 0.12567038E+02 -0.20977408E+01 0.26365575E+02 -0.42715430E+01 -0.22156878E+01 -0.11669028E-02 -0.12178326E-04 -0.35094789E-01 -0.36626510E-03 -0.10328185E+00 -0.59552061E-05 0.19898050E+03 0.84945259E-03 0.37138614E+00 -0.25446960E+01 -0.11345621E+01 0.75228875E+01 -0.12409730E+01 -0.12216176E+03 -0.37800226E+02 0.49244403E+01 0.62779113E+00 -0.10171182E+00 -0.43015541E+01 -0.19178638E+01 0.12716689E+02 -0.20602993E+01 -0.20977408E+01 -0.20650224E+03 0.31949098E+02 0.83242739E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.89071880E-03 -0.92959444E-05 -0.90116425E-01 -0.94049579E-03 0.29264749E+03 0.20997959E-02 -0.28238988E-01 -0.22707097E-03 -0.13122752E+00 -0.22629472E-03 0.61242007E+00 -0.17083509E+01 -0.16566787E+01 -0.18638173E+03 -0.50801262E+02 0.68260786E+01 0.63495161E+00 -0.17302944E+01 0.17114212E+02 -0.17245833E+01 0.10352349E+01 -0.16566752E+00 -0.28877963E+01 -0.28004497E+01 -0.31505967E+03 0.56283224E+02 0.11538803E+02 0.10733222E+01 -0.17176259E+00 -0.29248897E+01 0.28929865E+02 -0.46296150E+01 -0.29152356E+01 -0.89656706E-03 -0.93569795E-05 -0.10724558E+00 -0.11192633E-02 -0.21757486E-01 -0.22707097E-03 0.29274063E+03 0.28729248E-02 -0.49798591E-01 -0.40579256E-03 -0.16202618E+00 -0.40438183E-03 0.68153890E+00 -0.16918757E+01 -0.16386315E+01 -0.17302944E+01 -0.18740171E+03 -0.55188260E+02 0.84867624E+01 0.10712380E+01 -0.17127767E+01 0.17626293E+02 -0.17070344E+01 0.11520726E+01 -0.18249471E+00 -0.28599448E+01 -0.27699410E+01 -0.29248897E+01 -0.31678364E+03 0.48630497E+02 0.14346016E+02 0.18108195E+01 -0.28684389E+00 -0.28952758E+01 0.29795467E+02 -0.47197678E+01 -0.28855691E+01 -0.62840163E-01 -0.57770378E-03 -0.15780271E+00 -0.16469005E-02 -0.38882232E-01 -0.40579256E-03 0.29292368E+03 0.45149893E-02 -0.64822814E-01 -0.58459832E-03 -0.19865773E+00 -0.58251011E-03 0.74086655E+00 -0.16753377E+01 -0.16067971E+01 -0.17127767E+01 -0.18834113E+03 -0.55000471E+02 0.83857228E+01 0.86492273E+00 -0.16952612E+01 0.18710595E+02 -0.16894219E+01 0.12523608E+01 -0.19634685E+00 -0.28319909E+01 -0.27161298E+01 -0.28952758E+01 -0.31837184E+03 0.48683506E+02 0.14175224E+02 0.14620654E+01 -0.22922462E+00 -0.28656695E+01 0.31628390E+02 -0.49587423E+01 -0.28557988E+01 -0.71349256E-01 -0.66569460E-03 -0.19394551E+00 -0.20241031E-02 -0.56015042E-01 -0.58459832E-03 0.29302351E+03 0.53427201E-02 -0.65409750E-01 -0.67402542E-03 -0.23558105E+00 -0.67160093E-03 0.74808903E+00 -0.16656929E+01 -0.15928640E+01 -0.16952612E+01 -0.18867626E+03 -0.54906725E+02 0.83270121E+01 0.80747099E-01 -0.16864639E+01 0.19821857E+02 -0.16806124E+01 0.12645688E+01 -0.19723372E+00 -0.28156854E+01 -0.26925751E+01 -0.28656695E+01 -0.31893814E+03 0.48672218E+02 0.14075973E+02 0.13649481E+00 -0.21288979E-01 -0.28507966E+01 0.33506847E+02 -0.52260336E+01 -0.28409053E+01 -0.79485143E-01 -0.75399642E-03 -0.22990739E+00 -0.23994175E-02 -0.64583768E-01 -0.67402542E-03 0.29310045E+03 0.59898177E-02 -0.64560309E-01 -0.67378059E-03 -0.25945883E+00 -0.76068636E-03 0.71569311E+00 -0.16570018E+01 -0.15785190E+01 -0.16864639E+01 -0.18923331E+03 -0.54812579E+02 0.82862473E+01 -0.16863082E+01 0.20490641E+02 -0.16718474E+01 0.12098076E+01 -0.18770999E+00 -0.28009959E+01 -0.26683286E+01 -0.28507966E+01 -0.31987998E+03 0.48719147E+02 0.14007069E+02 -0.28505336E+01 0.34637380E+02 -0.53742280E+01 -0.28260909E+01 -0.70592166E-01 -0.66565245E-03 -0.12429711E+00 -0.12972209E-02 -0.75201414E-01 -0.67378059E-03 0.29295322E+03 0.44363327E-02 -0.38860587E-01 -0.40556666E-03 -0.24243745E+00 -0.67142407E-03 0.67520554E+00 -0.16660338E+01 -0.16214392E+01 0.10464732E+01 -0.16863082E+01 -0.19024661E+03 -0.54906377E+02 0.83725627E+01 -0.17120399E+01 0.20498619E+02 -0.16806242E+01 0.11413667E+01 -0.17801982E+00 -0.28162617E+01 -0.27408791E+01 0.17689573E+01 -0.27590558E+00 -0.28505336E+01 -0.32159269E+03 0.49087749E+02 0.14152973E+02 -0.28940321E+01 0.34650845E+02 -0.54045176E+01 -0.28409252E+01 -0.89363099E-03 -0.93263373E-05 -0.93052124E-01 -0.97113407E-03 -0.58123209E-01 -0.40556666E-03 0.29274599E+03 0.25066052E-02 -0.86187384E-03 -0.89949054E-05 -0.19353555E+00 -0.40452664E-03 0.58169256E+00 -0.16919846E+01 -0.15999259E+01 0.18896683E+01 -0.17120399E+01 -0.19037896E+03 -0.55187799E+02 0.83957998E+01 -0.16778310E+01 0.19884307E+02 -0.17078690E+01 0.98329310E+00 -0.15575948E+00 -0.28601308E+01 -0.27045147E+01 0.31942953E+01 -0.50599540E+00 -0.28940321E+01 -0.32181660E+03 0.49428946E+02 0.14192258E+02 -0.28362030E+01 0.33612433E+02 -0.53244095E+01 -0.28869818E+01 -0.95612344E-03 -0.99785368E-05 -0.53264034E-01 -0.55588756E-03 -0.38332653E-01 -0.89949054E-05 0.26921187E+03 0.12209128E-02 -0.77697458E-03 -0.81088582E-05 -0.11567965E+00 -0.87137452E-05 0.46451832E+00 -0.18794010E+01 -0.15192191E+01 0.26251845E+01 -0.16778310E+01 -0.17564264E+03 -0.51156974E+02 0.82456741E+01 -0.15379209E+01 0.17977306E+02 -0.16256003E+01 0.78522103E+00 -0.12721097E+00 -0.31769365E+01 -0.25680863E+01 0.44376080E+01 -0.71892165E+00 -0.28362030E+01 -0.29690607E+03 0.46023370E+02 0.13938478E+02 -0.25997015E+01 0.30388813E+02 -0.49231871E+01 -0.27479122E+01 -0.10365274E-02 -0.10817669E-04 -0.22298997E-01 -0.23272242E-03 -0.66109854E-01 -0.81088582E-05 0.24579760E+03 0.84135438E-03 -0.69746052E-03 -0.72790136E-05 -0.99112757E-01 -0.79227719E-05 0.43621853E+00 -0.20587232E+01 -0.14104398E+01 0.29155404E+01 -0.15379209E+01 -0.16074289E+03 -0.46711518E+02 0.79127908E+01 -0.13976821E+01 0.16260700E+02 -0.15028176E+01 0.73738381E+00 -0.11946196E+00 -0.34800657E+01 -0.23842075E+01 0.49284294E+01 -0.79844421E+00 -0.25997015E+01 -0.27171979E+03 0.42116819E+02 0.13375780E+02 -0.23626400E+01 0.27487088E+02 -0.44531237E+01 -0.25403629E+01 -0.11364253E-02 -0.11860249E-04 -0.62924825E-03 -0.65671194E-05 -0.51374736E-01 -0.72790136E-05 0.22235750E+03 0.55257934E-03 -0.89255292E-01 -0.70906607E-05 0.45215280E+00 -0.22754922E+01 -0.13107487E+01 0.24667704E+01 -0.13976821E+01 -0.14528699E+03 -0.42264729E+02 0.63503151E+01 0.14681026E+02 -0.13616800E+01 0.76431855E+00 -0.12382645E+00 -0.38464892E+01 -0.22156878E+01 0.41698256E+01 -0.67554911E+00 -0.23626400E+01 -0.24559295E+03 0.38061162E+02 0.10734565E+02 0.24816788E+02 -0.40205418E+01 -0.23017823E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.92582470E-03 -0.96623255E-05 -0.21683108E-01 -0.22629472E-03 0.29249089E+03 0.93899797E-03 -0.21203776E-01 -0.97832424E-05 -0.71925308E-01 -0.93059444E-05 0.53099880E+00 -0.17328999E+01 -0.17245833E+01 -0.18766696E+03 -0.51030416E+02 0.68826972E+01 0.11494059E+01 -0.17521309E+01 0.17993985E+02 -0.16668777E+01 0.89760037E+00 -0.14541384E+00 -0.29292939E+01 -0.29152356E+01 -0.31723224E+03 0.56854685E+02 0.11634511E+02 0.19429557E+01 -0.31476442E+00 -0.29618020E+01 0.30417032E+02 -0.49276468E+01 -0.28176901E+01 -0.92827855E-03 -0.96879349E-05 -0.38747058E-01 -0.40438183E-03 -0.93741072E-03 -0.97832424E-05 0.29252851E+03 0.11272212E-02 -0.31497905E-01 -0.98369999E-05 -0.80804250E-01 -0.95760031E-05 0.57296891E+00 -0.17321883E+01 -0.17070344E+01 -0.17521309E+01 -0.18913401E+03 -0.55622843E+02 0.86554071E+01 0.21606308E+01 -0.17520569E+01 0.18407184E+02 -0.17057913E+01 0.96854598E+00 -0.15690687E+00 -0.29280891E+01 -0.28855691E+01 -0.29618020E+01 -0.31971192E+03 0.49493657E+02 0.14631092E+02 0.36523280E+01 -0.59168619E+00 -0.29616750E+01 0.31115484E+02 -0.50407855E+01 -0.28834677E+01 -0.93303617E-03 -0.97375877E-05 -0.55814953E-01 -0.58251011E-03 -0.94256166E-03 -0.98369999E-05 0.29257763E+03 0.13058487E-02 -0.38248922E-01 -0.99264522E-05 -0.10616624E+00 -0.98771465E-05 0.65284766E+00 -0.17316471E+01 -0.16894219E+01 -0.17520569E+01 -0.19102779E+03 -0.55622856E+02 0.86749437E+01 0.19808075E+01 -0.17520397E+01 0.20401092E+02 -0.17435727E+01 0.11035737E+01 -0.17878067E+00 -0.29271763E+01 -0.28557988E+01 -0.29616750E+01 -0.32291338E+03 0.50011819E+02 0.14664123E+02 0.33483570E+01 -0.54243911E+00 -0.29616479E+01 0.34486006E+02 -0.55867871E+01 -0.29473353E+01 -0.93950919E-03 -0.98051430E-05 -0.64351458E-01 -0.67160093E-03 -0.95113280E-03 -0.99264522E-05 0.29257699E+03 0.13952789E-02 -0.17181466E-01 -0.10009662E-04 -0.11698968E+00 -0.99707864E-05 0.75794506E+00 -0.17325699E+01 -0.16806124E+01 -0.17520397E+01 -0.19181884E+03 -0.55621662E+02 0.86690385E+01 0.75206056E+00 -0.17520824E+01 0.22314308E+02 -0.17455292E+01 0.12812295E+01 -0.20756036E+00 -0.29287341E+01 -0.28409053E+01 -0.29616479E+01 -0.32425036E+03 0.50231084E+02 0.14654135E+02 0.12712824E+01 -0.20594892E+00 -0.29617180E+01 0.37720082E+02 -0.61106878E+01 -0.29506406E+01 -0.94268585E-03 -0.98382960E-05 -0.72887446E-01 -0.76068636E-03 -0.95910582E-03 -0.10009662E-04 0.29258100E+03 0.14845354E-02 -0.95913579E-03 -0.10009975E-04 -0.12784603E+00 -0.10021305E-04 0.80885568E+00 -0.17325536E+01 -0.16718474E+01 -0.17520824E+01 -0.19218464E+03 -0.55620927E+02 0.86602214E+01 -0.17520151E+01 0.23380365E+02 -0.17455184E+01 0.13672896E+01 -0.22150141E+00 -0.29287086E+01 -0.28260909E+01 -0.29617180E+01 -0.32486892E+03 0.50332785E+02 0.14639234E+02 -0.29616042E+01 0.39522169E+02 -0.64026056E+01 -0.29506243E+01 -0.93888991E-03 -0.97986799E-05 -0.64334512E-01 -0.67142407E-03 -0.20098704E-01 -0.10009975E-04 0.29258909E+03 0.13950558E-02 -0.94692422E-03 -0.98825296E-05 -0.12599173E+00 -0.99743272E-05 0.76584105E+00 -0.17326971E+01 -0.16806242E+01 0.10386881E+01 -0.17520151E+01 -0.19300135E+03 -0.55621503E+02 0.86692625E+01 -0.17516908E+01 0.23202076E+02 -0.17460305E+01 0.12945768E+01 -0.20972263E+00 -0.29289491E+01 -0.28409252E+01 0.17557971E+01 -0.28444074E+00 -0.29616042E+01 -0.32624926E+03 0.50555316E+02 0.14654513E+02 -0.29610581E+01 0.39220762E+02 -0.63537996E+01 -0.29514879E+01 -0.93142427E-03 -0.97207651E-05 -0.38760933E-01 -0.40452664E-03 -0.43707890E-01 -0.98825296E-05 0.29258464E+03 0.11273703E-02 -0.90379544E-03 -0.94324181E-05 -0.12432188E+00 -0.98495447E-05 0.69052184E+00 -0.17321429E+01 -0.17078690E+01 0.25182774E+01 -0.17516908E+01 -0.19340288E+03 -0.55622434E+02 0.86410780E+01 -0.16970838E+01 0.22200415E+02 -0.17460864E+01 0.11672581E+01 -0.18909809E+00 -0.29280144E+01 -0.28869818E+01 0.42568961E+01 -0.68962550E+00 -0.29610581E+01 -0.32692822E+03 0.50663406E+02 0.14606876E+02 -0.28687486E+01 0.37527582E+02 -0.60795416E+01 -0.29515844E+01 -0.98194949E-03 -0.10248069E-04 -0.83493364E-03 -0.87137452E-05 -0.69271226E-01 -0.94324181E-05 0.27502451E+03 0.68938559E-03 -0.84001290E-03 -0.87667547E-05 -0.12208159E+00 -0.93143151E-05 0.66369623E+00 -0.18415082E+01 -0.16256003E+01 0.32064503E+01 -0.16970838E+01 -0.18185558E+03 -0.52287970E+02 0.84381586E+01 -0.15920711E+01 0.20074998E+02 -0.16760612E+01 0.11219114E+01 -0.18175342E+00 -0.31128835E+01 -0.27479122E+01 0.54201800E+01 -0.87808747E+00 -0.28687486E+01 -0.30740847E+03 0.47632801E+02 0.14263855E+02 -0.26912369E+01 0.33934755E+02 -0.54975455E+01 -0.28332120E+01 -0.10382557E-02 -0.10835706E-04 -0.75914416E-03 -0.79227719E-05 -0.76734055E-01 -0.87667547E-05 0.25747100E+03 0.64606008E-03 -0.76858040E-03 -0.80212528E-05 -0.10700336E+00 -0.86474752E-05 0.58532222E+00 -0.19654957E+01 -0.15028176E+01 0.33975388E+01 -0.15920711E+01 -0.16914037E+03 -0.48953851E+02 0.81046240E+01 -0.14681644E+01 0.17330914E+02 -0.15706120E+01 0.98942868E+00 -0.16029150E+00 -0.33224740E+01 -0.25403629E+01 0.57431995E+01 -0.93042188E+00 -0.26912369E+01 -0.28591488E+03 0.44281127E+02 0.13700055E+02 -0.24817834E+01 0.29296178E+02 -0.47461009E+01 -0.26549625E+01 -0.11349350E-02 -0.11844695E-04 -0.67941293E-03 -0.70906607E-05 -0.54570200E-01 -0.80212528E-05 0.23400232E+03 0.58182586E-03 -0.52806300E-01 -0.77235182E-05 0.54602781E+00 -0.21660390E+01 -0.13616800E+01 0.26473125E+01 -0.14681644E+01 -0.15123902E+03 -0.44505464E+02 0.64147095E+01 0.13660367E+02 -0.14138587E+01 0.92300475E+00 -0.14953127E+00 -0.36614697E+01 -0.23017823E+01 0.44750140E+01 -0.72497412E+00 -0.24817834E+01 -0.25565427E+03 0.39559654E+02 0.10843417E+02 0.23091469E+02 -0.37409303E+01 -0.23899851E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.11247371E-02 -0.11738265E-04 0.25726183E+03 0.63121360E-03 -0.87969584E-03 -0.91809038E-05 -0.80616683E-03 -0.84135217E-05 0.53992581E+00 -0.19859020E+01 -0.15570736E+03 -0.48977572E+02 0.49631555E+01 -0.15762532E+01 0.73733402E+01 -0.13955268E+01 0.91268979E+00 -0.14785378E+00 -0.33569658E+01 -0.26320750E+03 0.40543038E+02 0.83897130E+01 -0.26644983E+01 0.12463884E+02 -0.20191221E+01 -0.23589964E+01 -0.10585969E-02 -0.11047996E-04 -0.89167698E-03 -0.93059444E-05 -0.25480273E-01 -0.91809038E-05 0.26901524E+03 0.67733017E-03 -0.26901940E-01 -0.95907170E-05 -0.85919741E-03 -0.89669729E-05 0.62262536E+00 -0.18943762E+01 -0.16668777E+01 0.53520116E+01 -0.15762532E+01 -0.17513816E+03 -0.51196925E+02 0.82741795E+01 0.10732459E+01 -0.16465357E+01 0.13568905E+02 -0.14844173E+01 0.10524859E+01 -0.17050168E+00 -0.32022536E+01 -0.28176901E+01 0.90470403E+01 -0.14656116E+01 -0.26644983E+01 -0.29605355E+03 0.45785790E+02 0.13986673E+02 0.18142149E+01 -0.29390103E+00 -0.27833040E+01 0.22936876E+02 -0.37157514E+01 -0.25092590E+01 -0.10163523E-02 -0.10607112E-04 -0.91755346E-03 -0.95760031E-05 -0.91896332E-03 -0.95907170E-05 0.28074737E+03 0.70571194E-03 -0.54088750E-01 -0.10025034E-04 -0.35101311E-01 -0.93148164E-05 0.79655881E+00 -0.18126331E+01 -0.17057913E+01 -0.16465357E+01 -0.18345941E+03 -0.53421482E+02 0.84829556E+01 0.36783861E+01 -0.17166919E+01 0.17742896E+02 -0.15953361E+01 0.13465020E+01 -0.21813184E+00 -0.30640727E+01 -0.28834677E+01 -0.27833040E+01 -0.31011955E+03 0.47973334E+02 0.14339579E+02 0.62179390E+01 -0.10072993E+01 -0.29018937E+01 0.29992569E+02 -0.48587629E+01 -0.26967541E+01 -0.98266211E-03 -0.10255506E-04 -0.94640842E-03 -0.98771465E-05 -0.96057866E-03 -0.10025034E-04 0.29249122E+03 0.73436965E-03 -0.49024073E-01 -0.10324474E-04 -0.89967129E-01 -0.99255482E-05 0.10708972E+01 -0.17366396E+01 -0.17435727E+01 -0.17166919E+01 -0.19487570E+03 -0.55647323E+02 0.86406706E+01 0.38787961E+01 -0.17525021E+01 0.21966129E+02 -0.16850482E+01 0.18102447E+01 -0.29325594E+00 -0.29356156E+01 -0.29473353E+01 -0.29018937E+01 -0.32941788E+03 0.51004900E+02 0.14606187E+02 0.65567169E+01 -0.10621747E+01 -0.29624295E+01 0.37131544E+02 -0.60152344E+01 -0.28484055E+01 -0.98942330E-03 -0.10326069E-04 -0.95538081E-03 -0.99707864E-05 -0.98927044E-03 -0.10324474E-04 0.29254014E+03 0.73535632E-03 -0.28113285E-01 -0.10418811E-04 -0.16098640E+00 -0.10349907E-04 0.14333144E+01 -0.17319037E+01 -0.17455292E+01 -0.17525021E+01 -0.19699295E+03 -0.55648296E+02 0.87298165E+01 0.18224452E+01 -0.17525012E+01 0.25778745E+02 -0.17411638E+01 0.24228734E+01 -0.39249862E+00 -0.29276085E+01 -0.29506406E+01 -0.29624295E+01 -0.33299670E+03 0.51582022E+02 0.14756875E+02 0.30806597E+01 -0.49905816E+00 -0.29624265E+01 0.43576367E+02 -0.70592488E+01 -0.29432618E+01 -0.99413888E-03 -0.10375283E-04 -0.96022143E-03 -0.10021305E-04 -0.99830961E-03 -0.10418811E-04 0.29253173E+03 0.73561402E-03 -0.99942208E-03 -0.10430421E-04 -0.17947806E+00 -0.10399223E-04 0.16531461E+01 -0.17318990E+01 -0.17455184E+01 -0.17525012E+01 -0.19721627E+03 -0.55648176E+02 0.87312260E+01 -0.17525027E+01 0.27604579E+02 -0.17425884E+01 0.27944782E+01 -0.45269632E+00 -0.29276020E+01 -0.29506243E+01 -0.29624265E+01 -0.33337438E+03 0.51643267E+02 0.14759261E+02 -0.29624289E+01 0.46662780E+02 -0.75592177E+01 -0.29456714E+01 -0.99061269E-03 -0.10338482E-04 -0.95572009E-03 -0.99743272E-05 -0.22031607E-01 -0.10430421E-04 0.29255261E+03 0.73543773E-03 -0.99135378E-03 -0.10346217E-04 -0.17989024E+00 -0.10381639E-04 0.15206748E+01 -0.17309160E+01 -0.17460305E+01 0.12245586E+01 -0.17525027E+01 -0.19752059E+03 -0.55648621E+02 0.87326296E+01 -0.17524060E+01 0.26817401E+02 -0.17445577E+01 0.25705472E+01 -0.41642114E+00 -0.29259386E+01 -0.29514879E+01 0.20699926E+01 -0.33533278E+00 -0.29624289E+01 -0.33388862E+03 0.51725673E+02 0.14761630E+02 -0.29622671E+01 0.45332109E+02 -0.73436692E+01 -0.29489986E+01 -0.98257199E-03 -0.10254566E-04 -0.94376367E-03 -0.98495447E-05 -0.45424895E-01 -0.10346217E-04 0.29254806E+03 0.73485204E-03 -0.97085662E-03 -0.10132299E-04 -0.15096113E+00 -0.10306636E-04 0.12302176E+01 -0.17320887E+01 -0.17460864E+01 0.35248492E+01 -0.17524060E+01 -0.19753514E+03 -0.55647836E+02 0.87171013E+01 -0.17343623E+01 0.24820915E+02 -0.17459416E+01 0.20795599E+01 -0.33688403E+00 -0.29279228E+01 -0.29515844E+01 0.59584050E+01 -0.96524821E+00 -0.29622671E+01 -0.33391340E+03 0.51731839E+02 0.14735386E+02 -0.29317638E+01 0.41957275E+02 -0.67969844E+01 -0.29513397E+01 -0.99209166E-03 -0.10353917E-04 -0.89247904E-03 -0.93143151E-05 -0.67965128E-01 -0.10132299E-04 0.28669542E+03 0.71975809E-03 -0.91858604E-03 -0.95867796E-05 -0.12299397E+00 -0.10093614E-04 0.97046859E+00 -0.17686457E+01 -0.16760612E+01 0.45542143E+01 -0.17343623E+01 -0.19256389E+03 -0.54535101E+02 0.85750910E+01 -0.16619487E+01 0.22439305E+02 -0.17279811E+01 0.16404788E+01 -0.26575571E+00 -0.29897163E+01 -0.28332120E+01 0.76984380E+01 -0.12471382E+01 -0.29317638E+01 -0.32550975E+03 0.50417700E+02 0.14495325E+02 -0.28093580E+01 0.37931372E+02 -0.61448394E+01 -0.29209771E+01 -0.10451533E-02 -0.10907693E-04 -0.82858378E-03 -0.86474752E-05 -0.87940613E-01 -0.95867796E-05 0.26912665E+03 0.67637135E-03 -0.82768535E-03 -0.86380988E-05 -0.76916466E-01 -0.93597604E-05 0.78546443E+00 -0.18879020E+01 -0.15706120E+01 0.51131268E+01 -0.16619487E+01 -0.17926113E+03 -0.51197932E+02 0.82670121E+01 -0.15179900E+01 0.18842384E+02 -0.16228397E+01 0.13277491E+01 -0.21509523E+00 -0.31913095E+01 -0.26549625E+01 0.86432294E+01 -0.14002024E+01 -0.28093580E+01 -0.30302301E+03 0.46912740E+02 0.13974555E+02 -0.25660085E+01 0.31851165E+02 -0.51598860E+01 -0.27432483E+01 -0.11549294E-02 -0.12053366E-04 -0.74005207E-03 -0.77235182E-05 -0.10315068E+00 -0.86380988E-05 0.23984529E+03 0.59758328E-03 -0.20030928E-01 -0.83415062E-05 0.68019859E+00 -0.21149439E+01 -0.14138587E+01 0.48202674E+01 -0.15179900E+01 -0.15366395E+03 -0.45637013E+02 0.65179537E+01 0.10444244E+02 -0.14660613E+01 0.11498069E+01 -0.18627016E+00 -0.35750987E+01 -0.23899851E+01 0.81481742E+01 -0.13200144E+01 -0.25660085E+01 -0.25975337E+03 0.40130338E+02 0.11017941E+02 0.17654939E+02 -0.28601219E+01 -0.24782283E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.13595278E-02 -0.14188647E-04 -0.83154072E-01 -0.84135217E-05 0.21644135E+03 0.54412163E-03 -0.48657587E-01 -0.81200792E-05 -0.69781846E-03 -0.72827492E-05 0.59776879E+00 -0.23514563E+01 -0.13955268E+01 -0.13376399E+03 -0.41208238E+02 0.62743035E+01 0.62226571E+00 -0.13470069E+01 0.82931739E+01 -0.11757010E+01 0.10104675E+01 -0.16369156E+00 -0.39748983E+01 -0.23589964E+01 -0.22611446E+03 0.34812190E+02 0.10606074E+02 0.10518771E+01 -0.17039975E+00 -0.22769786E+01 0.14018770E+02 -0.22709827E+01 -0.19874033E+01 -0.12638846E-02 -0.13190472E-04 -0.12520418E-01 -0.89669729E-05 -0.77804975E-03 -0.81200792E-05 0.23393384E+03 0.59443179E-03 -0.67042905E-01 -0.88708119E-05 -0.77850049E-03 -0.81247834E-05 0.76965209E+00 -0.21810716E+01 -0.14844173E+01 -0.13470069E+01 -0.15086242E+03 -0.44544210E+02 0.77849314E+01 0.38661218E+01 -0.14686982E+01 0.11894484E+02 -0.12987530E+01 0.13010199E+01 -0.21075945E+00 -0.36868835E+01 -0.25092590E+01 -0.22769786E+01 -0.25501783E+03 0.39359599E+02 0.13159646E+02 0.65352923E+01 -0.10586883E+01 -0.24826874E+01 0.20106436E+02 -0.32571535E+01 -0.21954121E+01 -0.11600733E-02 -0.12107049E-04 -0.89252708E-03 -0.93148164E-05 -0.84998345E-03 -0.88708119E-05 0.25737405E+03 0.65055223E-03 -0.10018150E+00 -0.97205287E-05 -0.32965212E-01 -0.86576764E-05 0.11539528E+01 -0.19797396E+01 -0.15953361E+01 -0.14686982E+01 -0.17192855E+03 -0.48997177E+02 0.80606971E+01 0.64604988E+01 -0.15926681E+01 0.16546834E+02 -0.14187729E+01 0.19506405E+01 -0.31599334E+00 -0.33465496E+01 -0.26967541E+01 -0.24826874E+01 -0.29062782E+03 0.44936312E+02 0.13625795E+02 0.10920820E+02 -0.17691144E+01 -0.26922443E+01 0.27970749E+02 -0.45311117E+01 -0.23982922E+01 -0.11056630E-02 -0.11539199E-04 -0.95104618E-03 -0.99255482E-05 -0.93140161E-03 -0.97205287E-05 0.27497376E+03 0.69434127E-03 -0.11386525E+00 -0.10527775E-04 -0.79156590E-01 -0.96995821E-05 0.18536711E+01 -0.18544138E+01 -0.16850482E+01 -0.15926681E+01 -0.18901619E+03 -0.52337002E+02 0.84010547E+01 0.67628026E+01 -0.16981766E+01 0.22556493E+02 -0.15648924E+01 0.31334456E+01 -0.50759633E+00 -0.31347010E+01 -0.28484055E+01 -0.26922443E+01 -0.31951296E+03 0.49470820E+02 0.14201141E+02 0.11431841E+02 -0.18518786E+01 -0.28705978E+01 0.38129496E+02 -0.61767123E+01 -0.26452942E+01 -0.10573977E-02 -0.11035480E-04 -0.99170737E-03 -0.10349907E-04 -0.10087504E-02 -0.10527775E-04 0.29249969E+03 0.73764742E-03 -0.46634590E-01 -0.11034998E-04 -0.13131832E+00 -0.10721463E-04 0.27340495E+01 -0.17427167E+01 -0.17411638E+01 -0.16981766E+01 -0.20339245E+03 -0.55675534E+02 0.86446883E+01 0.36380749E+01 -0.17529377E+01 0.29099360E+02 -0.17034650E+01 0.46216337E+01 -0.74866592E+00 -0.29458861E+01 -0.29432618E+01 -0.28705978E+01 -0.34381433E+03 0.53266037E+02 0.14612973E+02 0.61497971E+01 -0.99621561E+00 -0.29631636E+01 0.49189521E+02 -0.79682905E+01 -0.28795349E+01 -0.10654307E-02 -0.11119317E-04 -0.99643280E-03 -0.10399223E-04 -0.10573514E-02 -0.11034998E-04 0.29250316E+03 0.73866338E-03 -0.10608347E-02 -0.11071350E-04 -0.18115654E+00 -0.11056198E-04 0.34190776E+01 -0.17400448E+01 -0.17425884E+01 -0.17529377E+01 -0.20414700E+03 -0.55676391E+02 0.87377492E+01 -0.17528667E+01 0.32808237E+02 -0.17430828E+01 0.57796087E+01 -0.93624299E+00 -0.29413717E+01 -0.29456714E+01 -0.29631636E+01 -0.34509008E+03 0.53470185E+02 0.14770287E+02 -0.29630436E+01 0.55459044E+02 -0.89838507E+01 -0.29465071E+01 -0.10581823E-02 -0.11043669E-04 -0.99474788E-03 -0.10381639E-04 -0.21878828E-01 -0.11071350E-04 0.29251661E+03 0.73841610E-03 -0.10480451E-02 -0.10937873E-04 -0.17267209E+00 -0.11001340E-04 0.29525885E+01 -0.17372681E+01 -0.17445577E+01 0.20469226E+01 -0.17528667E+01 -0.20320912E+03 -0.55675291E+02 0.87356720E+01 -0.17526655E+01 0.30288338E+02 -0.17420857E+01 0.49910519E+01 -0.80850686E+00 -0.29366758E+01 -0.29489986E+01 0.34601153E+01 -0.56050850E+00 -0.29630436E+01 -0.34350445E+03 0.53216309E+02 0.14766772E+02 -0.29627057E+01 0.51199370E+02 -0.82938510E+01 -0.29448195E+01 -0.10414984E-02 -0.10869548E-04 -0.98756126E-03 -0.10306636E-04 -0.74649095E-01 -0.10937873E-04 0.29256049E+03 0.73773362E-03 -0.10322977E-02 -0.10773526E-04 -0.16278700E+00 -0.10872520E-04 0.21402522E+01 -0.17337240E+01 -0.17459416E+01 0.55504345E+01 -0.17526655E+01 -0.20241726E+03 -0.55674523E+02 0.87329503E+01 -0.17519398E+01 0.26804110E+02 -0.17424514E+01 0.36178823E+01 -0.58606934E+00 -0.29306871E+01 -0.29513397E+01 0.93824543E+01 -0.15198860E+01 -0.29627057E+01 -0.34216613E+03 0.53001769E+02 0.14762177E+02 -0.29614766E+01 0.45309667E+02 -0.73398205E+01 -0.29454398E+01 -0.10256101E-02 -0.10703731E-04 -0.96714994E-03 -0.10093614E-04 -0.95453332E-01 -0.10773526E-04 0.29255970E+03 0.73650612E-03 -0.98283089E-03 -0.10257268E-04 -0.14086685E+00 -0.10713617E-04 0.14879109E+01 -0.17348672E+01 -0.17279811E+01 0.67553990E+01 -0.17519398E+01 -0.20081608E+03 -0.55674209E+02 0.86610325E+01 -0.16975677E+01 0.24649625E+02 -0.17424488E+01 0.25151624E+01 -0.40744107E+00 -0.29326171E+01 -0.29209771E+01 0.11419317E+02 -0.18498602E+01 -0.29614766E+01 -0.33945922E+03 0.52564782E+02 0.14640600E+02 -0.28695684E+01 0.41667691E+02 -0.67499140E+01 -0.29454330E+01 -0.10696790E-02 -0.11163654E-04 -0.89683352E-03 -0.93597604E-05 -0.13019587E+00 -0.10257268E-04 0.27507258E+03 0.69292462E-03 -0.88381229E-03 -0.92238649E-05 -0.16083653E+00 -0.10005744E-04 0.11161550E+01 -0.18433836E+01 -0.16228397E+01 0.75559522E+01 -0.16975677E+01 -0.19145418E+03 -0.52336375E+02 0.83996613E+01 -0.15738155E+01 0.24937640E+02 -0.16561995E+01 0.18867484E+01 -0.30564480E+00 -0.31160556E+01 -0.27432483E+01 0.12772581E+02 -0.20691010E+01 -0.28695684E+01 -0.32363415E+03 0.50140954E+02 0.14198786E+02 -0.26603763E+01 0.42154587E+02 -0.68288545E+01 -0.27996396E+01 -0.11333827E-02 -0.11828495E-04 -0.79926644E-03 -0.83415062E-05 -0.16001362E+00 -0.92238649E-05 0.25155729E+03 0.61757781E-03 0.80249788E+00 -0.20156766E+01 -0.14660613E+01 0.12057719E+02 -0.15738155E+01 -0.15727378E+03 -0.47880521E+02 0.50609096E+01 0.13565417E+01 -0.21975770E+00 -0.34072979E+01 -0.24782283E+01 0.20382357E+02 -0.33019111E+01 -0.26603763E+01 -0.26585545E+03 0.40980820E+02 0.85549565E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.16629540E-02 -0.17355340E-04 -0.17666840E-01 -0.72827492E-05 0.18127945E+03 0.46222261E-03 -0.46208187E-01 -0.71392325E-05 -0.61374639E-03 -0.64053350E-05 0.63855364E+00 -0.27994161E+01 -0.11757010E+01 -0.11421835E+03 -0.34541974E+02 0.61408649E+01 0.29579518E+01 -0.11526676E+01 0.65420961E+01 -0.10092086E+01 0.10794105E+01 -0.17485713E+00 -0.47321305E+01 -0.19874033E+01 -0.19307461E+03 0.29714594E+02 0.10380512E+02 0.50001190E+01 -0.80998503E+00 -0.19484682E+01 0.11058753E+02 -0.17914423E+01 -0.17059653E+01 -0.14890944E-02 -0.15540863E-04 -0.14379690E-01 -0.81247834E-05 -0.68406698E-03 -0.71392325E-05 0.20472575E+03 0.52461509E-03 -0.10061139E+00 -0.79893061E-05 -0.12523663E-01 -0.70613706E-05 0.94957271E+00 -0.24812165E+01 -0.12987530E+01 -0.11526676E+01 -0.13443133E+03 -0.38998572E+02 0.73433625E+01 0.65601441E+01 -0.12772784E+01 0.94117655E+01 -0.11290759E+01 0.16051577E+01 -0.26002288E+00 -0.41942484E+01 -0.21954121E+01 -0.19484682E+01 -0.22724272E+03 0.35048730E+02 0.12413219E+02 0.11089268E+02 -0.17963738E+01 -0.21591114E+01 0.15909648E+02 -0.25772374E+01 -0.19085899E+01 -0.14015836E-02 -0.14627561E-04 -0.82956124E-03 -0.86576764E-05 -0.76551933E-03 -0.79893061E-05 0.22230395E+03 0.56808927E-03 -0.12762543E+00 -0.90204335E-05 -0.39837085E-01 -0.79881879E-05 0.18125664E+01 -0.22875832E+01 -0.14187729E+01 -0.12772784E+01 -0.15295853E+03 -0.42340527E+02 0.76553068E+01 0.96268453E+01 -0.14142972E+01 0.13936147E+02 -0.12526296E+01 0.30639608E+01 -0.49633165E+00 -0.38669288E+01 -0.23982922E+01 -0.21591114E+01 -0.25856097E+03 0.39972265E+02 0.12940525E+02 0.16273212E+02 -0.26361010E+01 -0.23907268E+01 0.23557652E+02 -0.38161090E+01 -0.21174440E+01 -0.12704236E-02 -0.13258716E-04 -0.92939455E-03 -0.96995821E-05 -0.86431990E-03 -0.90204335E-05 0.25163973E+03 0.63979946E-03 -0.14877012E+00 -0.10399190E-04 -0.12819117E+00 -0.92072237E-05 0.33798375E+01 -0.20154729E+01 -0.15648924E+01 -0.14142972E+01 -0.17909886E+03 -0.47913181E+02 0.79985067E+01 0.10574914E+02 -0.15902782E+01 0.20776367E+02 -0.14081953E+01 0.57132773E+01 -0.92547996E+00 -0.34069554E+01 -0.26452942E+01 -0.23907268E+01 -0.30274871E+03 0.46873893E+02 0.13520675E+02 0.17875834E+02 -0.28956631E+01 -0.26882062E+01 0.35120371E+02 -0.56890638E+01 -0.23804134E+01 -0.50642588E-02 -0.12127795E-04 -0.10273091E-02 -0.10721463E-04 -0.99642962E-03 -0.10399190E-04 0.28086435E+03 0.71210420E-03 -0.91822370E-01 -0.11503691E-04 -0.17873749E+00 -0.10725980E-04 0.56128305E+01 -0.18107620E+01 -0.17034650E+01 -0.15902782E+01 -0.20370738E+03 -0.53485001E+02 0.84296870E+01 0.65513147E+01 -0.17174988E+01 0.30389582E+02 -0.16016877E+01 0.94879220E+01 -0.15369025E+01 -0.30609100E+01 -0.28795349E+01 -0.26882062E+01 -0.34434672E+03 0.53357989E+02 0.14249535E+02 0.11074335E+02 -0.17938779E+01 -0.29032579E+01 0.51370514E+02 -0.83212602E+01 -0.27074910E+01 -0.24425209E-01 -0.11764342E-04 -0.10593828E-02 -0.11056198E-04 -0.11022607E-02 -0.11503691E-04 0.29260413E+03 0.74196018E-03 -0.11302282E-02 -0.11795573E-04 -0.29916952E+00 -0.11845982E-04 0.75049402E+01 -0.17330264E+01 -0.17430828E+01 -0.17174988E+01 -0.21477488E+03 -0.55713949E+02 0.86985085E+01 -0.17533842E+01 0.39402394E+02 -0.17452709E+01 0.12686351E+02 -0.20549809E+01 -0.29295078E+01 -0.29465071E+01 -0.29032579E+01 -0.36305546E+03 0.56285871E+02 0.14703956E+02 -0.29639196E+01 0.66605807E+02 -0.10789049E+02 -0.29502058E+01 -0.75910558E-02 -0.11689435E-04 -0.10541264E-02 -0.11001340E-04 -0.30381201E-01 -0.11795573E-04 0.29251143E+03 0.74179220E-03 -0.11095801E-02 -0.11580080E-04 -0.18912806E+00 -0.11733822E-04 0.58632704E+01 -0.17376559E+01 -0.17420857E+01 0.45648266E+01 -0.17533842E+01 -0.21023215E+03 -0.55709291E+02 0.87370563E+01 -0.17532047E+01 0.31930030E+02 -0.17444824E+01 0.99112681E+01 -0.16054733E+01 -0.29373322E+01 -0.29448195E+01 0.77163801E+01 -0.12499351E+01 -0.29639196E+01 -0.35537629E+03 0.55053787E+02 0.14769114E+02 -0.29636172E+01 0.53974502E+02 -0.87430406E+01 -0.29488718E+01 -0.11102163E-02 -0.11586719E-04 -0.10417831E-02 -0.10872520E-04 -0.84683273E-01 -0.11580080E-04 0.29248778E+03 0.74090287E-03 -0.10889092E-02 -0.11364349E-04 -0.11103176E+00 -0.11514036E-04 0.37457762E+01 -0.17408475E+01 -0.17424514E+01 0.90636672E+01 -0.17532047E+01 -0.20660967E+03 -0.55703345E+02 0.87388936E+01 -0.17526895E+01 0.25917748E+02 -0.17434598E+01 0.63318601E+01 -0.10256761E+01 -0.29427286E+01 -0.29454398E+01 0.15321223E+02 -0.24818319E+01 -0.29636172E+01 -0.34925298E+03 0.54077195E+02 0.14772224E+02 -0.29627448E+01 0.43811362E+02 -0.70968508E+01 -0.29471445E+01 -0.10870975E-02 -0.11345441E-04 -0.10265574E-02 -0.10713617E-04 -0.11755392E+00 -0.11364349E-04 0.29248715E+03 0.73968854E-03 -0.10525810E-02 -0.10985212E-04 -0.75843231E-01 -0.11305784E-04 0.23393978E+01 -0.17413736E+01 -0.17424488E+01 0.89243960E+01 -0.17526895E+01 -0.20161014E+03 -0.55701882E+02 0.87033340E+01 -0.17166474E+01 0.22461520E+02 -0.17439346E+01 0.39545158E+01 -0.64058624E+00 -0.29436164E+01 -0.29454330E+01 0.15085791E+02 -0.24437253E+01 -0.29627448E+01 -0.34080161E+03 0.52712667E+02 0.14712108E+02 -0.29018208E+01 0.37968935E+02 -0.61505323E+01 -0.29479454E+01 -0.11157723E-02 -0.11644704E-04 -0.95873036E-03 -0.10005744E-04 -0.10373638E+00 -0.10985212E-04 0.28076162E+03 0.70006857E-03 -0.58737235E-01 -0.10827533E-04 0.17290239E+01 -0.18134713E+01 -0.16561995E+01 0.60763390E+01 -0.17166474E+01 -0.18895409E+03 -0.53475766E+02 0.68846034E+01 0.19981820E+02 -0.16922940E+01 0.29227420E+01 -0.47345444E+00 -0.30654918E+01 -0.27996396E+01 0.10271443E+02 -0.16638692E+01 -0.29018208E+01 -0.31940800E+03 0.49342559E+02 0.11637733E+02 0.33777269E+02 -0.54715737E+01 -0.28606537E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.19485883E-02 -0.20336349E-04 -0.68896215E-02 -0.64053350E-05 0.15788405E+03 0.40803991E-03 -0.56619370E-01 -0.63257706E-05 -0.58544193E-03 -0.56495585E-05 0.63186954E+00 -0.32022787E+01 -0.10092086E+01 -0.98805163E+02 -0.30096993E+02 0.61019210E+01 0.44049677E+01 -0.99678295E+00 0.31349304E+01 -0.89027329E+00 0.10681115E+01 -0.17302417E+00 -0.54131281E+01 -0.17059653E+01 -0.16702013E+03 0.25665630E+02 0.10314680E+02 0.74461520E+01 -0.12062076E+01 -0.16849607E+01 0.52992825E+01 -0.85843462E+00 -0.15049169E+01 -0.17858554E-02 -0.18637995E-04 -0.67660641E-03 -0.70613706E-05 -0.60612268E-03 -0.63257706E-05 0.17547880E+03 0.45601491E-03 -0.11110441E+00 -0.72066013E-05 -0.12406400E-01 -0.64187999E-05 0.11698018E+01 -0.28848554E+01 -0.11290759E+01 -0.99678295E+00 -0.11634166E+03 -0.33442061E+02 0.71265019E+01 0.88524187E+01 -0.11170418E+01 0.56171805E+01 -0.99499262E+00 0.19774329E+01 -0.32032228E+00 -0.48765596E+01 -0.19085899E+01 -0.16849607E+01 -0.19666394E+03 0.30310371E+02 0.12046637E+02 0.14964129E+02 -0.24240235E+01 -0.18882474E+01 0.94952819E+01 -0.15381307E+01 -0.16819355E+01 -0.16296921E-02 -0.17008204E-04 -0.76541219E-03 -0.79881879E-05 -0.69052212E-03 -0.72066013E-05 0.19894931E+03 0.51304880E-03 -0.18796678E+00 -0.83498387E-05 -0.28417687E-01 -0.74056227E-05 0.26875379E+01 -0.25521445E+01 -0.12526296E+01 -0.11170418E+01 -0.13896930E+03 -0.37903255E+02 0.72995082E+01 0.13123630E+02 -0.12577767E+01 0.90322981E+01 -0.11156610E+01 0.45430105E+01 -0.73590446E+00 -0.43141417E+01 -0.21174440E+01 -0.18882474E+01 -0.23491353E+03 0.36293837E+02 0.12339081E+02 0.22184168E+02 -0.35935266E+01 -0.21261440E+01 0.15268185E+02 -0.24732336E+01 -0.18859120E+01 -0.11397067E-01 -0.15750990E-04 -0.88221776E-03 -0.92072237E-05 -0.80006484E-03 -0.83498387E-05 0.22233358E+03 0.57188245E-03 -0.16313315E+00 -0.98498578E-05 -0.47986726E-01 -0.88984680E-05 0.62010410E+01 -0.22862821E+01 -0.14081953E+01 -0.12577767E+01 -0.16380015E+03 -0.42362572E+02 0.76785119E+01 0.15538893E+02 -0.14297386E+01 0.14508479E+02 -0.12917639E+01 0.10482240E+02 -0.16979338E+01 -0.38647313E+01 -0.23804134E+01 -0.21261440E+01 -0.27688778E+03 0.42884400E+02 0.12979755E+02 0.26266945E+02 -0.42547715E+01 -0.24168301E+01 0.24525133E+02 -0.39726294E+01 -0.21835977E+01 -0.68801674E-01 -0.14097767E-04 -0.10277419E-02 -0.10725980E-04 -0.94379367E-03 -0.98498578E-05 0.25758060E+03 0.65892147E-03 -0.18589673E+00 -0.11723957E-04 -0.15404578E+00 -0.10604971E-04 0.11863207E+02 -0.19732535E+01 -0.16016877E+01 -0.14297386E+01 -0.19628414E+03 -0.49059757E+02 0.81355860E+01 0.12169841E+02 -0.16408829E+01 0.24571690E+02 -0.14845134E+01 0.20053552E+02 -0.32482342E+01 -0.33355854E+01 -0.27074910E+01 -0.24168301E+01 -0.33179848E+03 0.51446462E+02 0.13752387E+02 0.20571884E+02 -0.33321924E+01 -0.27737464E+01 0.41535956E+02 -0.67279109E+01 -0.25094197E+01 -0.11943183E+00 -0.12728050E-04 -0.11350583E-02 -0.11845982E-04 -0.11233661E-02 -0.11723957E-04 0.29273776E+03 0.74540679E-03 -0.12031711E-02 -0.12556838E-04 -0.37509276E+00 -0.12533584E-04 0.16863026E+02 -0.17378832E+01 -0.17452709E+01 -0.16408829E+01 -0.23456261E+03 -0.55748297E+02 0.85957874E+01 -0.17538992E+01 0.49880579E+02 -0.17115905E+01 0.28505260E+02 -0.46171404E+01 -0.29377177E+01 -0.29502058E+01 -0.27737464E+01 -0.39650463E+03 0.61616126E+02 0.14530315E+02 -0.29647895E+01 0.84318130E+02 -0.13657432E+02 -0.28932726E+01 -0.60944376E-01 -0.12416937E-04 -0.11243114E-02 -0.11733822E-04 -0.14093544E+00 -0.12556838E-04 0.29261218E+03 0.74542913E-03 -0.11687854E-02 -0.12197973E-04 -0.16354702E+00 -0.12518373E-04 0.11099187E+02 -0.17344354E+01 -0.17444824E+01 0.12060554E+02 -0.17538992E+01 -0.21790806E+03 -0.55744062E+02 0.87415519E+01 -0.17537264E+01 0.26923069E+02 -0.17487497E+01 0.18762053E+02 -0.30390354E+01 -0.29318876E+01 -0.29488718E+01 0.20387148E+02 -0.33022646E+01 -0.29647895E+01 -0.36835155E+03 0.57067662E+02 0.14776712E+02 -0.29644990E+01 0.45510728E+02 -0.73717256E+01 -0.29560846E+01 -0.97364176E-02 -0.12057755E-04 -0.11032519E-02 -0.11514036E-04 -0.16315817E+00 -0.12197973E-04 0.29253163E+03 0.74382185E-03 -0.11401135E-02 -0.11898740E-04 -0.10412500E+00 -0.12162317E-04 0.60604122E+01 -0.17335935E+01 -0.17434598E+01 0.15094148E+02 -0.17537264E+01 -0.20922440E+03 -0.55737111E+02 0.87390582E+01 -0.17532679E+01 0.20234483E+02 -0.17487549E+01 0.10244521E+02 -0.16594169E+01 -0.29304664E+01 -0.29471445E+01 0.25515148E+02 -0.41329672E+01 -0.29644990E+01 -0.35367293E+03 0.54708381E+02 0.14772502E+02 -0.29637219E+01 0.34204370E+02 -0.55404554E+01 -0.29560952E+01 -0.11345264E-02 -0.11840431E-04 -0.10832977E-02 -0.11305784E-04 -0.15298635E+00 -0.11898740E-04 0.29249952E+03 0.74248403E-03 -0.11102413E-02 -0.11586981E-04 -0.87072756E-01 -0.11875363E-04 0.33681829E+01 -0.17329727E+01 -0.17439346E+01 0.12407653E+02 -0.17532679E+01 -0.20133903E+03 -0.55733785E+02 0.87217496E+01 -0.17353310E+01 0.17722819E+02 -0.17499893E+01 0.56935723E+01 -0.92226603E+00 -0.29294150E+01 -0.29479454E+01 0.20973881E+02 -0.33974275E+01 -0.29637219E+01 -0.34034325E+03 0.52558623E+02 0.14743237E+02 -0.29334035E+01 0.29958631E+02 -0.48528105E+01 -0.29581798E+01 -0.11357195E-02 -0.11852882E-04 -0.10374725E-02 -0.10827533E-04 -0.12009796E+00 -0.11586981E-04 0.28658158E+03 0.71611912E-03 -0.48588756E-01 -0.11565613E-04 0.22946266E+01 -0.17671616E+01 -0.16922940E+01 0.80019043E+01 -0.17353310E+01 -0.18742792E+03 -0.54619660E+02 0.69332076E+01 0.12648323E+02 -0.17322918E+01 0.38788368E+01 -0.62831477E+00 -0.29872100E+01 -0.28606537E+01 0.13526419E+02 -0.21910817E+01 -0.29334035E+01 -0.31682815E+03 0.48800221E+02 0.11719894E+02 0.21380725E+02 -0.34633644E+01 -0.29282661E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.26367206E-02 -0.27518009E-04 0.11691798E+03 0.31040631E-03 -0.15879240E-01 -0.48749114E-05 -0.42567276E-03 -0.44425135E-05 0.30894644E+00 -0.43198103E+01 -0.69421330E+02 -0.22297074E+02 0.57891290E+01 0.19807205E+01 -0.76539824E+00 -0.70141742E+00 0.52224306E+00 -0.84598286E-01 -0.73022073E+01 -0.11734982E+03 0.17972447E+02 0.97859437E+01 0.33482100E+01 -0.54237739E+00 -0.12938292E+01 -0.11856760E+01 -0.22213481E-02 -0.23182994E-04 -0.54132940E-03 -0.56495585E-05 -0.46710426E-03 -0.48749114E-05 0.14034169E+03 0.37264749E-03 -0.61160249E-01 -0.57321406E-05 -0.47157255E-03 -0.49215445E-05 0.53417080E+00 -0.36029813E+01 -0.89027329E+00 -0.76539824E+00 -0.87160026E+02 -0.26758321E+02 0.69178904E+01 0.58331968E+01 -0.89151591E+00 0.23724452E+00 -0.76471706E+00 0.90296180E+00 -0.14627021E+00 -0.60904761E+01 -0.15049169E+01 -0.12938292E+01 -0.14733522E+03 0.22617766E+02 0.11693996E+02 0.98604302E+01 -0.15972850E+01 -0.15070176E+01 0.40103791E+00 -0.64963886E-01 -0.12926770E+01 -0.20249245E-02 -0.21133029E-04 -0.61503657E-03 -0.64187999E-05 -0.54924225E-03 -0.57321406E-05 0.15792382E+03 0.41507500E-03 -0.11209667E+00 -0.65647585E-05 -0.56517062E-03 -0.58983763E-05 0.12295079E+01 -0.32050468E+01 -0.99499262E+00 -0.89151591E+00 -0.10373876E+03 -0.30106230E+02 0.69820971E+01 0.10342836E+02 -0.99693289E+00 0.15461141E+01 -0.89022740E+00 0.20783602E+01 -0.33666692E+00 -0.54178110E+01 -0.16819355E+01 -0.15070176E+01 -0.17536000E+03 0.26993128E+02 0.11802536E+02 0.17483529E+02 -0.28321010E+01 -0.16852153E+01 0.26135512E+01 -0.42336080E+00 -0.15048404E+01 -0.18954089E-02 -0.19781345E-04 -0.70959196E-03 -0.74056227E-05 -0.62902203E-03 -0.65647585E-05 0.17552542E+03 0.45895273E-03 -0.18490299E+00 -0.78425031E-05 -0.66915747E-03 -0.69836301E-05 0.34299646E+01 -0.28841868E+01 -0.11156610E+01 -0.99693289E+00 -0.12191790E+03 -0.33456331E+02 0.71631975E+01 0.15575259E+02 -0.11479232E+01 0.22306585E+01 -0.10147341E+01 0.57980083E+01 -0.93917852E+00 -0.48754260E+01 -0.18859120E+01 -0.16852153E+01 -0.20608989E+03 0.31800895E+02 0.12108662E+02 0.26328400E+02 -0.42647520E+01 -0.19404481E+01 0.37707026E+01 -0.61078954E+00 -0.17153054E+01 -0.37829768E-01 -0.17202053E-04 -0.85263341E-03 -0.88984680E-05 -0.75145296E-03 -0.78425031E-05 0.21068091E+03 0.54456009E-03 -0.24297827E+00 -0.96193652E-05 -0.81726223E-03 -0.85293184E-05 0.87724127E+01 -0.24047730E+01 -0.12917639E+01 -0.11479232E+01 -0.15312802E+03 -0.40153071E+02 0.73802059E+01 0.21768511E+02 -0.13447723E+01 0.17769103E+01 -0.11864595E+01 0.14828886E+02 -0.24019494E+01 -0.40650283E+01 -0.21835977E+01 -0.19404481E+01 -0.25884760E+03 0.40015170E+02 0.12475499E+02 0.36797491E+02 -0.59603741E+01 -0.22732032E+01 0.30036892E+01 -0.48653076E+00 -0.20055911E+01 -0.15567512E+00 -0.15921633E-04 -0.10161471E-02 -0.10604971E-04 -0.92170833E-03 -0.96193652E-05 0.24012212E+03 0.61893949E-03 -0.35472890E+00 -0.11694541E-04 -0.97819414E-03 -0.10208877E-04 0.20388768E+02 -0.21123227E+01 -0.14845134E+01 -0.13447723E+01 -0.18900300E+03 -0.45739429E+02 0.78605356E+01 0.31038869E+02 -0.15515063E+01 -0.13622756E+01 0.34465149E+02 -0.55823791E+01 -0.35706677E+01 -0.25094197E+01 -0.22732032E+01 -0.31949044E+03 0.49546697E+02 0.13287442E+02 0.52468065E+02 -0.84983418E+01 -0.26226644E+01 -0.23027894E+01 -0.29914070E+00 -0.14448644E-04 -0.12009430E-02 -0.12533584E-04 -0.11205475E-02 -0.11694541E-04 0.28189826E+03 0.72416564E-03 -0.12390640E-02 -0.12931432E-04 -0.11974085E-02 -0.12496697E-04 0.34530089E+02 -0.18034786E+01 -0.17115905E+01 -0.15515063E+01 -0.30295866E+03 -0.53561180E+02 0.88391322E+01 -0.17187497E+01 -0.16266867E+01 0.58369661E+02 -0.94537851E+01 -0.30486002E+01 -0.28932726E+01 -0.26226644E+01 -0.51212130E+03 0.80335994E+02 0.14941665E+02 -0.29053725E+01 -0.27497511E+01 -0.12091038E+00 -0.13024193E-04 -0.11994854E-02 -0.12518373E-04 -0.35400654E+00 -0.12931432E-04 0.29269180E+03 0.74833530E-03 -0.12151085E-02 -0.12681422E-04 -0.12612720E-02 -0.13163206E-04 0.16989522E+02 -0.17310373E+01 -0.17487497E+01 0.35445146E+02 -0.17187497E+01 -0.22021925E+03 -0.55772693E+02 0.87103667E+01 -0.17542574E+01 -0.17513011E+01 0.28719068E+02 -0.46516829E+01 -0.29261433E+01 -0.29560846E+01 0.59916433E+02 -0.97047802E+01 -0.29053725E+01 -0.37225837E+03 0.57627715E+02 0.14723995E+02 -0.29653966E+01 -0.29603970E+01 -0.29539221E-01 -0.12519425E-04 -0.11653689E-02 -0.12162317E-04 -0.22278842E+00 -0.12681422E-04 0.29248278E+03 0.74634292E-03 -0.11808282E-02 -0.12323657E-04 -0.17655237E-02 -0.12658465E-04 0.80014028E+01 -0.17318408E+01 -0.17487549E+01 0.21807030E+02 -0.17542574E+01 -0.20609693E+03 -0.55761113E+02 0.87461764E+01 -0.17539435E+01 0.84869924E+01 -0.17511135E+01 0.13525571E+02 -0.21908251E+01 -0.29275037E+01 -0.29560952E+01 0.36862603E+02 -0.59708767E+01 -0.29653966E+01 -0.34838625E+03 0.53791450E+02 0.14784534E+02 -0.29648641E+01 0.14346412E+02 -0.23237821E+01 -0.29600823E+01 -0.11745151E-02 -0.12257771E-04 -0.11378735E-02 -0.11875363E-04 -0.17018751E+00 -0.12323657E-04 0.29248926E+03 0.74475699E-03 -0.11509821E-02 -0.12012170E-04 -0.82800114E-01 -0.12305913E-04 0.41569139E+01 -0.17304186E+01 -0.17499893E+01 0.14942885E+02 -0.17539435E+01 -0.20168972E+03 -0.55755356E+02 0.87459120E+01 -0.17537806E+01 0.14779875E+02 -0.17515163E+01 0.70268425E+01 -0.11382070E+01 -0.29250977E+01 -0.29581798E+01 0.25259436E+02 -0.40915200E+01 -0.29648641E+01 -0.34093608E+03 0.52600284E+02 0.14784082E+02 -0.29645908E+01 0.24983885E+02 -0.40468861E+01 -0.29607612E+01 -0.11424362E-02 -0.11922981E-04 -0.11081939E-02 -0.11565613E-04 -0.15942759E+00 -0.12012170E-04 0.29239877E+03 0.71946840E-03 0.26606893E+01 -0.17316662E+01 -0.17322918E+01 0.13042016E+02 -0.17537806E+01 -0.18351822E+03 -0.55751694E+02 0.52240006E+01 0.44976292E+01 -0.72853764E+00 -0.29272085E+01 -0.29282661E+01 0.22046224E+02 -0.35711044E+01 -0.29645908E+01 -0.31021919E+03 0.47634733E+02 0.88306505E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.26228869E-02 -0.27373634E-04 -0.24738193E-01 -0.44425135E-05 0.11694008E+03 0.31419533E-03 -0.14510170E-01 -0.44423605E-05 -0.41857439E-03 -0.43684318E-05 0.26728897E+00 -0.43215522E+01 0.10415918E+01 -0.70141742E+00 -0.71513262E+02 -0.22298278E+02 0.64284232E+01 0.30743413E+01 -0.70143927E+00 -0.70151062E+00 0.45182528E+00 -0.73191547E-01 -0.73051519E+01 0.17607067E+01 -0.28521833E+00 -0.11856760E+01 -0.12088602E+03 0.18542426E+02 0.10866607E+02 0.51968665E+01 -0.84184466E+00 -0.11857129E+01 -0.11858335E+01 -0.26659355E-02 -0.27822909E-04 -0.27018673E-01 -0.49215445E-05 -0.42565810E-03 -0.44423605E-05 0.11698186E+03 0.32014905E-03 -0.57738694E-01 -0.49258151E-05 -0.42805601E-03 -0.44673862E-05 0.43056606E+00 -0.43212757E+01 -0.76471706E+00 -0.70143927E+00 -0.73655198E+02 -0.22302114E+02 0.72568081E+01 0.60999914E+01 -0.76545108E+00 -0.70141963E+00 0.72782837E+00 -0.11790039E+00 -0.73046794E+01 -0.12926770E+01 -0.11857129E+01 -0.12450666E+03 0.19119340E+02 0.12266901E+02 0.10311418E+02 -0.16703392E+01 -0.12939176E+01 -0.11856792E+01 -0.22890448E-02 -0.23889507E-04 -0.25381719E-01 -0.58983763E-05 -0.47198175E-03 -0.49258151E-05 0.14040886E+03 0.37403923E-03 -0.11256435E+00 -0.60074212E-05 -0.48193290E-03 -0.50296698E-05 0.95493991E+00 -0.36027696E+01 -0.89022740E+00 -0.76545108E+00 -0.91323808E+02 -0.26766776E+02 0.69332679E+01 0.98254101E+01 -0.90677263E+00 -0.76503890E+00 0.16142304E+01 -0.26148297E+00 -0.60901217E+01 -0.15048404E+01 -0.12939176E+01 -0.15437376E+03 0.23736591E+02 0.11719995E+02 0.16608873E+02 -0.26904074E+01 -0.15328084E+01 -0.12932218E+01 -0.20436630E-02 -0.21328591E-04 -0.17076097E-01 -0.69836301E-05 -0.57561908E-03 -0.60074212E-05 0.16381310E+03 0.43085910E-03 -0.15171947E+00 -0.72108945E-05 -0.60504245E-03 -0.63144968E-05 0.25176735E+01 -0.30900922E+01 -0.10147341E+01 -0.90677263E+00 -0.10996184E+03 -0.31231894E+02 0.69879250E+01 0.13482684E+02 -0.10478604E+01 -0.92495411E+00 0.42558728E+01 -0.68937538E+00 -0.52234888E+01 -0.17153054E+01 -0.15328084E+01 -0.18587939E+03 0.28617763E+02 0.11812382E+02 0.22791115E+02 -0.36917533E+01 -0.17713021E+01 -0.15635414E+01 -0.14069406E-01 -0.19443328E-04 -0.39305704E-01 -0.85293184E-05 -0.69093349E-03 -0.72108945E-05 0.18724325E+03 0.48926994E-03 -0.17655716E+00 -0.86535764E-05 -0.73661529E-03 -0.76876504E-05 0.64125036E+01 -0.27048907E+01 -0.11864595E+01 -0.10478604E+01 -0.12924567E+03 -0.35699346E+02 0.72317654E+01 0.15457157E+02 -0.12038711E+01 -0.10846679E+01 0.10839696E+02 -0.17557832E+01 -0.45723473E+01 -0.20055911E+01 -0.17713021E+01 -0.21847689E+03 0.33669408E+02 0.12224575E+02 0.26128778E+02 -0.42322654E+01 -0.20350237E+01 -0.18335227E+01 -0.85146637E-01 -0.17534446E-04 -0.91496839E-01 -0.10208877E-04 -0.82916838E-03 -0.86535764E-05 0.21655768E+03 0.56258459E-03 -0.15399105E+00 -0.10675720E-04 -0.89608978E-03 -0.93519983E-05 0.13430198E+02 -0.23400367E+01 0.25196135E+01 -0.13622756E+01 -0.12038711E+01 -0.15139205E+03 -0.41283654E+02 0.76138360E+01 0.11298069E+02 -0.14246489E+01 -0.12783576E+01 0.22702394E+02 -0.36771606E+01 -0.39555957E+01 0.42591523E+01 -0.68986500E+00 -0.23027894E+01 -0.20350237E+01 -0.25591297E+03 0.39447704E+02 0.12870422E+02 0.19098244E+02 -0.30933880E+01 -0.24082250E+01 -0.21609341E+01 -0.13871496E+00 -0.14779451E-04 -0.30534456E+00 -0.12496697E-04 -0.10229261E-02 -0.10675720E-04 0.26342252E+03 0.67765910E-03 -0.11970207E-02 -0.12492650E-04 -0.11113436E-02 -0.11598485E-04 0.18730508E+02 -0.19239522E+01 0.22650621E+02 -0.16266867E+01 -0.14246489E+01 -0.19236509E+03 -0.50211097E+02 0.82011099E+01 -0.16622378E+01 -0.15579331E+01 0.31662050E+02 -0.51282795E+01 -0.32522488E+01 0.38288610E+02 -0.62015787E+01 -0.27497511E+01 -0.24082250E+01 -0.32517394E+03 0.50228609E+02 0.13863152E+02 -0.28098445E+01 -0.26335301E+01 -0.61195760E-01 -0.13005170E-04 -0.84129370E-01 -0.13163206E-04 -0.11019069E+00 -0.12492650E-04 0.29246116E+03 0.74854041E-03 -0.12344464E-02 -0.12883241E-04 -0.12445215E-02 -0.12988390E-04 0.11111017E+02 -0.17304764E+01 0.56564743E+00 -0.17513011E+01 0.11669962E+02 -0.16622378E+01 -0.19111799E+03 -0.55782280E+02 0.86562392E+01 -0.17545128E+01 -0.17514355E+01 0.18782047E+02 -0.30421668E+01 -0.29251949E+01 0.95616964E+00 -0.15487277E+00 -0.29603970E+01 0.19726888E+02 -0.31952047E+01 -0.28098445E+01 -0.32306559E+03 0.49636495E+02 0.14632498E+02 -0.29658283E+01 -0.29606246E+01 -0.13869516E-01 -0.12700715E-04 -0.12129088E-02 -0.12658465E-04 -0.13924076E+00 -0.12883241E-04 0.29236641E+03 0.74779983E-03 -0.12146362E-02 -0.12676493E-04 -0.12346491E-02 -0.12885356E-04 0.64520954E+01 -0.17296952E+01 -0.17511135E+01 0.12739216E+02 -0.17545128E+01 -0.18808195E+03 -0.55776604E+02 0.87473522E+01 -0.17544652E+01 0.11109602E+01 -0.17512923E+01 0.10906622E+02 -0.17665969E+01 -0.29238767E+01 -0.29600823E+01 0.21534371E+02 -0.34880233E+01 -0.29658283E+01 -0.31793373E+03 0.48820171E+02 0.14786522E+02 -0.29657462E+01 0.18779672E+01 -0.30418317E+00 -0.29603845E+01 -0.12076586E-02 -0.12603672E-04 -0.11791280E-02 -0.12305913E-04 -0.89047699E-01 -0.12676493E-04 0.29230729E+03 0.73435172E-03 -0.12243854E-02 -0.12778240E-04 0.41746113E+01 -0.17302744E+01 -0.17515163E+01 0.86450985E+01 -0.17544652E+01 -0.18572204E+03 -0.55771995E+02 0.69942460E+01 0.51159495E+01 -0.17517190E+01 0.70567586E+01 -0.11430303E+01 -0.29248541E+01 -0.29607612E+01 0.14613665E+02 -0.23670729E+01 -0.29657462E+01 -0.31394434E+03 0.48186100E+02 0.11823066E+02 0.86479957E+01 -0.14007736E+01 -0.29611039E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.24123184E-02 -0.25176046E-04 0.12276367E+03 0.32155676E-03 -0.12450511E-01 -0.43893722E-05 -0.45507138E-03 -0.47493308E-05 0.23967335E+00 -0.41163478E+01 -0.74141000E+02 -0.23407988E+02 0.56225115E+01 0.34073757E+01 -0.71792217E+00 -0.78561509E+00 0.40514354E+00 -0.65630999E-01 -0.69582695E+01 -0.12532787E+03 0.19223281E+02 0.95042871E+01 0.57598242E+01 -0.93305935E+00 -0.12135748E+01 -0.13280030E+01 -0.25802613E-02 -0.26928775E-04 -0.42487643E-01 -0.43684318E-05 -0.42058086E-03 -0.43893722E-05 0.11696348E+03 0.31802070E-03 -0.19335764E-01 -0.43661119E-05 -0.42194337E-03 -0.44035919E-05 0.24644381E+00 -0.43239533E+01 0.31262924E+01 -0.70151062E+00 -0.71792217E+00 -0.74727793E+02 -0.22297929E+02 0.71655433E+01 0.42244279E+01 -0.70118328E+00 -0.71847045E+00 0.41658861E+00 -0.67484236E-01 -0.73092107E+01 0.52846847E+01 -0.85607937E+00 -0.11858335E+01 -0.12135748E+01 -0.12631986E+03 0.19423783E+02 0.12112634E+02 0.71409730E+01 -0.11567842E+01 -0.11852802E+01 -0.12145024E+01 -0.26372306E-02 -0.27523332E-04 -0.37647060E-01 -0.44673862E-05 -0.41835211E-03 -0.43661119E-05 0.11698538E+03 0.31879142E-03 -0.51812949E-01 -0.44687159E-05 -0.42164408E-03 -0.44004684E-05 0.30979913E+00 -0.43203223E+01 0.19741084E+01 -0.70141963E+00 -0.70118328E+00 -0.75477566E+02 -0.22303262E+02 0.71286849E+01 0.60705380E+01 -0.70168061E+00 -0.70157335E+00 0.52368419E+00 -0.84831764E-01 -0.73030692E+01 0.33370312E+01 -0.54056672E+00 -0.11856792E+01 -0.11852802E+01 -0.12758722E+03 0.19615711E+02 0.12050324E+02 0.10261632E+02 -0.16622850E+01 -0.11861203E+01 -0.11859389E+01 -0.27227522E-02 -0.28415874E-04 -0.42281181E-01 -0.50296698E-05 -0.42818342E-03 -0.44687159E-05 0.11702233E+03 0.32114696E-03 -0.88994729E-01 -0.51260958E-05 -0.43471186E-03 -0.45368496E-05 0.62673462E+00 -0.43205436E+01 0.16309355E+01 -0.76503890E+00 -0.70168061E+00 -0.77644013E+02 -0.22307808E+02 0.72711835E+01 0.82697436E+01 -0.77976354E+00 -0.70164907E+00 0.10594322E+01 -0.17161420E+00 -0.73034469E+01 0.27569334E+01 -0.44658727E+00 -0.12932218E+01 -0.11861203E+01 -0.13124944E+03 0.20197250E+02 0.12291208E+02 0.13979175E+02 -0.22644440E+01 -0.13181123E+01 -0.11860676E+01 -0.22687455E-02 -0.23677654E-04 -0.60381371E-01 -0.63144968E-05 -0.49117225E-03 -0.51260958E-05 0.14628593E+03 0.38911555E-03 -0.11778417E+00 -0.65322551E-05 -0.52642474E-03 -0.54940068E-05 0.14991793E+01 -0.34639961E+01 0.21842910E+01 -0.92495411E+00 -0.77976354E+00 -0.98102872E+02 -0.27889063E+02 0.69489161E+01 0.10529944E+02 -0.95692617E+00 -0.82013940E+00 0.25342110E+01 -0.41049921E+00 -0.58555350E+01 0.36923229E+01 -0.59809366E+00 -0.15635414E+01 -0.13181123E+01 -0.16583299E+03 0.25522133E+02 0.11746441E+02 0.17799806E+02 -0.28832664E+01 -0.16175869E+01 -0.13863628E+01 -0.19671590E-02 -0.20530161E-04 -0.94353779E-01 -0.76876504E-05 -0.62590762E-03 -0.65322551E-05 0.17555154E+03 0.46028580E-03 -0.13385002E+00 -0.81373237E-05 -0.67278096E-03 -0.70214465E-05 0.34378157E+01 -0.28855036E+01 0.45815569E+01 -0.10846679E+01 -0.95692617E+00 -0.11978282E+03 -0.33471603E+02 0.70921696E+01 0.11103122E+02 -0.11481787E+01 -0.10131270E+01 0.58112836E+01 -0.94130456E+00 -0.48776553E+01 0.77446637E+01 -0.12544711E+01 -0.18335227E+01 -0.16175869E+01 -0.20248088E+03 0.31177756E+02 0.11988602E+02 0.18768717E+02 -0.30401336E+01 -0.19408812E+01 -0.17125898E+01 -0.13655556E-01 -0.17592714E-04 -0.14965754E+00 -0.93519983E-05 -0.77970208E-03 -0.81373237E-05 0.21065174E+03 0.54643995E-03 -0.10697527E+00 -0.10164005E-04 -0.83633053E-03 -0.87283238E-05 0.63913273E+01 -0.24049276E+01 0.94506934E+01 -0.12783576E+01 -0.11481787E+01 -0.14406601E+03 -0.40169576E+02 0.74502841E+01 0.74370771E+01 -0.13893702E+01 -0.12249288E+01 0.10803892E+02 -0.17499627E+01 -0.40652867E+01 0.15975441E+02 -0.25876255E+01 -0.21609341E+01 -0.19408812E+01 -0.24352901E+03 0.37492727E+02 0.12593953E+02 0.12571626E+02 -0.20362919E+01 -0.23485896E+01 -0.20706186E+01 -0.31731369E-01 -0.14651543E-04 -0.23081970E+00 -0.11598485E-04 -0.97389460E-03 -0.10164005E-04 0.25739641E+03 0.66144089E-03 -0.11671148E-02 -0.12180538E-04 -0.10475229E-02 -0.10932423E-04 0.81999829E+01 -0.19681342E+01 0.15533079E+02 -0.15579331E+01 -0.13893702E+01 -0.17136108E+03 -0.49096209E+02 0.80683912E+01 -0.16425735E+01 -0.15048543E+01 0.13861251E+02 -0.22451493E+01 -0.33269340E+01 0.26257116E+02 -0.42529456E+01 -0.26335301E+01 -0.23485896E+01 -0.28966876E+03 0.44531218E+02 0.13638805E+02 -0.27766044E+01 -0.25438056E+01 -0.99412422E-02 -0.12837617E-04 -0.14530947E+00 -0.12988390E-04 -0.17789741E-02 -0.12180538E-04 0.29235758E+03 0.74769519E-03 -0.12369273E-02 -0.12909133E-04 -0.12251659E-02 -0.12786386E-04 0.60694391E+01 -0.17312366E+01 0.74327847E+01 -0.17514355E+01 0.21251653E+01 -0.16425735E+01 -0.18339221E+03 -0.55787051E+02 0.86371571E+01 -0.17546171E+01 -0.17510167E+01 0.10259773E+02 -0.16618126E+01 -0.29264805E+01 0.12564371E+02 -0.20350968E+01 -0.29606246E+01 0.35923771E+01 -0.58187035E+00 -0.27766044E+01 -0.31000599E+03 0.47510016E+02 0.14600243E+02 -0.29660047E+01 -0.29599166E+01 -0.12317144E-02 -0.12854729E-04 -0.49930138E-01 -0.12885356E-04 -0.43702887E-01 -0.12909133E-04 0.29229690E+03 0.73543728E-03 -0.12263071E-02 -0.12798296E-04 0.47417388E+01 -0.17320662E+01 -0.17512923E+01 0.41803082E+01 -0.17546171E+01 -0.17669016E+03 -0.55784865E+02 0.69988269E+01 -0.17545746E+01 0.80154353E+01 -0.12982959E+01 -0.29278847E+01 -0.29603845E+01 0.70663930E+01 -0.11445752E+01 -0.29660047E+01 -0.29867705E+03 0.45680730E+02 0.11830815E+02 -0.29659313E+01 -0.12176441E-02 -0.12707884E-04 -0.17815582E-01 -0.12778240E-04 -0.56888197E-01 -0.12798296E-04 0.29227822E+03 0.72226879E-03 0.36538981E+01 -0.17304932E+01 -0.17517190E+01 0.46340972E+01 -0.17545746E+01 -0.17605817E+03 -0.55783494E+02 0.52430629E+01 0.61765459E+01 -0.10004495E+01 -0.29252241E+01 -0.29611039E+01 0.78334735E+01 -0.12688313E+01 -0.29659313E+01 -0.29760857E+03 0.45511484E+02 0.88628684E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.20907687E-02 -0.21820208E-04 -0.15280454E-01 -0.47493308E-05 0.14030494E+03 0.36494319E-03 -0.46051907E-03 -0.48061854E-05 -0.50706768E-03 -0.52919878E-05 0.24986659E+00 -0.36092681E+01 0.23300809E+01 -0.78561509E+00 -0.85988916E+02 -0.26749432E+02 0.60726827E+01 0.28408732E+01 -0.78409278E+00 -0.89070618E+00 0.42237423E+00 -0.68422734E-01 -0.61011032E+01 0.39387665E+01 -0.63806251E+00 -0.13280030E+01 -0.14535558E+03 0.22319922E+02 0.10265257E+02 0.48022092E+01 -0.77793632E+00 -0.13254297E+01 -0.15056487E+01 -0.24200611E-02 -0.25256853E-04 -0.39294061E-01 -0.44035919E-05 -0.14951867E-01 -0.48061854E-05 0.12281904E+03 0.33084145E-03 -0.18239248E-01 -0.44015426E-05 -0.45364268E-03 -0.47344203E-05 0.24940594E+00 -0.41202759E+01 0.29376635E+01 -0.71847045E+00 -0.78409278E+00 -0.77998744E+02 -0.23412403E+02 0.71290163E+01 0.43238292E+01 -0.71818374E+00 -0.78536504E+00 0.42159580E+00 -0.68296022E-01 -0.69649144E+01 0.49658263E+01 -0.80443445E+00 -0.12145024E+01 -0.13254297E+01 -0.13184908E+03 0.20268814E+02 0.12050888E+02 0.73090009E+01 -0.11840149E+01 -0.12140178E+01 -0.13275811E+01 -0.25969432E-02 -0.27102875E-04 -0.39896689E-01 -0.44004684E-05 -0.42174700E-03 -0.44015426E-05 0.11698109E+03 0.31818732E-03 -0.45028381E-01 -0.43990367E-05 -0.41409852E-03 -0.43217195E-05 0.26194740E+00 -0.43210899E+01 0.28713325E+01 -0.70157335E+00 -0.71818374E+00 -0.75997533E+02 -0.22303045E+02 0.71462039E+01 0.57407411E+01 -0.70138732E+00 -0.70146394E+00 0.44279562E+00 -0.71729294E-01 -0.73043660E+01 0.48536977E+01 -0.78625959E+00 -0.11859389E+01 -0.12140178E+01 -0.12846615E+03 0.19758867E+02 0.12079937E+02 0.97041432E+01 -0.15719925E+01 -0.11856244E+01 -0.11857538E+01 -0.26783038E-02 -0.27951990E-04 -0.46667797E-01 -0.45368496E-05 -0.42150690E-03 -0.43990367E-05 0.11699333E+03 0.31965121E-03 -0.55637401E-01 -0.47515607E-05 -0.42604735E-03 -0.44464229E-05 0.38406668E+00 -0.43220435E+01 0.31988388E+01 -0.70164907E+00 -0.70138732E+00 -0.77946499E+02 -0.22307860E+02 0.71642056E+01 0.72469567E+01 -0.73491268E+00 -0.70170517E+00 0.64922631E+00 -0.10516732E+00 -0.73059823E+01 0.54073170E+01 -0.87592417E+00 -0.11860676E+01 -0.11856244E+01 -0.13176076E+03 0.20280237E+02 0.12110372E+02 0.12250255E+02 -0.19844028E+01 -0.12422964E+01 -0.11861624E+01 -0.25234634E-02 -0.26336006E-04 -0.86060744E-01 -0.54940068E-05 -0.45528504E-03 -0.47515607E-05 0.12875970E+03 0.34823164E-03 -0.10110620E+00 -0.57909466E-05 -0.47264122E-03 -0.49326976E-05 0.82261853E+00 -0.39293287E+01 0.43492109E+01 -0.82013940E+00 -0.73491268E+00 -0.87385812E+02 -0.24545170E+02 0.71055679E+01 0.83950323E+01 -0.86451796E+00 -0.75390765E+00 0.13905535E+01 -0.22524889E+00 -0.66421333E+01 0.73519017E+01 -0.11908982E+01 -0.13863628E+01 -0.12422964E+01 -0.14771689E+03 0.22741959E+02 0.12011246E+02 0.14190954E+02 -0.22987224E+01 -0.14613803E+01 -0.12744047E+01 -0.20624577E-02 -0.21524741E-04 -0.11252369E+00 -0.70214465E-05 -0.55487692E-03 -0.57909466E-05 0.16385552E+03 0.43118608E-03 -0.10965209E+00 -0.74674546E-05 -0.61070402E-03 -0.63735834E-05 0.17105763E+01 -0.31003240E+01 0.66823870E+01 -0.10131270E+01 -0.86451796E+00 -0.11119055E+03 -0.31242159E+02 0.70031835E+01 0.88505135E+01 -0.10775222E+01 -0.94417640E+00 0.28915581E+01 -0.46837824E+00 -0.52407877E+01 0.11295907E+02 -0.18297253E+01 -0.17125898E+01 -0.14613803E+01 -0.18795651E+03 0.28928800E+02 0.11838180E+02 0.14960908E+02 -0.24233868E+01 -0.18214435E+01 -0.15960358E+01 -0.17450567E-02 -0.18212201E-04 -0.15418602E+00 -0.87283238E-05 -0.71551657E-03 -0.74674546E-05 0.19895003E+03 0.51713859E-03 -0.10189083E+00 -0.93955150E-05 -0.78983668E-03 -0.82430930E-05 0.29953742E+01 -0.25465029E+01 0.98630409E+01 -0.12249288E+01 -0.10775222E+01 -0.13466501E+03 -0.37939422E+02 0.73605572E+01 0.77318862E+01 -0.13185876E+01 -0.11887451E+01 0.50633777E+01 -0.82015700E+00 -0.43046060E+01 0.16672475E+02 -0.27005780E+01 -0.20706186E+01 -0.18214435E+01 -0.22763761E+03 0.35024388E+02 0.12442280E+02 0.13069973E+02 -0.21170510E+01 -0.22289392E+01 -0.20094537E+01 -0.14437416E-02 -0.15067541E-04 -0.18899141E+00 -0.10932423E-04 -0.90025946E-03 -0.93955150E-05 0.24568578E+03 0.63195050E-03 -0.53626918E-01 -0.11637965E-04 -0.99467506E-03 -0.10380879E-04 0.38277950E+01 -0.20617751E+01 0.11347922E+02 -0.15048543E+01 -0.13185876E+01 -0.15857358E+03 -0.46867737E+02 0.79452507E+01 0.24842690E+01 -0.16019820E+01 -0.14527757E+01 0.64705046E+01 -0.10480660E+01 -0.34852246E+01 0.19182526E+02 -0.31071076E+01 -0.25438056E+01 -0.22289392E+01 -0.26805278E+03 0.41131714E+02 0.13430650E+02 0.41994083E+01 -0.68020307E+00 -0.27079903E+01 -0.24557720E+01 -0.12193593E-02 -0.12725786E-04 -0.16186938E+00 -0.12786386E-04 -0.11151265E-02 -0.11637965E-04 0.29235799E+03 0.73364169E-03 -0.11991036E-02 -0.12514388E-04 0.33656994E+01 -0.17316203E+01 0.82236014E+01 -0.17510167E+01 -0.16019820E+01 -0.17934679E+03 -0.55792557E+02 0.68241964E+01 -0.17332974E+01 0.56893743E+01 -0.92153890E+00 -0.29271289E+01 0.13901166E+02 -0.22516474E+01 -0.29599166E+01 -0.27079903E+01 -0.30316761E+03 0.46389658E+02 0.11535616E+02 -0.29299642E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.16218760E-02 -0.16926631E-04 0.17537941E+03 0.43935417E-03 -0.56647007E-03 -0.59119379E-05 -0.61556137E-02 -0.61714783E-05 0.28576449E+00 -0.28833788E+01 -0.10405696E+03 -0.33424919E+02 0.49336497E+01 0.30445818E+01 -0.99495519E+00 -0.10515702E+01 0.48305630E+00 -0.78254280E-01 -0.48740636E+01 -0.17589789E+03 0.26990414E+02 0.83398415E+01 0.51465611E+01 -0.83373394E+00 -0.16818723E+01 -0.17775743E+01 -0.18263607E-02 -0.19060727E-04 -0.25935914E-01 -0.52919878E-05 -0.10039632E-01 -0.59119379E-05 0.15787298E+03 0.41085346E-03 -0.51382266E-03 -0.53624858E-05 -0.76890951E-02 -0.59184280E-05 0.27351888E+00 -0.32080206E+01 0.39182695E+01 -0.89070618E+00 -0.99495519E+00 -0.98166516E+02 -0.30088923E+02 0.69825585E+01 0.33297181E+01 -0.88944881E+00 -0.99605394E+00 0.46235599E+00 -0.74900371E-01 -0.54228342E+01 0.66234381E+01 -0.10729783E+01 -0.15056487E+01 -0.16818723E+01 -0.16594056E+03 0.25511811E+02 0.11803310E+02 0.56285516E+01 -0.91180951E+00 -0.15035232E+01 -0.16837284E+01 -0.20841056E-02 -0.21750669E-04 -0.14222408E-01 -0.47344203E-05 -0.71571804E-02 -0.53624858E-05 0.14031504E+03 0.36982836E-03 -0.74921983E-02 -0.46053461E-05 -0.48897810E-03 -0.51031967E-05 0.25395958E+00 -0.36073107E+01 0.33601425E+01 -0.78536504E+00 -0.88944881E+00 -0.88453895E+02 -0.26752309E+02 0.69076900E+01 0.42756307E+01 -0.76397796E+00 -0.85858568E+00 0.42929328E+00 -0.69543659E-01 -0.60977979E+01 0.56799849E+01 -0.92013306E+00 -0.13275811E+01 -0.15035232E+01 -0.14952246E+03 0.22987933E+02 0.11676758E+02 0.72275262E+01 -0.11708281E+01 -0.12914283E+01 -0.14513532E+01 -0.25550484E-02 -0.26665641E-04 -0.23639000E-01 -0.43217195E-05 -0.44127505E-03 -0.46053461E-05 0.11694917E+03 0.31781661E-03 -0.26024437E-01 -0.43157520E-05 -0.41664047E-03 -0.43482484E-05 0.25126827E+00 -0.43270355E+01 0.32985162E+01 -0.70146394E+00 -0.76397796E+00 -0.75896088E+02 -0.22299969E+02 0.72137900E+01 0.52184149E+01 -0.70052491E+00 -0.71828335E+00 0.42474358E+00 -0.68805773E-01 -0.73144156E+01 0.55758076E+01 -0.90324552E+00 -0.11857538E+01 -0.12914283E+01 -0.12829465E+03 0.19738918E+02 0.12194183E+02 0.88212022E+01 -0.14289789E+01 -0.11841664E+01 -0.12141856E+01 -0.26280701E-02 -0.27427728E-04 -0.42629391E-01 -0.44464229E-05 -0.41352672E-03 -0.43157520E-05 0.11696963E+03 0.31865200E-03 -0.34250593E-01 -0.45489783E-05 -0.41695912E-03 -0.43515740E-05 0.28803691E+00 -0.43278193E+01 0.38156956E+01 -0.70170517E+00 -0.70052491E+00 -0.77511946E+02 -0.22306268E+02 0.71518615E+01 0.62892341E+01 -0.71794048E+00 -0.70136448E+00 0.48689758E+00 -0.78872904E-01 -0.73157458E+01 0.64500519E+01 -0.10448487E+01 -0.11861624E+01 -0.11841664E+01 -0.13102619E+03 0.20165486E+02 0.12089506E+02 0.10631321E+02 -0.17221757E+01 -0.12136066E+01 -0.11855865E+01 -0.25829767E-02 -0.26957113E-04 -0.66907064E-01 -0.49326976E-05 -0.43587400E-03 -0.45489783E-05 0.12284613E+03 0.33371446E-03 -0.50043636E-01 -0.53283485E-05 -0.45087345E-03 -0.47055193E-05 0.48005106E+00 -0.41183464E+01 0.49292198E+01 -0.75390765E+00 -0.71794048E+00 -0.83034678E+02 -0.23428959E+02 0.71440394E+01 0.71609685E+01 -0.81443468E+00 -0.73677436E+00 0.81147783E+00 -0.13144930E+00 -0.69616488E+01 0.83323483E+01 -0.13497365E+01 -0.12744047E+01 -0.12136066E+01 -0.14036174E+03 0.21606154E+02 0.12076278E+02 0.12104894E+02 -0.19608419E+01 -0.13767196E+01 -0.12454426E+01 -0.21541484E-02 -0.22481667E-04 -0.13618978E+00 -0.63735834E-05 -0.51055170E-03 -0.53283485E-05 0.15220095E+03 0.40278264E-03 -0.12365296E+00 -0.69744586E-05 -0.57371574E-03 -0.59875571E-05 0.91064474E+00 -0.33276778E+01 0.70395525E+01 -0.94417640E+00 -0.81443468E+00 -0.10306843E+03 -0.29014860E+02 0.70343971E+01 0.78874247E+01 -0.10332217E+01 -0.91161978E+00 0.15393539E+01 -0.24935089E+00 -0.56251066E+01 0.11899659E+02 -0.19275560E+01 -0.15960358E+01 -0.13767196E+01 -0.17422688E+03 0.26803302E+02 0.11890944E+02 0.13332903E+02 -0.21597186E+01 -0.17465580E+01 -0.15410021E+01 -0.17013121E-02 -0.17755663E-04 -0.15016361E+00 -0.82430930E-05 -0.66827867E-03 -0.69744586E-05 0.19898128E+03 0.51503403E-03 -0.13871730E+00 -0.90451660E-05 -0.76061183E-03 -0.79380892E-05 0.14824585E+01 -0.25556453E+01 0.95520967E+01 -0.11887451E+01 -0.10332217E+01 -0.13676547E+03 -0.37941031E+02 0.72749930E+01 0.11658090E+02 -0.13044628E+01 -0.11886468E+01 0.25059465E+01 -0.40591642E+00 -0.43200606E+01 0.16146856E+02 -0.26154883E+01 -0.20094537E+01 -0.17465580E+01 -0.23118823E+03 0.35596443E+02 0.12297642E+02 0.19706825E+02 -0.31921367E+01 -0.22050628E+01 -0.20092868E+01 -0.14516712E-02 -0.15150297E-04 -0.14127870E+00 -0.10380879E-04 -0.86668972E-03 -0.90451660E-05 0.23981230E+03 0.60661304E-03 -0.77472854E-01 -0.11193885E-04 0.21898569E+01 -0.21132209E+01 0.72084319E+01 -0.14527757E+01 -0.13044628E+01 -0.15184615E+03 -0.45756514E+02 0.64422035E+01 0.48956587E+01 -0.15665916E+01 0.37017341E+01 -0.59959884E+00 -0.35721885E+01 0.12185133E+02 -0.19737214E+01 -0.24557720E+01 -0.22050628E+01 -0.25668073E+03 0.39333292E+02 0.10889900E+02 0.82756215E+01 -0.13404672E+01 -0.26481665E+01 -0.12276692E-02 -0.12812511E-04 -0.14085507E+00 -0.12514388E-04 -0.10725757E-02 -0.11193885E-04 0.28648462E+03 0.70680430E-03 0.21925545E+01 -0.17673253E+01 0.58715541E+01 -0.17332974E+01 -0.15665916E+01 -0.17245683E+03 -0.54683742E+02 0.50733718E+01 0.37062920E+01 -0.60033301E+00 -0.29874848E+01 0.99252692E+01 -0.16076626E+01 -0.29299642E+01 -0.26481665E+01 -0.29152085E+03 0.44540689E+02 0.85760242E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.16115242E-02 -0.16818596E-04 -0.59133870E-03 -0.61714783E-05 0.17538712E+03 0.44563921E-03 -0.59091291E-03 -0.61670345E-05 -0.95763281E-02 -0.61369889E-05 0.29148652E+00 -0.28811403E+01 0.14767022E+01 -0.10515702E+01 -0.10423432E+03 -0.33421480E+02 0.60380010E+01 0.17347769E+01 -0.10499448E+01 -0.10516017E+01 0.49272882E+00 -0.79821473E-01 -0.48702796E+01 0.24962175E+01 -0.40438421E+00 -0.17775743E+01 -0.17619769E+03 0.27047472E+02 0.10206637E+02 0.29324669E+01 -0.47505609E+00 -0.17748266E+01 -0.17776276E+01 -0.16258747E-02 -0.16968364E-04 -0.56709193E-03 -0.59184280E-05 -0.86361060E-02 -0.61670345E-05 0.17538214E+03 0.45119202E-03 -0.54331590E-03 -0.56702906E-05 -0.58681485E-03 -0.61242653E-05 0.27089122E+00 -0.28880003E+01 0.28009460E+01 -0.99605394E+00 -0.10499448E+01 -0.10664585E+03 -0.33425726E+02 0.69433508E+01 0.28484679E+01 -0.95388098E+00 -0.10517250E+01 0.45791421E+00 -0.74181320E-01 -0.48818723E+01 0.47347159E+01 -0.76701587E+00 -0.16837284E+01 -0.17748266E+01 -0.18027402E+03 0.27697435E+02 0.11737033E+02 0.48150467E+01 -0.78002927E+00 -0.16124393E+01 -0.17778344E+01 -0.19728916E-02 -0.20589990E-04 -0.13010801E-01 -0.51031967E-05 -0.28402342E-01 -0.56702906E-05 0.14617753E+03 0.38329670E-03 -0.46348563E-03 -0.48371457E-05 -0.49312692E-03 -0.51464957E-05 0.26262155E+00 -0.34633279E+01 0.30645876E+01 -0.85858568E+00 -0.95388098E+00 -0.90982103E+02 -0.27862876E+02 0.69542530E+01 0.37281401E+01 -0.79895138E+00 -0.87638198E+00 0.44393547E+00 -0.71916234E-01 -0.58544095E+01 0.51803789E+01 -0.83920606E+00 -0.14513532E+01 -0.16124393E+01 -0.15379615E+03 0.23639133E+02 0.11755468E+02 0.63020480E+01 -0.10209131E+01 -0.13505474E+01 -0.14814361E+01 -0.23929774E-02 -0.24974195E-04 -0.17678043E-01 -0.43482484E-05 -0.63985924E-03 -0.48371457E-05 0.12277994E+03 0.33012322E-03 -0.13774656E-01 -0.43414042E-05 -0.42021413E-03 -0.43855448E-05 0.24566396E+00 -0.41247997E+01 0.32319114E+01 -0.71828335E+00 -0.79895138E+00 -0.78539113E+02 -0.23411151E+02 0.70979949E+01 0.45718862E+01 -0.71717987E+00 -0.73615276E+00 0.41527015E+00 -0.67271826E-01 -0.69725578E+01 0.54632203E+01 -0.88501622E+00 -0.12141856E+01 -0.13505474E+01 -0.13276245E+03 0.20420065E+02 0.11998445E+02 0.77283124E+01 -0.12519506E+01 -0.12123202E+01 -0.12443918E+01 -0.25759938E-02 -0.26884237E-04 -0.29847192E-01 -0.43515740E-05 -0.41598466E-03 -0.43414042E-05 0.11694874E+03 0.31784780E-03 -0.22480601E-01 -0.44513079E-05 -0.40819198E-03 -0.42600762E-05 0.25344182E+00 -0.43324235E+01 0.39093144E+01 -0.70136448E+00 -0.71717987E+00 -0.76761331E+02 -0.22302868E+02 0.71720149E+01 0.54747474E+01 -0.71747312E+00 -0.70106833E+00 0.42841805E+00 -0.69400666E-01 -0.73235287E+01 0.66083050E+01 -0.10704982E+01 -0.11855865E+01 -0.12123202E+01 -0.12975735E+03 0.19968614E+02 0.12123573E+02 0.92545130E+01 -0.14991650E+01 -0.12128166E+01 -0.11850859E+01 -0.25229950E-02 -0.26331117E-04 -0.43417094E-01 -0.47055193E-05 -0.42651542E-03 -0.44513079E-05 0.12281008E+03 0.33250862E-03 -0.33660399E-01 -0.51997375E-05 -0.43909792E-03 -0.45826245E-05 0.33584186E+00 -0.41223643E+01 0.49387264E+01 -0.73677436E+00 -0.71747312E+00 -0.82076518E+02 -0.23425410E+02 0.71290006E+01 0.63323798E+01 -0.81418837E+00 -0.73556628E+00 0.56770671E+00 -0.91962831E-01 -0.69684400E+01 0.83484175E+01 -0.13523605E+01 -0.12454426E+01 -0.12128166E+01 -0.13874205E+03 0.21352934E+02 0.12050855E+02 0.10704248E+02 -0.17339814E+01 -0.13763031E+01 -0.12434005E+01 -0.20993909E-02 -0.21910194E-04 -0.72043370E-01 -0.59875571E-05 -0.49822845E-03 -0.51997375E-05 0.15203491E+03 0.40139243E-03 -0.17673544E-01 -0.67841610E-05 -0.56341016E-03 -0.58800034E-05 0.51172148E+00 -0.33342396E+01 0.70358413E+01 -0.91161978E+00 -0.81418837E+00 -0.99703530E+02 -0.29011120E+02 0.70073651E+01 0.49196764E+01 -0.10329272E+01 -0.91112511E+00 0.86501399E+00 -0.14012105E+00 -0.56361987E+01 0.11893386E+02 -0.19265743E+01 -0.15410021E+01 -0.13763031E+01 -0.16853885E+03 0.25891734E+02 0.11845249E+02 0.83162210E+01 -0.13471200E+01 -0.17460601E+01 -0.15401659E+01 -0.16332782E-02 -0.17045630E-04 -0.21583579E+00 -0.79380892E-05 -0.65004474E-03 -0.67841610E-05 0.19890370E+03 0.50451300E-03 -0.73674286E-03 -0.76889818E-05 0.65701978E+00 -0.25502210E+01 0.12586195E+02 -0.11886468E+01 -0.10329272E+01 -0.12731025E+03 -0.37945497E+02 0.59488665E+01 -0.11727986E+01 0.11106253E+01 -0.17990509E+00 -0.43108899E+01 0.21275686E+02 -0.34463504E+01 -0.20092868E+01 -0.17460601E+01 -0.21520507E+03 0.32997687E+02 0.10055958E+02 -0.19824976E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.16016700E-02 -0.16715752E-04 -0.58803400E-03 -0.61369889E-05 0.17538637E+03 0.44541420E-03 -0.58597202E-03 -0.61154691E-05 -0.43665739E-02 -0.60994334E-05 0.29235146E+00 -0.28815324E+01 0.16458959E+01 -0.10516017E+01 -0.10373450E+03 -0.33417286E+02 0.60387736E+01 0.10591455E+01 -0.10501400E+01 -0.10517574E+01 0.49419092E+00 -0.80058621E-01 -0.48709424E+01 0.27822224E+01 -0.45071831E+00 -0.17776276E+01 -0.17535280E+03 0.26920936E+02 0.10207943E+02 0.17903796E+01 -0.29004039E+00 -0.17751567E+01 -0.17778907E+01 -0.16101520E-02 -0.16804275E-04 -0.87696541E-02 -0.61242653E-05 -0.25780045E-01 -0.61154691E-05 0.17541622E+03 0.45101433E-03 -0.53715474E-03 -0.56059899E-05 -0.58534991E-02 -0.60209255E-05 0.27282565E+00 -0.28857599E+01 0.23230251E+01 -0.10517250E+01 -0.10501400E+01 -0.10539655E+03 -0.33422495E+02 0.69798114E+01 0.20706710E+01 -0.95452483E+00 -0.10339173E+01 0.46118410E+00 -0.74711409E-01 -0.48780844E+01 0.39268383E+01 -0.63614422E+00 -0.17778344E+01 -0.17751567E+01 -0.17816218E+03 0.27363394E+02 0.11798665E+02 0.35002593E+01 -0.56703886E+00 -0.16135274E+01 -0.17477327E+01 -0.19480962E-02 -0.20331213E-04 -0.60100663E-02 -0.51464957E-05 -0.27000336E-01 -0.56059899E-05 0.14617357E+03 0.38278450E-03 -0.45616848E-03 -0.47607806E-05 -0.47816925E-03 -0.49903907E-05 0.26258576E+00 -0.34613003E+01 0.26515217E+01 -0.87638198E+00 -0.95452483E+00 -0.89727004E+02 -0.27858703E+02 0.69529221E+01 0.28803403E+01 -0.79904805E+00 -0.85854366E+00 0.44387497E+00 -0.71906941E-01 -0.58509821E+01 0.44821323E+01 -0.72609731E+00 -0.14814361E+01 -0.16135274E+01 -0.15167453E+03 0.23305832E+02 0.11753218E+02 0.48689272E+01 -0.78875738E+00 -0.13507108E+01 -0.14512822E+01 -0.23544364E-02 -0.24571963E-04 -0.93922807E-02 -0.43855448E-05 -0.53424284E-02 -0.47607806E-05 0.12277133E+03 0.32944068E-03 -0.40755025E-02 -0.42696781E-05 -0.40399608E-03 -0.42162858E-05 0.24204843E+00 -0.41229794E+01 0.30086929E+01 -0.73615276E+00 -0.79904805E+00 -0.77362189E+02 -0.23406774E+02 0.70957632E+01 0.36156603E+01 -0.71672088E+00 -0.71823623E+00 0.40915839E+00 -0.66282403E-01 -0.69694796E+01 0.50858910E+01 -0.82389872E+00 -0.12443918E+01 -0.13507108E+01 -0.13077296E+03 0.20108738E+02 0.11994671E+02 0.61119084E+01 -0.99011034E+00 -0.12115442E+01 -0.12141058E+01 -0.25253548E-02 -0.26355745E-04 -0.18423678E-01 -0.42600762E-05 -0.40911202E-03 -0.42696781E-05 0.11692724E+03 0.31697125E-03 -0.74196533E-02 -0.43598154E-05 -0.39935147E-03 -0.41678126E-05 0.23972266E+00 -0.43366092E+01 0.37977394E+01 -0.70106833E+00 -0.71672088E+00 -0.75851741E+02 -0.22298205E+02 0.71752949E+01 0.46838793E+01 -0.71750870E+00 -0.70088425E+00 0.40522718E+00 -0.65644740E-01 -0.73306042E+01 0.64196986E+01 -0.10399585E+01 -0.11850859E+01 -0.12115442E+01 -0.12821978E+03 0.19731273E+02 0.12129118E+02 0.79176295E+01 -0.12826157E+01 -0.12128767E+01 -0.11847747E+01 -0.24642846E-02 -0.25718390E-04 -0.34769833E-01 -0.45826245E-05 -0.41774879E-03 -0.43598154E-05 0.12283951E+03 0.33150008E-03 -0.67005388E-01 -0.50763157E-05 -0.43380501E-03 -0.45273854E-05 0.28433118E+00 -0.41274186E+01 0.47955485E+01 -0.73556628E+00 -0.71750870E+00 -0.83210913E+02 -0.23421014E+02 0.71502657E+01 0.76551978E+01 -0.81481601E+00 -0.75232399E+00 0.48063314E+00 -0.77858981E-01 -0.69769843E+01 0.81063905E+01 -0.13131747E+01 -0.12434005E+01 -0.12128767E+01 -0.14065965E+03 0.21674765E+02 0.12086803E+02 0.12940339E+02 -0.20962386E+01 -0.13773642E+01 -0.12717276E+01 -0.20595097E-02 -0.21493975E-04 -0.58206311E-02 -0.58800034E-05 -0.48640242E-03 -0.50763157E-05 0.15197500E+03 0.39466216E-03 -0.16491555E-01 -0.65805009E-05 0.38066337E+00 -0.33292502E+01 0.44665247E+01 -0.91112511E+00 -0.81481601E+00 -0.96579452E+02 -0.29003616E+02 0.60781023E+01 0.44853469E+01 -0.10196493E+01 0.64347336E+00 -0.10423552E+00 -0.56277646E+01 0.75502134E+01 -0.12230505E+01 -0.15401659E+01 -0.13773642E+01 -0.16325790E+03 0.25055078E+02 0.10274423E+02 0.75820305E+01 -0.12282045E+01 -0.17236152E+01 -0.16513683E-02 -0.17234427E-04 -0.85913082E-02 -0.76889818E-05 -0.63053043E-03 -0.65805009E-05 0.19286305E+03 0.48288283E-03 0.43902760E+00 -0.26270897E+01 0.61762049E+01 -0.11727986E+01 -0.10196493E+01 -0.11734177E+03 -0.36819304E+02 0.48236805E+01 0.74213181E+00 -0.12021593E+00 -0.44408299E+01 0.10440251E+02 -0.16911879E+01 -0.19824976E+01 -0.17236152E+01 -0.19835441E+03 0.30348281E+02 0.81539458E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.15936846E-02 -0.16632414E-04 -0.58443551E-03 -0.60994334E-05 0.17538475E+03 0.43905139E-03 -0.57225107E-03 -0.59722711E-05 0.28891914E+00 -0.28799247E+01 0.11461200E+01 -0.10517574E+01 -0.10259257E+03 -0.33414684E+02 0.49679571E+01 0.41685342E+00 -0.10325340E+01 0.48838892E+00 -0.79118903E-01 -0.48682248E+01 0.19374013E+01 -0.31385861E+00 -0.17778907E+01 -0.17342248E+03 0.26614646E+02 0.83978347E+01 0.70464903E+00 -0.11415300E+00 -0.17453955E+01 -0.16534664E-02 -0.17256323E-04 -0.57691304E-03 -0.60209255E-05 -0.23788469E-01 -0.59722711E-05 0.16955904E+03 0.43679250E-03 -0.51198579E-03 -0.53433153E-05 -0.53019016E-03 -0.55333043E-05 0.26840621E+00 -0.29837693E+01 0.17520136E+01 -0.10339173E+01 -0.10325340E+01 -0.10061618E+03 -0.32304568E+02 0.69340649E+01 0.12181112E+01 -0.91916787E+00 -0.96105850E+00 0.45371354E+00 -0.73501466E-01 -0.50437600E+01 0.29616017E+01 -0.47977864E+00 -0.17477327E+01 -0.17453955E+01 -0.17008148E+03 0.26113754E+02 0.11721336E+02 0.20590938E+01 -0.33357259E+00 -0.15537603E+01 -0.16245722E+01 -0.20081412E-02 -0.20957870E-04 -0.34615309E-02 -0.49903907E-05 -0.33882048E-01 -0.53433153E-05 0.14033621E+03 0.36857606E-03 -0.42975731E-03 -0.44851417E-05 -0.43381469E-03 -0.45274864E-05 0.25495473E+00 -0.36047923E+01 0.21794546E+01 -0.85854366E+00 -0.91916787E+00 -0.84868844E+02 -0.26740796E+02 0.69347739E+01 0.18542489E+01 -0.76395798E+00 -0.78531531E+00 0.43097547E+00 -0.69817658E-01 -0.60935410E+01 0.36841500E+01 -0.59682916E+00 -0.14512822E+01 -0.15537603E+01 -0.14346229E+03 0.22034918E+02 0.11722541E+02 0.31344224E+01 -0.50777376E+00 -0.12913946E+01 -0.13274970E+01 -0.24342564E-02 -0.25405001E-04 -0.11494214E-01 -0.42162858E-05 -0.14244710E-01 -0.44851417E-05 0.11693718E+03 0.31589702E-03 -0.39926474E-03 -0.41669075E-05 -0.38956671E-03 -0.40656945E-05 0.23759323E+00 -0.43266793E+01 0.26689809E+01 -0.71823623E+00 -0.76395798E+00 -0.72342964E+02 -0.22288761E+02 0.72130763E+01 0.22927909E+01 -0.70065061E+00 -0.70105282E+00 0.40162735E+00 -0.65062949E-01 -0.73138141E+01 0.45116426E+01 -0.73087850E+00 -0.12141058E+01 -0.12913946E+01 -0.12228847E+03 0.18794041E+02 0.12192977E+02 0.38757313E+01 -0.62786194E+00 -0.11843791E+01 -0.11850588E+01 -0.24659475E-02 -0.25735744E-04 -0.18922096E-01 -0.41678126E-05 -0.45151370E-02 -0.41669075E-05 0.11693079E+03 0.31609362E-03 -0.13475450E-02 -0.43649100E-05 -0.39297458E-03 -0.41012605E-05 0.22961507E+00 -0.43272116E+01 0.38466372E+01 -0.70088425E+00 -0.70065061E+00 -0.73470486E+02 -0.22293510E+02 0.71659987E+01 0.22572397E+01 -0.73402094E+00 -0.70072984E+00 0.38814131E+00 -0.62877724E-01 -0.73147185E+01 0.65023555E+01 -0.10533620E+01 -0.11847747E+01 -0.11843791E+01 -0.12419451E+03 0.19090994E+02 0.12113403E+02 0.38156380E+01 -0.61812187E+00 -0.12407890E+01 -0.11845137E+01 -0.22708331E-02 -0.23699441E-04 -0.26702316E-01 -0.45273854E-05 -0.41823695E-03 -0.43649100E-05 0.12861869E+03 0.33816896E-03 -0.44700789E-03 -0.46651766E-05 0.23735622E+00 -0.39368051E+01 0.67264661E+01 -0.75232399E+00 -0.73402094E+00 -0.80808617E+02 -0.24527093E+02 0.62140349E+01 -0.78813147E+00 0.40122669E+00 -0.64997097E-01 -0.66547709E+01 0.11370411E+02 -0.18419604E+01 -0.12717276E+01 -0.12407890E+01 -0.13659880E+03 0.20987143E+02 0.10504199E+02 -0.13322566E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.18357689E-02 -0.19158914E-04 -0.30789269E-02 -0.55333043E-05 0.15200117E+03 0.38501504E-03 -0.44948165E-03 -0.46909939E-05 0.26104710E+00 -0.33275135E+01 0.10344195E+01 -0.96105850E+00 -0.88913889E+02 -0.28961215E+02 0.51054270E+01 0.31225563E+00 -0.81361201E+00 0.44127371E+00 -0.71486405E-01 -0.56248248E+01 0.17485815E+01 -0.28327046E+00 -0.16245722E+01 -0.15029994E+03 0.23061769E+02 0.86302077E+01 0.52783656E+00 -0.85509590E-01 -0.13753288E+01 -0.22750497E-02 -0.23743447E-04 -0.23480074E-02 -0.45274864E-05 -0.29814492E-01 -0.46909939E-05 0.12279692E+03 0.32847402E-03 -0.39887265E-03 -0.41628155E-05 -0.39392972E-03 -0.41112288E-05 0.24712686E+00 -0.41177292E+01 0.15845342E+01 -0.78531531E+00 -0.81361201E+00 -0.73378153E+02 -0.23395689E+02 0.71552419E+01 0.10353616E+01 -0.71773490E+00 -0.71822949E+00 0.41774324E+00 -0.67674367E-01 -0.69606094E+01 0.26784966E+01 -0.43391621E+00 -0.13274970E+01 -0.13753288E+01 -0.12403843E+03 0.19045226E+02 0.12095220E+02 0.17501753E+01 -0.28352823E+00 -0.12132591E+01 -0.12140951E+01 -0.24024521E-02 -0.25073077E-04 -0.46378412E-02 -0.40656945E-05 -0.15979302E-01 -0.41628155E-05 0.11693584E+03 0.31502718E-03 -0.39303164E-03 -0.41018560E-05 -0.63020376E-03 -0.40657214E-05 0.22554864E+00 -0.43233388E+01 0.21047377E+01 -0.70105282E+00 -0.71773490E+00 -0.71087844E+02 -0.22285431E+02 0.71463879E+01 0.16093254E+01 -0.70076116E+00 -0.70100227E+00 0.38126714E+00 -0.61765073E-01 -0.73081667E+01 0.35578461E+01 -0.57636917E+00 -0.11850588E+01 -0.12132591E+01 -0.12016681E+03 0.18458632E+02 0.12080246E+02 0.27204018E+01 -0.44070362E+00 -0.11845658E+01 -0.11849736E+01 -0.24271249E-02 -0.25330574E-04 -0.47311540E-02 -0.41012605E-05 -0.46023346E-02 -0.41018560E-05 0.11692209E+03 0.31582529E-03 -0.42520237E-03 -0.44376044E-05 -0.18415784E-02 -0.42967900E-05 0.22919201E+00 -0.43272245E+01 0.27875323E+01 -0.70072984E+00 -0.70076116E+00 -0.72281303E+02 -0.22288936E+02 0.72148813E+01 0.21212159E+01 -0.74960785E+00 -0.73405848E+00 0.38742616E+00 -0.62762455E-01 -0.73147403E+01 0.47120446E+01 -0.76334412E+00 -0.11845137E+01 -0.11845658E+01 -0.12218432E+03 0.18776741E+02 0.12196034E+02 0.35857033E+01 -0.58087853E+00 -0.12671371E+01 -0.12408525E+01 -0.21340685E-02 -0.22272105E-04 -0.94670244E-02 -0.46651766E-05 -0.34153136E-02 -0.44376044E-05 0.13445432E+03 0.34596464E-03 0.22916280E+00 -0.37627684E+01 0.33285979E+01 -0.78813147E+00 -0.74960785E+00 -0.80766249E+02 -0.25636890E+02 0.53033841E+01 0.38737656E+00 -0.62754044E-01 -0.63605797E+01 0.56266585E+01 -0.91150468E+00 -0.13322566E+01 -0.12671371E+01 -0.13652718E+03 0.20936337E+02 0.89648357E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.23706604E-02 -0.24741284E-04 -0.70890245E-03 -0.41112288E-05 0.11692746E+03 0.31045107E-03 -0.38566782E-03 -0.40250039E-05 -0.57017845E-02 -0.40132230E-05 0.22026949E+00 -0.43217700E+01 0.12629601E+01 -0.71822949E+00 -0.69220622E+02 -0.22279374E+02 0.64444803E+01 0.58085413E+00 -0.70091648E+00 -0.70106907E+00 0.37234355E+00 -0.60319866E-01 -0.73055200E+01 0.21349078E+01 -0.34585627E+00 -0.12140951E+01 -0.11701054E+03 0.17962197E+02 0.10893749E+02 0.98187582E+00 -0.15906444E+00 -0.11848292E+01 -0.11850872E+01 -0.23783246E-02 -0.24821271E-04 -0.38956930E-03 -0.40657214E-05 -0.15054090E-01 -0.40250039E-05 0.11693855E+03 0.31474105E-03 -0.40678672E-03 -0.42454102E-05 -0.52020450E-02 -0.40252116E-05 0.21891350E+00 -0.43212217E+01 0.16629280E+01 -0.70100227E+00 -0.70091648E+00 -0.70175975E+02 -0.22282337E+02 0.71610951E+01 0.11416356E+01 -0.73450310E+00 -0.70095502E+00 0.37005118E+00 -0.59948420E-01 -0.73045892E+01 0.28110119E+01 -0.45538492E+00 -0.11849736E+01 -0.11848292E+01 -0.11862540E+03 0.18216588E+02 0.12105109E+02 0.19298198E+01 -0.31263150E+00 -0.12416034E+01 -0.11848937E+01 -0.21769643E-02 -0.22719784E-04 -0.41170983E-03 -0.42967900E-05 -0.36404805E-02 -0.42454102E-05 0.12861005E+03 0.33217568E-03 0.21844699E+00 -0.39304561E+01 0.22861829E+01 -0.73405848E+00 -0.73450310E+00 -0.76368722E+02 -0.24513213E+02 0.54017650E+01 0.36926279E+00 -0.59820451E-01 -0.66440430E+01 0.38645636E+01 -0.62605803E+00 -0.12408525E+01 -0.12416034E+01 -0.12909369E+03 0.19805802E+02 0.91311429E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 -0.23584866E-02 -0.24614233E-04 -0.38453900E-03 -0.40132230E-05 0.11692377E+03 0.30618521E-03 -0.38294690E-03 -0.39966072E-05 0.21207041E+00 -0.43203650E+01 0.82629021E+00 -0.70106907E+00 -0.68392282E+02 -0.22277164E+02 0.57248404E+01 0.19435409E+00 -0.70091203E+00 0.35848382E+00 -0.58074741E-01 -0.73031450E+01 0.13967610E+01 -0.22627669E+00 -0.11850872E+01 -0.11561031E+03 0.17740800E+02 0.96772702E+01 0.32853615E+00 -0.53223188E-01 -0.11848217E+01 -0.23613793E-02 -0.24644423E-04 -0.38568773E-03 -0.40252116E-05 -0.15551920E-01 -0.39966072E-05 0.11693647E+03 0.30622550E-03 0.21205822E+00 -0.43215731E+01 0.12126517E+01 -0.70095502E+00 -0.70091203E+00 -0.68581138E+02 -0.22279477E+02 0.57259355E+01 0.35846302E+00 -0.58071371E-01 -0.73051832E+01 0.20498654E+01 -0.33208026E+00 -0.11848937E+01 -0.11848217E+01 -0.11592949E+03 0.17786906E+02 0.96791167E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.10000000E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.73007589E+00 -0.47791410E+01 -0.80786603E+01 -0.10735529E+01 -0.45423119E+01 -0.76783303E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.12875379E+01 -0.42729598E+01 -0.72230115E+01 -0.86232178E+00 -0.44841105E+01 -0.75799067E+01 -0.73193270E+00 -0.44916564E+01 -0.75926988E+01 -0.51603338E+00 -0.45085547E+01 -0.76212363E+01 -0.61948008E+00 -0.43775531E+01 -0.73998181E+01 -0.68304074E+00 -0.42793760E+01 -0.72338543E+01 -0.71426769E+00 -0.41984834E+01 -0.70971163E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.35601016E+00 -0.15060889E+01 -0.25458927E+01 0.64500903E+00 -0.16689431E+01 -0.28211711E+01 -0.21215130E+00 -0.52607998E+01 -0.88928567E+01 -0.22257718E+00 -0.52416289E+01 -0.88604592E+01 0.83707514E+00 -0.17437449E+01 -0.29476284E+01 0.38187663E+00 -0.13952795E+01 -0.23586135E+01 0.19964828E+00 -0.11927143E+01 -0.20161661E+01 0.92284651E-01 -0.10434371E+01 -0.17638169E+01 0.67937173E-01 -0.95358111E+00 -0.16119355E+01 0.45402680E-01 -0.85441984E+00 -0.14443376E+01 0.28001318E-01 -0.79615742E+00 -0.13458247E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.19607089E-01 -0.13666893E+01 -0.23102515E+01 0.41824926E-01 -0.13828718E+01 -0.23376242E+01 0.54009602E-01 -0.13798434E+01 -0.23324877E+01 0.54886968E-01 -0.13858378E+01 -0.23426572E+01 0.41994337E-01 -0.13663276E+01 -0.23096417E+01 0.34842476E-01 -0.13133247E+01 -0.22200348E+01 0.21929996E-01 -0.12106125E+01 -0.20464221E+01 0.14816440E-01 -0.11068098E+01 -0.18709649E+01 0.71735406E-02 -0.10058716E+01 -0.17003275E+01 0.46638650E-02 -0.92740099E+00 -0.15676581E+01 0.26555312E-02 -0.85507323E+00 -0.14454159E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.36676090E-02 -0.13998433E+01 -0.23662951E+01 0.47453482E-02 -0.13948700E+01 -0.23579180E+01 0.72339044E-02 -0.14109662E+01 -0.23850976E+01 0.77620945E-02 -0.13957068E+01 -0.23593177E+01 0.74975053E-02 -0.14068059E+01 -0.23780657E+01 0.65886737E-02 -0.13862602E+01 -0.23433394E+01 0.38731180E-02 -0.13098881E+01 -0.22142374E+01 0.19912716E-02 -0.12089198E+01 -0.20435172E+01 0.34457596E-03 -0.11017995E+01 -0.18624857E+01 -0.17084600E-04 -0.10031355E+01 -0.16956826E+01 -0.41829973E-04 -0.89521077E+00 -0.15132649E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.18117608E-04 -0.14382016E+01 -0.24311360E+01 -0.19541025E-04 -0.14512249E+01 -0.24531659E+01 -0.41104053E-05 -0.14412508E+01 -0.24362913E+01 0.35810686E-03 -0.14474765E+01 -0.24468168E+01 0.86262602E-03 -0.14377778E+01 -0.24304205E+01 0.61385471E-05 -0.14467032E+01 -0.24455055E+01 -0.55054371E-05 -0.14303970E+01 -0.24179451E+01 -0.18857532E-04 -0.13150356E+01 -0.22229503E+01 -0.19545600E-04 -0.11872204E+01 -0.20068795E+01 -0.26680571E-04 -0.10736020E+01 -0.18148355E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.16404615E-04 -0.14868600E+01 -0.25133882E+01 -0.92369949E-05 -0.14778511E+01 -0.24981171E+01 -0.23710578E-04 -0.14851980E+01 -0.25105803E+01 -0.10057016E-04 -0.14792956E+01 -0.25006310E+01 -0.66869617E-05 -0.14893809E+01 -0.25176509E+01 -0.49755106E-05 -0.14752451E+01 -0.24937695E+01 -0.95114750E-05 -0.14824034E+01 -0.25058580E+01 -0.64772759E-05 -0.13795586E+01 -0.23320204E+01 -0.24176065E-04 -0.12904761E+01 -0.21814234E+01 -0.17189726E-04 -0.11638123E+01 -0.19673279E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.28471641E-04 -0.13773314E+01 -0.23282318E+01 0.95816722E-06 -0.14072786E+01 -0.23788637E+01 -0.12076326E-04 -0.14714681E+01 -0.24874129E+01 -0.10807086E-04 -0.15207585E+01 -0.25706943E+01 -0.11161304E-04 -0.15263816E+01 -0.25801916E+01 -0.20055691E-04 -0.15181462E+01 -0.25662770E+01 -0.26852077E-04 -0.15227043E+01 -0.25739554E+01 -0.19050641E-04 -0.15127609E+01 -0.25571761E+01 -0.19715413E-04 -0.14913835E+01 -0.25210167E+01 0.33878064E-05 -0.13892753E+01 -0.23484356E+01 -0.34576010E-04 -0.12239378E+01 -0.20689494E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.56398446E-04 -0.11405498E+01 -0.19279831E+01 -0.15864107E-04 -0.12545651E+01 -0.21207178E+01 -0.34396076E-04 -0.13648443E+01 -0.23071364E+01 -0.21986729E-04 -0.14743089E+01 -0.24921774E+01 0.52056130E-05 -0.15736459E+01 -0.26600491E+01 -0.13752350E-05 -0.15813178E+01 -0.26730676E+01 -0.46498680E-05 -0.15685133E+01 -0.26514487E+01 -0.19054566E-04 -0.15681498E+01 -0.26508067E+01 -0.12723450E-04 -0.15526272E+01 -0.26245537E+01 -0.41287490E-04 -0.14520409E+01 -0.24545388E+01 -0.67649937E-04 -0.12879069E+01 -0.21771004E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.33357966E-04 -0.98516893E+00 -0.16653495E+01 -0.49860107E-04 -0.11012408E+01 -0.18615406E+01 -0.29121356E-04 -0.12150149E+01 -0.20538326E+01 -0.64973913E-04 -0.13596684E+01 -0.22983959E+01 -0.47182663E-04 -0.15436715E+01 -0.26094265E+01 -0.67505641E-04 -0.15979560E+01 -0.27012088E+01 -0.28856358E-04 -0.16156942E+01 -0.27311742E+01 0.66711107E-05 -0.16110310E+01 -0.27232994E+01 -0.88580379E-05 -0.16122189E+01 -0.27252734E+01 -0.18625635E-04 -0.15272640E+01 -0.25816878E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.41683819E-04 -0.86574634E+00 -0.14634723E+01 -0.38333279E-04 -0.97176765E+00 -0.16426802E+01 -0.57507505E-04 -0.10931890E+01 -0.18479170E+01 0.68280592E-05 -0.12635463E+01 -0.21359138E+01 -0.10174167E-03 -0.14315321E+01 -0.24198258E+01 -0.66316080E-04 -0.16799063E+01 -0.28397741E+01 -0.74049959E-04 -0.16408147E+01 -0.27736115E+01 -0.53376426E-04 -0.16438845E+01 -0.27788402E+01 -0.48810071E-04 -0.16228442E+01 -0.27432591E+01 -0.73584354E-04 -0.15841441E+01 -0.26778375E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.48118420E-05 -0.66277511E+00 -0.11203550E+01 -0.18260330E-04 -0.79174586E+00 -0.13383640E+01 -0.22777606E-04 -0.88713826E+00 -0.14996240E+01 -0.42816896E-04 -0.99285880E+00 -0.16783249E+01 -0.57540209E-04 -0.11913010E+01 -0.20137940E+01 -0.12622011E-03 -0.13789037E+01 -0.23308702E+01 -0.10976066E-02 -0.65360711E+00 -0.11050275E+01 -0.13944407E-03 -0.16889513E+01 -0.28550835E+01 -0.39006204E-04 -0.16721192E+01 -0.28265820E+01 -0.49153549E-04 -0.16707199E+01 -0.28242130E+01 -0.80289801E-04 -0.16295539E+01 -0.27545982E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.94335240E-05 -0.66738691E+00 -0.11281508E+01 -0.24013672E-04 -0.65966426E+00 -0.11151072E+01 -0.33650011E-04 -0.79829526E+00 -0.13494442E+01 -0.25928102E-04 -0.93667321E+00 -0.15833201E+01 -0.32623966E-04 -0.10845518E+01 -0.18333416E+01 -0.55343833E-04 -0.12528916E+01 -0.21178357E+01 -0.79205561E-04 -0.15505039E+01 -0.26210261E+01 -0.38003714E-04 -0.17022137E+01 -0.28773975E+01 -0.48634295E-04 -0.17002884E+01 -0.28741819E+01 -0.10361308E-04 -0.16898889E+01 -0.28566784E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.59119322E-05 -0.70017737E+00 -0.11835785E+01 -0.14543802E-04 -0.66353971E+00 -0.11216505E+01 -0.27038167E-04 -0.66683954E+00 -0.11272254E+01 -0.24881679E-04 -0.66659284E+00 -0.11268136E+01 -0.22336300E-04 -0.84891238E+00 -0.14349973E+01 -0.29986663E-04 -0.10174238E+01 -0.17198650E+01 -0.30273510E-04 -0.12378458E+01 -0.20924453E+01 -0.33218393E-04 -0.15112191E+01 -0.25545802E+01 -0.12291160E-04 -0.17294887E+01 -0.29234863E+01 -0.55390439E-04 -0.16986944E+01 -0.28714782E+01 -0.67921277E-04 -0.16955332E+01 -0.28660843E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.22892619E-05 -0.79970068E+00 -0.13518220E+01 -0.34042565E-04 -0.69427548E+00 -0.11736054E+01 -0.29322870E-04 -0.66133833E+00 -0.11179188E+01 -0.18520892E-04 -0.67574534E+00 -0.11422847E+01 -0.44095333E-04 -0.73570177E+00 -0.12436208E+01 -0.13631124E-04 -0.96566424E+00 -0.16323655E+01 -0.18403631E-04 -0.11684261E+01 -0.19751242E+01 -0.30182810E-04 -0.14573423E+01 -0.24635024E+01 -0.21977258E-04 -0.17288422E+01 -0.29224149E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.96096956E-05 -0.98866951E+00 -0.16712469E+01 -0.25788017E-04 -0.89318277E+00 -0.15098393E+01 -0.17901886E-04 -0.79396960E+00 -0.13421295E+01 -0.15515695E-04 -0.66932056E+00 -0.11314188E+01 -0.20788614E-04 -0.66957888E+00 -0.11318615E+01 -0.29950432E-04 -0.71221837E+00 -0.12039388E+01 -0.79763861E-04 -0.86679264E+00 -0.14652332E+01 0.62146229E-05 -0.11891561E+01 -0.20101667E+01 -0.60913855E-04 -0.14057552E+01 -0.23763045E+01 -0.59914479E-04 -0.16912205E+01 -0.28588373E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.73316461E-05 -0.99293752E+00 -0.16784616E+01 -0.65075077E-05 -0.99357334E+00 -0.16795566E+01 -0.24474551E-04 -0.82784379E+00 -0.13993893E+01 -0.18857208E-04 -0.69572056E+00 -0.11760444E+01 -0.19047106E-04 -0.67271434E+00 -0.11371597E+01 -0.19226591E-04 -0.70880567E+00 -0.11981386E+01 -0.33449801E-04 -0.88789729E+00 -0.15009068E+01 -0.11609816E-03 -0.11333208E+01 -0.19157639E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.37105963E-05 -0.98969264E+00 -0.16729764E+01 -0.14729875E-04 -0.99001307E+00 -0.16735492E+01 -0.19591296E-04 -0.82089647E+00 -0.13876453E+01 -0.93112312E-05 -0.70053389E+00 -0.11841959E+01 -0.10793624E-04 -0.66765328E+00 -0.11286039E+01 -0.40392857E-04 -0.70163762E+00 -0.11860383E+01 0.11634927E-04 -0.89600441E+00 -0.15146117E+01 -0.99461805E-05 -0.11367258E+01 -0.19215158E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.15589030E-05 -0.99061413E+00 -0.16745341E+01 -0.25002085E-06 -0.95293809E+00 -0.16108464E+01 -0.18340935E-04 -0.79103403E+00 -0.13371649E+01 -0.12199068E-04 -0.65779221E+00 -0.11119297E+01 -0.17449818E-04 -0.66517975E+00 -0.11244218E+01 -0.15437209E-04 -0.73064797E+00 -0.12350862E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.15361566E-05 -0.85824196E+00 -0.14507853E+01 -0.12983907E-04 -0.68618697E+00 -0.11599307E+01 -0.12926853E-04 -0.65903822E+00 -0.11140329E+01 -0.10409705E-04 -0.65942056E+00 -0.11146858E+01 -0.12116367E-04 -0.76283043E+00 -0.12895077E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.53194151E-05 -0.65811632E+00 -0.11124798E+01 -0.16225085E-04 -0.65181712E+00 -0.11018309E+01 -0.12175012E-04 -0.72381679E+00 -0.12235406E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.93218916E-06 -0.65479993E+00 -0.11068738E+01 -0.11427151E-04 -0.65261348E+00 -0.11031850E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.11374207E+01 -0.35988748E+01 -0.60835282E+01 -0.81269119E+00 -0.37569236E+01 -0.63507039E+01 -0.86204067E+00 -0.37062973E+01 -0.62651237E+01 -0.86132270E+00 -0.36842788E+01 -0.62279049E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.41876580E+00 -0.43708098E+01 -0.73884170E+01 -0.57469749E+00 -0.42656638E+01 -0.72106682E+01 -0.63737822E+00 -0.42206050E+01 -0.71345108E+01 -0.64582562E+00 -0.42103360E+01 -0.71171524E+01 -0.58794794E+00 -0.42355747E+01 -0.71598159E+01 -0.46057242E+00 -0.42666316E+01 -0.72122914E+01 -0.49824978E+00 -0.42016028E+01 -0.71023894E+01 0.21671793E+00 -0.58070052E+00 -0.98161902E+00 0.11361062E+00 -0.48930719E+00 -0.82712555E+00 0.60520075E-01 -0.42085475E+00 -0.71141235E+00 0.30968605E-01 -0.38103848E+00 -0.64410745E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.47423322E-01 -0.65342197E+00 -0.11045445E+01 0.12746087E+00 -0.70065447E+00 -0.11843766E+01 0.16209582E+00 -0.71631155E+00 -0.12108532E+01 0.16496496E+00 -0.71845553E+00 -0.12144852E+01 0.12210256E+00 -0.68999000E+00 -0.11663594E+01 0.79605960E-01 -0.64335472E+00 -0.10875327E+01 0.44568974E-01 -0.58333030E+00 -0.98606204E+00 0.14726045E-01 -0.51951564E+00 -0.87819327E+00 0.60058456E-02 -0.47233539E+00 -0.79843672E+00 0.39690732E-02 -0.43482169E+00 -0.73502610E+00 0.30008818E-02 -0.40397232E+00 -0.68287481E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.64757041E-02 -0.65788842E+00 -0.11120946E+01 0.68846046E-02 -0.65510621E+00 -0.11073899E+01 0.78823979E-02 -0.65845485E+00 -0.11130522E+01 0.89068724E-02 -0.65354439E+00 -0.11047603E+01 0.88172434E-02 -0.65672103E+00 -0.11101216E+01 0.68877520E-02 -0.65015083E+00 -0.10989916E+01 0.37512450E-02 -0.61314243E+00 -0.10364566E+01 0.23534657E-02 -0.56977568E+00 -0.96315275E+00 0.12966358E-02 -0.51846792E+00 -0.87641939E+00 0.59107988E-03 -0.47296938E+00 -0.79951156E+00 0.24698769E-04 -0.42305505E+00 -0.71513230E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.69521364E-03 -0.67645089E+00 -0.11434726E+01 0.11916901E-02 -0.68104524E+00 -0.11512495E+01 0.20687820E-02 -0.67814869E+00 -0.11463429E+01 0.22345994E-02 -0.67940676E+00 -0.11484613E+01 0.23542486E-02 -0.67541762E+00 -0.11417263E+01 0.17995186E-02 -0.67841717E+00 -0.11467999E+01 0.11005083E-02 -0.67336022E+00 -0.11382489E+01 0.18317815E-03 -0.61788539E+00 -0.10444794E+01 -0.23565402E-05 -0.55906796E+00 -0.94504933E+00 -0.22613593E-05 -0.50507304E+00 -0.85377435E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.39444853E-06 -0.69842407E+00 -0.11806161E+01 -0.11278175E-05 -0.69505700E+00 -0.11749439E+01 0.17555177E-04 -0.69741390E+00 -0.11789090E+01 0.17626733E-03 -0.69548116E+00 -0.11756298E+01 0.37656054E-03 -0.69884659E+00 -0.11813309E+01 0.18953378E-03 -0.69366649E+00 -0.11725707E+01 0.19224752E-05 -0.69573161E+00 -0.11760656E+01 0.72776430E-07 -0.64863065E+00 -0.10964368E+01 -0.37043390E-05 -0.60671845E+00 -0.10255977E+01 -0.36241908E-05 -0.54781537E+00 -0.92601912E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.19012713E-04 -0.64575511E+00 -0.10915739E+01 0.51958204E-05 -0.66149195E+00 -0.11181860E+01 0.41671327E-05 -0.69065903E+00 -0.11674826E+01 0.20589718E-05 -0.71540506E+00 -0.12093218E+01 -0.41078028E-05 -0.71694651E+00 -0.12119179E+01 -0.19347201E-05 -0.71415345E+00 -0.12072059E+01 -0.23046668E-05 -0.71538948E+00 -0.12093029E+01 -0.15559414E-05 -0.71176873E+00 -0.12031754E+01 -0.73063887E-07 -0.70022290E+00 -0.11836332E+01 0.62054871E-05 -0.65305800E+00 -0.11039304E+01 -0.72453857E-05 -0.57615041E+00 -0.97392807E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.16038825E-04 -0.53943966E+00 -0.91187777E+00 -0.10430093E-05 -0.58970937E+00 -0.99684495E+00 -0.49696521E-05 -0.64340420E+00 -0.10876054E+01 -0.22329447E-05 -0.69263650E+00 -0.11708354E+01 0.10760681E-04 -0.73892071E+00 -0.12490696E+01 0.50173076E-05 -0.74118669E+00 -0.12529037E+01 0.68646709E-05 -0.73670040E+00 -0.12453183E+01 -0.13448756E-05 -0.73624371E+00 -0.12445482E+01 0.40206064E-05 -0.73075910E+00 -0.12352771E+01 -0.90326372E-05 -0.68330929E+00 -0.11550697E+01 -0.19861518E-04 -0.60926912E+00 -0.10299216E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.46458303E-05 -0.46478996E+00 -0.78568709E+00 -0.11749638E-04 -0.52107741E+00 -0.88083010E+00 -0.27788905E-05 -0.57184261E+00 -0.96663572E+00 -0.16167461E-04 -0.64224198E+00 -0.10856490E+01 -0.41299555E-05 -0.72606644E+00 -0.12273160E+01 -0.13886318E-04 -0.75255815E+00 -0.12721290E+01 -0.92050466E-05 -0.75848577E+00 -0.12821369E+01 0.79349533E-05 -0.75643700E+00 -0.12786842E+01 -0.24503081E-05 -0.75643239E+00 -0.12786750E+01 -0.17133109E-05 -0.71868438E+00 -0.12148642E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.87522032E-05 -0.40997152E+00 -0.69301945E+00 -0.81547734E-05 -0.45879548E+00 -0.77554885E+00 -0.13747454E-04 -0.51738513E+00 -0.87459035E+00 0.77440868E-05 -0.59198985E+00 -0.10007045E+01 -0.21312925E-04 -0.67509196E+00 -0.11411619E+01 0.56932475E-05 -0.78494207E+00 -0.13268755E+01 -0.13946572E-04 -0.77182693E+00 -0.13046697E+01 -0.11045417E-04 -0.77288926E+00 -0.13064968E+01 -0.11674239E-04 -0.76545634E+00 -0.12939092E+01 -0.19866208E-04 -0.74732760E+00 -0.12632829E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.34535457E-05 -0.31336739E+00 -0.52971623E+00 0.24296697E-06 -0.37415911E+00 -0.63247865E+00 -0.22256012E-05 -0.41950437E+00 -0.70913135E+00 -0.10299729E-04 -0.46842439E+00 -0.79182793E+00 -0.11236372E-04 -0.56268915E+00 -0.95117478E+00 -0.17455445E-04 -0.64775557E+00 -0.10949579E+01 -0.50071338E-04 -0.72985406E+00 -0.12337681E+01 -0.10169126E-04 -0.79241794E+00 -0.13395053E+01 -0.54241855E-05 -0.78673965E+00 -0.13299096E+01 -0.27368962E-05 -0.78572068E+00 -0.13281721E+01 -0.21514621E-04 -0.77033882E+00 -0.13021807E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.22923616E-05 -0.31547640E+00 -0.53328130E+00 -0.40516783E-05 -0.31265450E+00 -0.52851059E+00 -0.57661815E-05 -0.37775848E+00 -0.63856463E+00 -0.25586938E-05 -0.44268374E+00 -0.74831429E+00 -0.49584183E-05 -0.51081530E+00 -0.86348621E+00 -0.66552786E-05 -0.59014282E+00 -0.99756439E+00 -0.39262067E-05 -0.72695048E+00 -0.12288458E+01 0.21200911E-05 -0.80108884E+00 -0.13541672E+01 -0.10099852E-04 -0.79986012E+00 -0.13520873E+01 0.49990834E-05 -0.79593480E+00 -0.13454764E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.21803910E-05 -0.33082342E+00 -0.55923432E+00 0.27233588E-06 -0.31431008E+00 -0.53131064E+00 -0.19962890E-05 -0.31593264E+00 -0.53405116E+00 -0.37438644E-05 -0.31593646E+00 -0.53406066E+00 -0.61062647E-06 -0.40074212E+00 -0.67742088E+00 -0.43291055E-05 -0.48068105E+00 -0.81254646E+00 -0.50593711E-05 -0.58274882E+00 -0.98507711E+00 -0.29719517E-05 -0.71178735E+00 -0.12032092E+01 -0.94859199E-06 -0.81300493E+00 -0.13743075E+01 -0.12937396E-04 -0.80142190E+00 -0.13547251E+01 -0.17955245E-04 -0.80004249E+00 -0.13523941E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.34550382E-05 -0.37763105E+00 -0.63835282E+00 -0.66919980E-05 -0.32900294E+00 -0.55614735E+00 -0.28111336E-05 -0.31413021E+00 -0.53100365E+00 -0.88323442E-06 -0.31961926E+00 -0.54028648E+00 -0.10614214E-04 -0.34939198E+00 -0.59060352E+00 0.10594819E-05 -0.45497981E+00 -0.76910013E+00 -0.46984886E-05 -0.55102613E+00 -0.93145259E+00 -0.48102490E-05 -0.68564782E+00 -0.11590213E+01 -0.95605717E-06 -0.81497777E+00 -0.13776385E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.19850434E-05 -0.46652454E+00 -0.78861308E+00 -0.34539835E-05 -0.42162136E+00 -0.71271825E+00 -0.68278058E-06 -0.37578995E+00 -0.63523639E+00 -0.98047378E-06 -0.31653168E+00 -0.53506158E+00 -0.16492219E-05 -0.31753365E+00 -0.53676042E+00 -0.51517036E-05 -0.33705691E+00 -0.56976425E+00 -0.22231837E-04 -0.41263982E+00 -0.69752866E+00 0.84971603E-05 -0.55866818E+00 -0.94437437E+00 -0.15677310E-04 -0.66436600E+00 -0.11230482E+01 -0.13341378E-04 -0.79867406E+00 -0.13500775E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.23323241E-05 -0.46751943E+00 -0.79029484E+00 0.10315786E-04 -0.46854070E+00 -0.79201667E+00 -0.33532295E-05 -0.39108471E+00 -0.66109043E+00 -0.16521591E-06 -0.32960973E+00 -0.55717415E+00 -0.12620752E-05 -0.31825347E+00 -0.53797677E+00 -0.22622202E-05 -0.33569787E+00 -0.56745673E+00 -0.64161669E-05 -0.41959159E+00 -0.70927964E+00 -0.31584037E-04 -0.54021088E+00 -0.91317481E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.60439200E-05 -0.46607089E+00 -0.78784623E+00 -0.20541069E-05 -0.46682901E+00 -0.78912858E+00 -0.17550235E-05 -0.38831959E+00 -0.65641592E+00 0.19694874E-05 -0.33082038E+00 -0.55921016E+00 0.14344787E-05 -0.31605076E+00 -0.53425337E+00 -0.84770233E-05 -0.33268918E+00 -0.56236811E+00 0.89194562E-05 -0.42185938E+00 -0.71311363E+00 0.26511716E-06 -0.53598003E+00 -0.90603132E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.54260049E-05 -0.46620085E+00 -0.78806591E+00 0.27218236E-05 -0.44965874E+00 -0.76011034E+00 -0.12675630E-05 -0.37355368E+00 -0.63145550E+00 0.86251805E-06 -0.31144821E+00 -0.52647519E+00 -0.94779313E-06 -0.31461331E+00 -0.53182295E+00 -0.12677737E-05 -0.34610251E+00 -0.58504794E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.77216518E-05 -0.40432863E+00 -0.68347667E+00 -0.65683610E-07 -0.32459688E+00 -0.54869865E+00 0.38143907E-06 -0.31162344E+00 -0.52676415E+00 0.10659711E-05 -0.31201245E+00 -0.52742629E+00 -0.31393068E-07 -0.36084677E+00 -0.60998104E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.30716571E-05 -0.31077867E+00 -0.52534027E+00 -0.43111039E-06 -0.30882335E+00 -0.52203278E+00 0.12214547E-05 -0.34230789E+00 -0.57863771E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.46257771E-05 -0.30947873E+00 -0.52314285E+00 0.11230187E-05 -0.30889848E+00 -0.52216158E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.15262064E+01 -0.33090381E+01 -0.55935980E+01 -0.10995579E+01 -0.35566602E+01 -0.60121910E+01 -0.95196898E+00 -0.36325096E+01 -0.61403943E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.71494664E+00 -0.41858508E+01 -0.70757623E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.10504815E+01 -0.38935606E+01 -0.65816757E+01 -0.65785838E+00 -0.41074444E+01 -0.69432242E+01 -0.57144652E+00 -0.41371735E+01 -0.69934691E+01 0.41099112E+00 -0.69170369E+00 -0.11692564E+01 0.16529191E+00 -0.51152301E+00 -0.86468364E+00 0.62338300E-01 -0.42756221E+00 -0.72275117E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.19487414E+00 -0.78161394E+00 -0.13212404E+01 -0.21719217E+00 -0.46521428E+01 -0.78639731E+01 -0.22592071E+00 -0.46393976E+01 -0.78424377E+01 -0.23935866E+00 -0.46285000E+01 -0.78240151E+01 -0.24464477E+00 -0.46217358E+01 -0.78125822E+01 0.37947245E+00 -0.85786354E+00 -0.14501260E+01 0.13127482E+00 -0.67509707E+00 -0.11411847E+01 0.48557227E-01 -0.57819252E+00 -0.97736893E+00 0.13526292E-01 -0.51461205E+00 -0.86990111E+00 0.61471090E-02 -0.47132774E+00 -0.79673015E+00 0.49468496E-02 -0.43830867E+00 -0.74091705E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.15593223E-01 -0.71408510E+00 -0.12070895E+01 0.26556009E-01 -0.71720185E+00 -0.12123663E+01 0.33724910E-01 -0.72368244E+00 -0.12233129E+01 0.40136961E-01 -0.72143388E+00 -0.12195293E+01 0.38753434E-01 -0.72356315E+00 -0.12231114E+01 0.18237140E-01 -0.70780665E+00 -0.11964704E+01 0.79213715E-02 -0.66372107E+00 -0.11219548E+01 0.49058533E-02 -0.61682435E+00 -0.10426771E+01 0.18340632E-02 -0.56160525E+00 -0.94933894E+00 0.15584380E-02 -0.51443330E+00 -0.86959745E+00 0.32433237E-03 -0.45990383E+00 -0.77742144E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.20026106E-02 -0.73284130E+00 -0.12387949E+01 0.21106504E-02 -0.73617889E+00 -0.12444157E+01 0.31036832E-02 -0.73192112E+00 -0.12372398E+01 0.39019721E-02 -0.73361373E+00 -0.12401391E+01 0.47250335E-02 -0.72988246E+00 -0.12337936E+01 0.17903180E-02 -0.73172469E+00 -0.12369094E+01 0.16765488E-02 -0.72839585E+00 -0.12312815E+01 0.14747603E-02 -0.67142582E+00 -0.11349873E+01 0.47992153E-03 -0.60735601E+00 -0.10266754E+01 -0.21995421E-05 -0.54837970E+00 -0.92698122E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.37540469E-03 -0.75821003E+00 -0.12816782E+01 0.75929842E-03 -0.75484646E+00 -0.12760103E+01 0.12721476E-02 -0.75757842E+00 -0.12806112E+01 0.17610847E-02 -0.75572739E+00 -0.12774873E+01 0.21797866E-02 -0.75948931E+00 -0.12838413E+01 0.18340514E-02 -0.75382956E+00 -0.12742610E+01 0.95625940E-03 -0.75576823E+00 -0.12775516E+01 0.95307621E-05 -0.70377734E+00 -0.11896828E+01 0.18464373E-05 -0.65871648E+00 -0.11134952E+01 0.44716180E-05 -0.59489957E+00 -0.10056409E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.17576459E-04 -0.70136215E+00 -0.11855891E+01 0.12008442E-04 -0.71811897E+00 -0.12139083E+01 0.12018808E-04 -0.74951824E+00 -0.12669860E+01 0.93681519E-05 -0.77657870E+00 -0.13127299E+01 0.16778629E-05 -0.77794654E+00 -0.13150384E+01 0.44673968E-05 -0.77491752E+00 -0.13099213E+01 0.15071943E-05 -0.77637248E+00 -0.13124036E+01 0.48165762E-05 -0.77243688E+00 -0.13057289E+01 0.10478180E-04 -0.75998537E+00 -0.12846952E+01 0.13107010E-04 -0.70906833E+00 -0.11986107E+01 -0.50722414E-05 -0.62548585E+00 -0.10573175E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.12419986E-04 -0.58595184E+00 -0.99048779E+00 0.48147855E-05 -0.64045010E+00 -0.10826171E+01 -0.25142174E-05 -0.69877984E+00 -0.11812119E+01 0.43019547E-05 -0.75183846E+00 -0.12709097E+01 0.16630537E-04 -0.80204649E+00 -0.13557728E+01 0.12346482E-04 -0.80415182E+00 -0.13593403E+01 0.67621486E-05 -0.79931157E+00 -0.13511575E+01 0.51967287E-05 -0.79893118E+00 -0.13505158E+01 0.89498202E-05 -0.79328363E+00 -0.13409688E+01 -0.33266488E-05 -0.74180317E+00 -0.12539472E+01 -0.15233154E-04 -0.66154749E+00 -0.11182700E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.19223968E-05 -0.50530184E+00 -0.85416090E+00 -0.61814809E-05 -0.56649563E+00 -0.95760501E+00 -0.22013850E-05 -0.62106131E+00 -0.10498414E+01 -0.10310776E-04 -0.69739357E+00 -0.11788763E+01 -0.23673627E-05 -0.78808910E+00 -0.13321802E+01 -0.63241010E-05 -0.81636590E+00 -0.13799877E+01 0.41924869E-05 -0.82277577E+00 -0.13908122E+01 0.15804959E-04 -0.82081299E+00 -0.13875044E+01 0.17387077E-04 -0.82106924E+00 -0.13879656E+01 0.45349850E-05 -0.78004278E+00 -0.13185844E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 -0.51280017E-05 -0.44622403E+00 -0.75429165E+00 -0.25244722E-05 -0.49903143E+00 -0.84356416E+00 -0.88417906E-05 -0.56253212E+00 -0.95090892E+00 0.15206261E-04 -0.64274428E+00 -0.10864996E+01 -0.19964766E-04 -0.73232426E+00 -0.12379073E+01 0.19901317E-04 -0.85106672E+00 -0.14386503E+01 -0.65841589E-05 -0.83701939E+00 -0.14148842E+01 -0.39377926E-05 -0.83856117E+00 -0.14175079E+01 -0.74456242E-05 -0.83089133E+00 -0.14045317E+01 -0.14641721E-04 -0.81118722E+00 -0.13712309E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.10031318E-04 -0.34175735E+00 -0.57770662E+00 0.52204219E-05 -0.40770908E+00 -0.68918729E+00 0.43838974E-05 -0.45671306E+00 -0.77202937E+00 -0.12448984E-05 -0.50938593E+00 -0.86107302E+00 -0.35282645E-05 -0.61147283E+00 -0.10336386E+01 -0.92237562E-05 -0.70257277E+00 -0.11876224E+01 -0.19790747E-04 -0.79155376E+00 -0.13380632E+01 -0.12311129E-04 -0.85899104E+00 -0.14520437E+01 0.24987754E-05 -0.85350853E+00 -0.14427760E+01 -0.48216252E-05 -0.85269814E+00 -0.14414079E+01 -0.15858060E-04 -0.83627770E+00 -0.14136442E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.90615401E-05 -0.34417517E+00 -0.58179372E+00 -0.22372602E-07 -0.34086435E+00 -0.57619304E+00 0.62647501E-06 -0.41160313E+00 -0.69577591E+00 0.47173876E-05 -0.48184793E+00 -0.81451995E+00 0.20263113E-05 -0.55529347E+00 -0.93867174E+00 -0.31757637E-05 -0.64052595E+00 -0.10827418E+01 0.76586851E-05 -0.78831985E+00 -0.13325834E+01 0.14396884E-05 -0.86912419E+00 -0.14691915E+01 -0.29478576E-05 -0.86794837E+00 -0.14671827E+01 0.31289099E-06 -0.86401590E+00 -0.14605308E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.87405669E-05 -0.36063124E+00 -0.60961186E+00 0.66210980E-05 -0.34285397E+00 -0.57956141E+00 0.16397731E-05 -0.34464530E+00 -0.58258152E+00 0.20268795E-05 -0.34443634E+00 -0.58223663E+00 0.45575515E-05 -0.43651951E+00 -0.73788988E+00 0.26015813E-05 -0.52291758E+00 -0.88394325E+00 0.53487280E-06 -0.63317006E+00 -0.10702990E+01 0.56459683E-05 -0.77282508E+00 -0.13063867E+01 0.62247018E-05 -0.88255714E+00 -0.14919108E+01 -0.61726221E-05 -0.86985659E+00 -0.14704068E+01 -0.17331946E-04 -0.86850716E+00 -0.14681238E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.14162502E-04 -0.41144323E+00 -0.69550083E+00 -0.11975233E-05 -0.35867596E+00 -0.60630658E+00 0.22588616E-05 -0.34272098E+00 -0.57933422E+00 0.56065710E-05 -0.34865306E+00 -0.58936467E+00 -0.48043723E-05 -0.38072807E+00 -0.64358021E+00 0.82632406E-05 -0.49521199E+00 -0.83710889E+00 0.37626127E-05 -0.59891220E+00 -0.10124041E+01 0.21057070E-05 -0.74460432E+00 -0.12586812E+01 0.12678650E-04 -0.88531777E+00 -0.14965587E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.85396360E-05 -0.50760401E+00 -0.85805382E+00 -0.18473856E-05 -0.45894137E+00 -0.77579345E+00 0.57245816E-05 -0.40948922E+00 -0.69220165E+00 0.42157353E-05 -0.34518905E+00 -0.58350421E+00 0.47307198E-05 -0.34642022E+00 -0.58559044E+00 -0.70538838E-06 -0.36749160E+00 -0.62120511E+00 -0.17704109E-04 -0.44920918E+00 -0.75934523E+00 0.14319676E-04 -0.60747806E+00 -0.10268680E+01 -0.10025376E-04 -0.72165070E+00 -0.12198814E+01 -0.29572064E-05 -0.86753038E+00 -0.14664712E+01 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.85821419E-05 -0.50854347E+00 -0.85964188E+00 0.16493335E-04 -0.51003093E+00 -0.86216342E+00 0.24876358E-05 -0.42590887E+00 -0.71995724E+00 0.59709092E-05 -0.35943482E+00 -0.60758471E+00 0.49496341E-05 -0.34715486E+00 -0.58683164E+00 0.42827298E-05 -0.36596509E+00 -0.61862629E+00 -0.57452087E-06 -0.45678338E+00 -0.77214869E+00 -0.26366656E-04 -0.58794746E+00 -0.99385686E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.12565208E-04 -0.50695871E+00 -0.85696300E+00 0.46891907E-05 -0.50808141E+00 -0.85886385E+00 0.41420104E-05 -0.42289361E+00 -0.71486018E+00 0.80703502E-05 -0.36065842E+00 -0.60965826E+00 0.77446881E-05 -0.34474650E+00 -0.58276050E+00 -0.25735036E-05 -0.36269755E+00 -0.61310652E+00 0.16030019E-04 -0.45925201E+00 -0.77632187E+00 0.99968945E-05 -0.58320085E+00 -0.98583832E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.11964946E-04 -0.50713051E+00 -0.85725341E+00 0.99516441E-05 -0.48943012E+00 -0.82733309E+00 0.46683721E-05 -0.40693178E+00 -0.68787787E+00 0.39080770E-05 -0.33966027E+00 -0.57416086E+00 0.50132371E-05 -0.34315556E+00 -0.58007083E+00 0.78247889E-05 -0.37733096E+00 -0.63783911E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.99089532E-05 -0.44026646E+00 -0.74422855E+00 0.54465978E-05 -0.35375295E+00 -0.59798408E+00 0.48361284E-05 -0.33992768E+00 -0.57461634E+00 0.68805448E-05 -0.34022345E+00 -0.57511425E+00 0.98595301E-05 -0.39338020E+00 -0.66496888E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.92026895E-05 -0.33896389E+00 -0.57298455E+00 0.35225491E-05 -0.33682498E+00 -0.56935837E+00 0.76078588E-05 -0.37324699E+00 -0.63093700E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.10923226E-04 -0.33757462E+00 -0.57063614E+00 0.59470629E-05 -0.33692929E+00 -0.56954298E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 0.00000000E+00 itsol-1.0.0/TESTS_HB/matfile_hb0000640000265600020320000000062711062577476015276 0ustar tilleaadmin2 'MATRICES/PORES3' 'PORES3' 'MATRICES/SHERMAN5' 'SHERMAN5' first line is the number of matrices to be tested [called numat in drivers] The second line gives the full path name of the file and the name of the file, this may be something like '/project/scicom00/DATA/MATRICES/MATRICES/SIMON/RAEFSKY6' 'RAEFSKY6' the name is printed in the output table Repeat for as many matrices as indicated by numat itsol-1.0.0/README0000640000265600020320000002061511064041051012636 0ustar tilleaadmin======================================================================= --> Version 1.0 Latest changes made on: Tue Sep 16 18:32:57 CDT 2008 +======================================================================+ |------------------- Iterative Solvers Package ------------------------| +======================================================================+ NOTE*** iluc has been temporily removed for a fix This is part of the ITSOL extention to the SPARSKIT package. This particular sub-package provides preconditioners for solving general sparse * real-valued * linear systems of equations. Main Contributors: Brian Suchomel, Na Li, Zhongze Li, Daniel Osei-Kuffuor, and Yousef Saad. Current contacts: Daniel Osei Kuffuor (dosei@cs.umn.edu) Yousef Saad (saad@cs.umn.edu) Apr. 2008 ======================================================================= This library contains a number of classic and new preconditioners. There are several ways in which you can use these preconditioners for solving a linear system. The easiest way is probably to use the sample drivers provided in the directories TESTS_COO and TESTS_HB as templates. TESTS_COO contains test codes for matrices in coordinate or matrix-market format while TESTS_HB is for matrices in the old Harwell- Boeing format. Each if these drivers has a name of the form mainPRECONhb.c or mainPRECONcoo where PRECON is one of ILUK standard ILU preconditioner with level of fill ILUT standard ILU preconditioner with threshold ILUC standard ILU preconditioner with threshold - Crout version ARMS Algebraic Multilevel Solvers == This includes both the standard ARMS and a version with nonsymmetric permutations which reorders the matrix by diagonal dominance VBILUT Variable Block ILUT preconditioner VBILUK Variable Block ILUK preconditioner For example, mainILUThb.c is a driver which reads a matrix in a Harwell-Boeing format (or a sequence of such matrices for consecutive tests -- see below), then constructs an ILUT preconditioner and proceeds to solve the system with the accelerator fgmres. There is only one accelerator used for the iteration phase, namely FGMRES (fgmr.c). This uses two wrapper structs MAT for the matrix [for matvecs] PRE for the preconditoner (preconditioning operation). These structs include substructs for each of the data-structures required by the above preconditioners and pointers to functions. Only one of these, along with one matvec function needs to be instantiated (set) for the MAT struct. Similarly one member and a corresponding function pointer of PRE needs to be instantiated. Thus, a driver mainPREC (resp mainPRECcoo) does the following steps 1/ read the matrix in Harwell-Boeing (resp. coo) format 2/ convert it to any required format 3/ construct the preconditioner -- get its struct -- say LU 4/ set MAT, PRE [by filling the appropriate members] 5/ call fgmr(MAT, PRE, + other parameters). 6/ output various results in OUT/PRECON.out Once you are familiar with the preconditioners and various structs, you should be able to bypass the wrapper structs MAT and PREC. In fact a second way of using the preconditioner is to build it directly by a call to the appropriate function and then call your own accelerator. For example, fgmr can be easily modified to pass directly the structs needed for the iteration. Thus, if your preconditioner is ILUK and you have the 'iluptr' struct LU and the 'csptr' struct CSMAT for the preconditioner and matrix respectively, you can simply issue the call call fgmr(CSmat, LU, + other parameters). and replace the matvec routines and preconditioner calls by the appropriate ones == These are available in LIB/MatOps.c ------------------------------------------------------------------------- ---------------- DETAILS ON THE PRECONDITIONERS ------------------------- ------------------------------------------------------------------------- ILU* These are the standard ILU(k), ILUT, preconditioners and the new, Crout-based ILU preconditoner. ILUT and ILUK are simple translations of the corresonding version in the old sparskit. ILUC is new and it is written in an "experimental" version which allows various dropping strategies [5 different ones] drivers: mainILUThb, mainILUKhb, mainILUChb, and mainILUTcoo, mainILUKcoo, mainILUCcoo, these produce the executables ilut.ex iluk.ex iluc.ex ARMS Algebraic Multilevel Solvers. This includes both the standard ARMS and a version with nonsymmetric permutations which reorders the matrix by diagonal dominance. drivers mainARMShb and mainARMScoo which produce the executable arms.ex VB block variants of ILUT and ILUK preconditioners with variable blocks. drivers mainVBILUThb, mainVBILUKhb, mainVBILUTcoo and VBILUKcoo which produce the executables vbilut.ex and vbiluk.ex ------------------------------------------------------------------------- ---------------- DETAILS ON THE DRIVERS --------------------------------- ------------------------------------------------------------------------- Each main driver reads input parameters from the file inputs This is done with the function "read_inputs". The parameters that are read are the same for all drivers - though some of these are not used by the drivers. For example droptol is not used by the level-of-fill techniques [iluk]. Note that the arms drivers set some other parameters to a default via the `set_arms_params' function -- which is in the 'auxill.c' file. The execution of the driver consists of looping through a number of matrices in harwell-boeing format and for each of them, a preset number of tests is done. The list of matrices used for the test is in the file: matfile_coo (coordinate format) and matfile_hb (harwell-Boeing format) These files begin with a number "nmat" of matrices to be read followed by nmat lines each consisting of a pathname for the matrix file followed by a short name that will be used for creating out filenames. The other major loop in the driver will loop through parameters. The parameters for dropping are tightened at each loop as instructed by the choice of lfilInc (how to increase the lfil parameter) and tolMul (scalar by which to multiply the drop tolerance at each new loop). SAMPLE_MATRICES: two ------------------------------------------------------------------------- -------------- porting itsol solvers into packages----------------------- ------------------------------------------------------------------------- It is recommended to test the various solvers with different options to see what works best. For this it is useful to imitate the general framework of the drivers provided. You can for example generate the matrix in coordinate format and then convert it to the internal csr format (called SparMat) by the function COOcs. Then you can call whatever preconditioner set-up function (e.g. ilut) to obtain the desired preconditioner- The pointers in MAT and PRE can then be set -- for example when using ILUT: MAT->n = n; matrix size MAT->CSR = csmat; matrix A itself [for matvecs] MAT->matvec = matvecCSR; ptr to matvec routine PRE->ILU = lu; preconditioner struct PRE->precon = preconILU; ptr to corresponding precon oper. You are now ready to call the accelerator: fgmr(MAT, PRE, rhs, sol, tol, krydim, itmax, outputs); -------------------------------------------------- updated Apr. 7th, 2008 A few of the changes in the April 2008 version ** quite a few small fixes. ** added test codes for the COO format -- this is the same essentially as the matrix-market format. ** chaged a few names -- SparRow became SparMat -- VBsparRow became VBSparMat. nnzrow became nzcount. These changes were made to avoid confusions [in fact confusion lead to some small errors in earlier versions].. Specifically nnzrow used to count number of nonzeros in rows or in columns.. ** ILUC [or possibly just the main routine calling it] seems to have a problem -- it will put back after this is fixed. itsol-1.0.0/vbilut.c0000640000265600020320000002517011062577476013457 0ustar tilleaadmin#include #include #include #include "LIB/globheads.h" #ifndef min #define min(a,b) (((a)>(b))?(b):(a)) #endif #ifndef max #define max(a,b) (((a)>(b))?(a):(b)) #endif #define qsplit qsplit_ #define gauss gauss_ #define bxinv bxinv_ #define dgemm dgemm_ /*-------------------- protos */ void *Malloc(int nbytes, char *msg); void zrmC(int m, int n, BData data); void copyBData(int m, int n, BData dst, BData src, int isig); void dgemm(char*, char*, int*, int*, int*, double*, double*, int*, double*, int*, double*, double*, int*) ; int vblusolC(double *y, double *x, vbiluptr lu); void gauss (int *, double*, int*); void bxinv (int*, int*, double*,double*,double*); int setupVBILU(vbiluptr lu, int n, int *bsz); void qsplit(double*, int*, int*, int*) ; /*-------------------- END protos */ int vbilutC( vbsptr vbmat, vbiluptr lu, int lfil, double tol, BData *w, FILE *fp ) { /*---------------------------------------------------------------------------- * Block ILUT (BILUT) preconditioner * Block incomplete LU factorization with dual truncation mechanism * NOTE : no pivoting implemented as yet in GE for diagonal blocks *---------------------------------------------------------------------------- * Parameters *---------------------------------------------------------------------------- * on entry: * ========= * vbmat = block matrix stored in VBSpaFmt format -- see globheads.h for * details on format, the block sizes might be different * lu = pointer to a VBILUSpar struct -- see globheads.h for details * on format * lfil = integer. The fill-in parameter. Each row of L and * each row of U will have a maximum of lfil elements. * WARNING: THE MEANING OF LFIL HAS CHANGED WITH RESPECT TO * EARLIER VERSIONS. * lfil must be .ge. 0. * tol = real*8. Sets the threshold for dropping small terms in the * factorization. See below for details on dropping strategy. * w = working array * fp = file pointer for error log ( might be stdout ) * * on return: * ========== * ierr = return value. * ierr = 0 --> successful return. * ierr = -1 --> Illegal value for lfil * ierr = -2 --> singular block or zero row encountered * lu->n = dimension of the block matrix * ->bsz = the row/col of the first element of each diagonal block * the size of the i-th row block should be bsz[i+1] - bsz[i] * ->L = L part -- stored in VBSpaFmt format * ->D = Diagonals * ->U = U part -- stored in VBSpaFmt format *---------------------------------------------------------------------------- * Notes: * ====== * All the diagonal blocks of the input block matrix must not be singular *---------------------------------------------------------------------------- * Dual drop-off strategy works as follows. * * 1) Theresholding in L and U as set by tol. Any element whose size * is less than some tolerance (relative to the norm of current * row in u) is dropped. * * 2) Keeping only the largest lfil elements in the i-th row of L * and the largest lfil elements in the i-th row of U. * * Flexibility: one can use tol=0 to get a strategy based on keeping the * largest elements in each row of L and U. Taking tol .ne. 0 but lfil=n * will give the usual threshold strategy (however, fill-in is then * impredictible). *--------------------------------------------------------------------------*/ int n = vbmat->n, *bsz = vbmat->bsz, ierr; double one = 1.0, zero = 0.0; int dim, szjrow, sz, len, lenu, lenl, col, jpos, jrow, upos, para; int max_blk_sz = MAX_BLOCK_SIZE*MAX_BLOCK_SIZE*sizeof(double); int nzcount, *ja, *jbuf, *iw, i, j, k, kk; double t, tnorm, tolnorm, *xnrm, *wn, vbnorm2( int, double * ); vbsptr L, U; BData *ba, *D, buf_fact, buf_ns; if( lfil < 0 ) { fprintf( fp, "vbilut: Illegal value for lfil.\n" ); return -1; } setupVBILU( lu, n, bsz ); L = lu->L; U = lu->U; D = lu->D; iw = lu->work; jbuf = (int *)Malloc( n*sizeof(int), "vbilut" ); buf_fact = (BData)Malloc( max_blk_sz, "vbilut" ); buf_ns = (BData)Malloc( max_blk_sz, "vbilut" ); xnrm = (double *)Malloc( n * sizeof(double), "vbilut" ); wn = (double *)Malloc( n * sizeof(double), "vbilut" ); /* set indicator array jw to -1 */ for( i = 0; i < n; i++ ) iw[i] = -1; /* beginning of main loop */ for( i = 0; i < n; i++ ) { dim = B_DIM(bsz,i); /* number of rows of blocks in i-th row */ nzcount = vbmat->nzcount[i]; ja = vbmat->ja[i]; ba = vbmat->ba[i]; tnorm = 0; for( j = 0; j < nzcount; j++ ) { sz = B_DIM(bsz,ja[j]); t = vbnorm2( dim * sz, ba[j] ); tnorm = max(t,tnorm); } if( tnorm == 0.0 ) { fprintf( fp, "vbilut: zero row encountered.\n" ); return -2; } tolnorm = tol * tnorm; /* unpack L-part and U-part of row of A in arrays w */ lenu = 1; lenl = 0; jbuf[i] = i; zrmC( dim, dim, w[i] ); iw[i] = i; for( j = 0; j < nzcount; j++ ) { col = ja[j]; sz = B_DIM(bsz,col); t = vbnorm2( dim * sz, ba[j] ); if( t < tolnorm && col != i ) continue; if( col < i ) { jbuf[lenl] = col; iw[col] = lenl; copyBData( dim, sz, w[lenl], ba[j], 0 ); lenl++; } else if( col == i ) { copyBData( dim, dim, w[i], ba[j], 0 ); } else { jpos = i + lenu; jbuf[jpos] = col; iw[col] = jpos; copyBData( dim, sz, w[jpos], ba[j], 0 ); lenu++; } } j = -1; len = 0; /* eliminate previous rows */ while( ++j < lenl ) { /*---------------------------------------------------------------------- * in order to do the elimination in the correct order we must select * the smallest column index among jw(k), k=j+1, ..., lenl. *--------------------------------------------------------------------*/ jrow = jbuf[j]; jpos = j; /* determine smallest column index */ for( k = j + 1; k < lenl; k++ ) { if( jbuf[k] < jrow ) { jrow = jbuf[k]; jpos = k; } } szjrow = B_DIM(bsz,jrow); if( jpos != j ) { col = jbuf[j]; jbuf[j] = jbuf[jpos]; jbuf[jpos] = col; iw[jrow] = j; iw[col] = jpos; sz = B_DIM(bsz,col); copyBData( dim, sz, buf_ns, w[j], 0 ); copyBData( dim, szjrow, w[j], w[jpos], 0 ); copyBData( dim, sz, w[jpos], buf_ns, 0 ); } /* get the multiplier for row to be eliminated (jrow). */ /* fact = w(jj)*alu(jrow) */ bxinv( &dim, &szjrow, D[jrow], w[j], buf_fact ); /* zero out element in row by resetting jw(n+jrow) to -1 */ iw[jrow] = -1; if( vbnorm2( dim * szjrow, buf_fact ) * xnrm[jrow] <= tolnorm ) continue; /* combine current row and row jrow */ nzcount = U->nzcount[jrow]; ja = U->ja[jrow]; ba = U->ba[jrow]; for( k = 0; k < nzcount; k++ ) { col = ja[k]; sz = B_DIM(bsz,col); dgemm ("n","n",&dim, &sz, &szjrow, &one, buf_fact, &dim, ba[k], &szjrow, &zero, buf_ns, &dim ); jpos = iw[col]; /* if fill-in element is small then disregard: */ if( vbnorm2( dim * sz, buf_ns ) < tolnorm && jpos == -1 ) continue; if( col >= i ) { /* dealing with upper part */ // if( jpos == -1 ) { if( jpos == -1 && vbnorm2( dim * sz, buf_ns ) > tolnorm) { /* this is a fill-in element */ upos = i + lenu; jbuf[upos] = col; iw[col] = upos; copyBData( dim, sz, w[upos], buf_ns, 0 ); lenu++; } else { /*-------------------- this is not a fill-in element */ for (kk=0;kknzcount[i] = len; if( len > 0 ) { L->ja[i] = (int *)Malloc( len * sizeof(int), "vbilut" ); L->ba[i] = (BData *)Malloc( len * sizeof(BData), "vbilut" ); } ja = L->ja[i]; ba = L->ba[i]; for( j = 0; j < len; j++ ) { jpos = iw[j]; ja[j] = jbuf[jpos]; sz = B_DIM(bsz,ja[j]); ba[j] = (BData)Malloc( dim*sz*sizeof(double), "vbilut" ); copyBData( dim, sz, ba[j], w[jpos], 0 ); } for( j = 0; j < lenl; j++ ) iw[j] = -1; /* update u-matrix */ len = min( lenu, lfil ); for( j = 1; j < lenu; j++ ) { jpos = i+j; sz = B_DIM(bsz,jbuf[jpos]); wn[j-1] = vbnorm2( dim*sz, w[jpos] ); iw[j-1] = jpos; } para = lenu - 1; qsplit( wn, iw, ¶, &len ); nzcount = U->nzcount[i] = len-1; if( nzcount > 0 ) { U->ja[i] = (int *)Malloc( nzcount*sizeof(int), "vbilut" ); U->ba[i] = (BData *)Malloc( nzcount*sizeof(BData), "vbilut" ); } ja = U->ja[i]; ba = U->ba[i]; t = vbnorm2( dim*dim, w[i] ); for( j = 0; j < nzcount; j++ ) { jpos = iw[j]; ja[j] = jbuf[jpos]; sz = B_DIM(bsz,ja[j]); ba[j] = (BData)Malloc( dim*sz*sizeof(double), "vbilut" ); copyBData( dim, sz, ba[j], w[jpos], 0 ); t = max(t,wn[j]); } for( j = 0; j < lenu-1; j++ ) iw[j] = -1; /* save norm in xnrm. Norm = average abs value. divide by len+1 * instead of len to avoid division by zero. */ xnrm[i] = t; /* store inverse of diagonal element of u */ D[i] = (BData)Malloc( dim*dim*sizeof(double), "vbilut" ); copyBData( dim, dim, D[i], w[i], 0 ); gauss( &dim, D[i], &ierr ); if( ierr != 0 ) { fprintf( fp, "singular block encountered.\n" ); for( j = i+1; j < n; j++ ) { D[j] = NULL; L->ja[j] = NULL; L->ba[j] = NULL; U->ja[j] = NULL; U->ba[j] = NULL; } return -2; } for( j = 0; j < lenu; j++ ) { iw[ jbuf[i+j] ] = -1; } } lu->DiagOpt = 1; free( jbuf ); free( buf_fact ); free( buf_ns ); free( xnrm ); free( wn ); return 0; } itsol-1.0.0/TESTS_COO/0000750000265600020320000000000011064037472013367 5ustar tilleaadminitsol-1.0.0/TESTS_COO/mainVBILUTcoo.c0000640000265600020320000002520111062577473016117 0ustar tilleaadmin/*---------------------------------------------------------------------------* * main test driver for VBILU * *---------------------------------------------------------------------------* * Na Li, Aug 26, 2001 -- YS 2005 * * * * Report bugs / send comments to: saad@cs.umn.edu, nli@cs.umn.edu * *---------------------------------------------------------------------------*/ #include #include #include #include #include "../LIB/globheads.h" #include "../LIB/defs.h" #include "../LIB/protos.h" #include "../ios.h" #include /*-------------------- protos */ void output_header_vb( io_t *pio ); void output_result( int lfil, io_t *pio, int iparam ); int read_inputs( char *in_file, io_t *pio ); int get_matrix_info( FILE *fmat, io_t *pio ); int read_coo(double **VAL, int **COL, int **ROW, io_t *pio, double **rhs, double **sol); void randvec (double *v, int n); void output_blocks( int nBlock, int *nB, FILE *f ); void output_perm( int n, int *perm, FILE *f ); /*-------------------- end protos */ int main() { int ierr = 0; /*------------------------------------------------------------------- * options *-----------------------------------------------------------------*/ int plotting = 0, output_mat = 0, skip_its = 0, diagscal = 0; char pltfile[256]; FILE *fits = NULL; csptr csmat = NULL; vbsptr vbmat = NULL; vbiluptr lu = NULL; SMatptr MAT; SPreptr PRE; double *sol = NULL, *x = NULL, *rhs0 = NULL, *rhs = NULL; BData *w = NULL; int lfil, max_blk_sz = MAX_BLOCK_SIZE*MAX_BLOCK_SIZE*sizeof(double); int nBlock, *nB = NULL, *perm = NULL; double tol; FILE *flog = stdout, *fmat = NULL; io_t io; double tm1=0.0, tm2=0.0; int mat, numat, iparam, i; double terr; char line[MAX_LINE]; int *ROW, *COL; double *VAL; int n, nnz; MAT = (SMatptr)Malloc( sizeof(SMat), "main:MAT" ); PRE = (SPreptr)Malloc( sizeof(SPre), "main:PRE" ); /*------------------------------------------------------------------- * reads matrix from Harwell Boeing file * * solves using block level of fill ILU preconditioned fgmres * *-----------------------------------------------------------------*/ memset( &io, 0, sizeof(io) ); /*-----------------------------------------------------------------*/ if( read_inputs( "inputs", &io ) != 0 ) { fprintf( flog, "Invalid inputs file...\n" ); goto ERROR_HANDLE; } /* set any parameters manually */ /* io.eps is the angle tolerance for grouping two columns in same supernode. This is a cosine and should be <= 1. */ io.eps = 0.8; /*-------------------- matfile_coo contains paths to matrices */ if( NULL == ( fmat = fopen( "matfile_coo", "r" ) ) ) { fprintf( flog, "Can't open matfile_coo...\n" ); goto ERROR_HANDLE; } memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, fmat ); if( ( numat = atoi( line ) ) <= 0 ) { fprintf( flog, "Invalid count of matrices...\n" ); goto ERROR_HANDLE; } /*-------------------- open file OUT/ILUT.out for all performance results of this run (all matrices and params) also set io->PrecMeth */ /* sprintf( io.outfile, "OUT/%s_ILUT.out", io.HBnameF );*/ strcpy(io.outfile,"OUT/ILUT.out"); strcpy(io.PrecMeth,"Variable Block ILUT (VBILUT)"); if( NULL == ( io.fout = fopen( io.outfile, "w" ) ) ) { fprintf(flog,"Can't open output file %s...\n", io.outfile); goto ERROR_HANDLE; } /* LOOP THROUGH MATRICES ------------------------------------------*/ for( mat = 1; mat <= numat; mat++ ) { if( get_matrix_info( fmat, &io ) != 0 ) { fprintf( flog, "Invalid format in matfile_coo...\n" ); goto ERROR_HANDLE; } fprintf( flog, "MATRIX: %s...\n", io.HBnameF ); /* Read in matrix and allocate memory------------------------------*/ csmat = (csptr)Malloc( sizeof(SparMat), "main" ); ierr = read_coo(&VAL,&COL, &ROW, &io, &rhs, &sol); n = io.ndim; nnz = io.nnz; if( ierr != 0 ) { fprintf( flog, "read_coo error = %d\n", ierr ); goto ERROR_HANDLE; } else fprintf(stdout," matrix read successfully \n"); if( ( ierr = COOcs( n, nnz, VAL, COL, ROW, csmat ) ) != 0 ) { fprintf( stderr, "ILUT: zCOOcs error\n" ); return ierr; } /*-------------------- COO arrays no longer needed -- free */ free(ROW); ROW = NULL; free(VAL); VAL = NULL; free(COL); COL = NULL; /*-------------------- DIAGONAL SCALING --- */ if (diagscal ==1) { int nrm=1; double *diag; diag = (double *)Malloc( sizeof(double)*n, "mainILUC:diag" ); ierr = roscalC( csmat, diag, nrm); if( ierr != 0 ) { fprintf( stderr, "main-vbiluk: roscal: a zero row...\n" ); return ierr; } ierr = coscalC( csmat, diag, nrm ); if( ierr != 0 ) { fprintf( stderr, "main-vbiluk: roscal: a zero col...\n" ); return ierr; } free(diag); } /*---------------------------------------------------------------------- | The right-hand side is generated by assuming the solution is | a vector of ones. To be changed if rhs0 is available from data. |---------------------------------------------------------------------*/ rhs0 = (double *)Malloc( io.ndim * sizeof(double), "main" ); rhs = (double *)Malloc( io.ndim * sizeof(double), "main" ); x = (double *)Malloc( io.ndim * sizeof(double), "main" ); for( i = 0; i < io.ndim; i++ ) x[i] = 1.0; matvec( csmat, x, rhs0 ); ierr = init_blocks( csmat, &nBlock, &nB, &perm, io.eps, &io.tm_h, &io.tm_a ); io.tm_b = io.tm_h + io.tm_a; if( ierr != 0 ) { fprintf( flog, "*** in init_blocks ierr != 0 ***\n" ); goto ERROR_HANDLE; } /*----- permutes the rows and columns of the matrix ------------------*/ if( dpermC( csmat, perm ) != 0 ) { fprintf( flog, "*** dpermC error ***\n" ); goto ERROR_HANDLE; } /*----- permutes right hand side -------------------------------------*/ for( i = 0; i < io.ndim; i++ ) rhs[perm[i]] = rhs0[i]; /*-------------------- convert to block matrix. */ vbmat = (vbsptr)Malloc( sizeof(VBSparMat), "main" ); ierr = csrvbsrC( 1, nBlock, nB, csmat, vbmat ); if( ierr != 0 ) { fprintf( flog, "*** in csrvbsr ierr != 0 ***\n" ); goto ERROR_HANDLE; } if( output_mat ) { char matdata[MAX_LINE]; FILE *fmatlab; int ii, jj; sprintf( matdata, "OUT/%s.dat", io.HBnameF ); if( NULL != ( fmatlab = fopen( matdata, "w" ) ) ) { fprintf( fmatlab, "%d %d 0\n", csmat->n, csmat->n ); for( ii = 0; ii < csmat->n; ii++ ) for( jj = 0; jj < csmat->nzcount[ii]; jj++ ) fprintf( fmatlab, "%d %d 1\n", ii+1, csmat->ja[ii][jj]+1 ); fclose( fmatlab ); } } io.rt_v = (double)csmat->n / (double)vbmat->n; io.rt_e = (double)nnzCS( csmat ) / (double)nnzVBMat( vbmat ); io.ceff = (double)nnzCS( csmat ) / (double)memVBMat( vbmat ) * 100; output_header_vb( &io ); lfil = io.lfil0; tol = io.tol0; w = (BData *)Malloc(vbmat->n*sizeof(BData),"main"); for( i = 0; i < vbmat->n; i++ ) w[i] = (double *)Malloc( max_blk_sz, "main" ); /* LOOP THROUGH PARAMETERS ---------------------------------------*/ for( iparam = 1; iparam <= io.nparam; iparam++ ) { fprintf( flog, "iparam = %d\n", iparam ); lu = (vbiluptr)Malloc( sizeof(VBILUSpar), "main" ); fprintf( flog, "begin vbilut\n" ); tm1 = sys_timer(); /*-------------------- call VBILUT preconditioner set-up */ ierr = vbilutC( vbmat, lu, lfil, tol, w, flog ); tm2 = sys_timer(); if( ierr == -2 ) { fprintf( io.fout, "Singular diagonal block...\n" ); cleanVBILU( lu ); goto NEXT_MAT; } else if( ierr != 0 ) { fprintf( flog, "*** vbilu error, ierr != 0 ***\n" ); goto ERROR_HANDLE; } io.tm_p = tm2 - tm1; io.fillfact = (double)nnz_vbilu( lu )/(double)(io.nnz + 1); fprintf( flog, "vbilut ends, fill factor (mem used) = %f\n", io.fillfact ); if( skip_its ) { io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } if( VBcondestC( lu, sol, x, flog ) != 0 ) { fprintf( flog, "Not attempting iterative solution.\n" ); fprintf( io.fout, "Not attempting iterative solution.\n" ); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } /*-------------------- initial guess */ /* for( i = 0; i < io.ndim; i++ ) x[i] = 0.0; */ randvec(x, n); /*-------------------- create a file for printing */ if(plotting ) { sprintf( pltfile, "OUT/%s_VBILUT_F%05d_T%08.6f", io.HBnameF, lfil,tol); if( NULL == ( fits = fopen( pltfile, "w" ) ) ) { fprintf( flog, "Can't open output file %s...\n", pltfile ); goto ERROR_HANDLE; } } else fits =NULL; /*-------------------- set up the structs before calling fgmr */ MAT->n = n; MAT->CSR = csmat; MAT->matvec = matvecCSR; PRE->VBILU = lu; PRE->precon = preconVBR; /*-------------------- call fgmr */ io.its = io.maxits; tm1 = sys_timer(); fgmr(MAT, PRE, rhs, x, io.tol, io.im, &io.its, fits); tm2 = sys_timer(); io.tm_i = tm2 - tm1; if( io.its < io.maxits ) fprintf( flog, "param %03d OK: converged in %d steps...\n\n", iparam, io.its ); else fprintf( flog, "not converged in %d steps...\n\n", io.maxits ); if( fits ) fclose( fits ); /* calculate residual norm */ vbmatvec( vbmat, x, sol ); terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( rhs[i] - sol[i] ) * ( rhs[i] - sol[i] ); io.rnorm = sqrt(terr); /* get sol vector of original matrix (before permutation) */ for( i = 0; i < io.ndim; i++ ) sol[perm[i]] = x[i]; /* calculate error norm */ terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( sol[i] - 1.0 ) * ( sol[i] - 1.0 ); io.enorm = sqrt(terr); NEXT_PARA: output_result( lfil, &io, iparam ); lfil += io.lfilInc; tol *= io.tolMul; cleanVBILU( lu ); } NEXT_MAT: /* output_blocks( nBlock, nB, io.fout ); */ for( i = 0; i < vbmat->n; i++ ) free( w[i] ); free( w ); cleanCS( csmat ); cleanVBMat( vbmat ); free( nB ); free( perm ); free( sol ); free( x ); free( rhs0 ); free( rhs ); } fclose( io.fout ); if( flog != stdout ) fclose ( flog ); fclose( fmat ); free(MAT); free(PRE); return 0; ERROR_HANDLE: errexit( "main.c\n" ); return 1; } itsol-1.0.0/TESTS_COO/mainILUTcoo.c0000640000265600020320000002046111062577473015672 0ustar tilleaadmin/*---------------------------------------------------------------------------* * main test driver for ILUT * *---------------------------------------------------------------------------* * Na Li, Oct 31, 2001 * * * * Report bugs / send comments to: saad@cs.umn.edu, nli@cs.umn.edu * *---------------------------------------------------------------------------*/ #include #include #include #include #include "../LIB/globheads.h" #include "../LIB/defs.h" #include "../LIB/protos.h" #include "../ios.h" #include /*-------------------- protos */ void output_header( io_t *pio ); void output_result( int lfil, io_t *pio, int iparam ); int read_inputs( char *in_file, io_t *pio ); int get_matrix_info( FILE *fmat, io_t *pio ); int read_coo(double **VAL, int **COL, int **ROW, io_t *pio, double **rhs, double **sol); void randvec (double *v, int n); /*-------------------- end protos */ int main () { int ierr = 0; /*------------------------------------------------------------------- * options *-----------------------------------------------------------------*/ /* -- plotting is for writing stats into OUT/.... in raw form */ int plotting = 0, output_lu = 0, diagscal = 0; char pltfile[256]; FILE *fits = NULL; csptr csmat = NULL; SMatptr MAT; SPreptr PRE; iluptr lu = NULL; double *sol = NULL, *x = NULL, *rhs = NULL; int lfil; double tol; /*-------------------- temp Harwell Boeing arrays */ double *VAL; int *ROW, *COL; int n, nnz; /*-------------------- end*/ FILE *flog = stdout, *fmat = NULL; io_t io; double tm1=0.0, tm2=0.0; int mat, numat, iparam, i; double terr; char line[MAX_LINE]; /*-------------------- allocates structs for preconditoiner and matrix */ MAT = (SMatptr)Malloc( sizeof(SMat), "main:MAT" ); PRE = (SPreptr)Malloc( sizeof(SPre), "main:PRE" ); /*-------------------- read parameters and other inputs */ memset( &io, 0, sizeof(io) ); if( read_inputs( "inputs", &io ) != 0 ) { fprintf( flog, "Invalid inputs file...\n" ); goto ERROR_HANDLE; } /*-------------------- matfile_coo contains paths to matrices */ if( NULL == ( fmat = fopen( "matfile_coo", "r" ) ) ) { fprintf( flog, "Can't open matfile_coo...\n" ); goto ERROR_HANDLE; } memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, fmat ); if( ( numat = atoi( line ) ) <= 0 ) { fprintf( flog, "Invalid count of matrices...\n" ); goto ERROR_HANDLE; } /*-------------------- open file OUT/ILUT.out for all performance results of this run (all matrices and params) also set io->PrecMeth */ /* sprintf( io.outfile, "OUT/%s_ILUT.out", io.HBnameF );*/ strcpy(io.outfile,"OUT/ILUT.out"); strcpy(io.PrecMeth,"ILUT"); if( NULL == ( io.fout = fopen( io.outfile, "w" ) ) ) { fprintf(flog,"Can't open output file %s...\n", io.outfile); goto ERROR_HANDLE; } /*-------------------- LOOP THROUGH MATRICES */ for( mat = 1; mat <= numat; mat++ ) { if( get_matrix_info( fmat, &io ) != 0 ) { fprintf( flog, "Invalid format in matfile_coo...\n" ); goto ERROR_HANDLE; } fprintf( flog, "MATRIX: %s...\n", io.HBnameF ); /*-------------------- Read matrix in COO format*/ csmat = (csptr)Malloc( sizeof(SparMat), "main" ); ierr = read_coo(&VAL,&COL, &ROW, &io, &rhs, &sol); n = io.ndim; nnz = io.nnz; if( ierr != 0 ) { fprintf( flog, "read_coo error = %d\n", ierr ); goto ERROR_HANDLE; } else fprintf(stdout," matrix read successfully \n"); /*-------------------- conversion from COO to CS format */ if( ( ierr = COOcs( n, nnz, VAL, COL, ROW, csmat ) ) != 0 ) { fprintf( stderr, "ILUT: zCOOcs error\n" ); return ierr; } /*-------------------- COO arrays no longer needed -- free */ free(ROW); ROW = NULL; free(VAL); VAL = NULL; free(COL); COL = NULL; /*-------------------- DIAGONAL SCALING ------*/ if (diagscal ==1) { int nrm=1; double *diag; diag = (double *)Malloc( sizeof(double)*n, "mainILUC:diag" ); ierr = roscalC( csmat, diag, nrm); if( ierr != 0 ) { fprintf( stderr, "main-ilut: roscal: a zero row...\n" ); return ierr; } ierr = coscalC( csmat, diag, nrm ); if( ierr != 0 ) { fprintf( stderr, "main-ilut: roscal: a zero col...\n" ); return ierr; } free(diag); } /*---------------------------------------------------------------------- | The right-hand side is generated by assuming the solution is | a vector of ones. To be changed if rhs is available from data. |---------------------------------------------------------------------*/ x = (double *)Malloc( io.ndim * sizeof(double), "main" ); for( i = 0; i < io.ndim; i++ ) x[i] = 1.0; matvec( csmat, x, rhs ); output_header( &io ); /*-------------------- set initial lfil and tol */ lfil = io.lfil0; tol = io.tol0; /*-------------------- LOOP through parameters */ for( iparam = 1; iparam <= io.nparam; iparam++ ) { fprintf( flog, "iparam = %d\n", iparam ); lu = (iluptr)Malloc( sizeof(ILUSpar), "main" ); fprintf( flog, "begin ilut\n" ); tm1 = sys_timer(); /*-------------------- call ILUT preconditioner set-up */ ierr = ilut( csmat, lu, lfil, tol, flog ); tm2 = sys_timer(); if( ierr != 0 ) { fprintf( io.fout, " *** ILUT error - code %d \n", ierr); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } if(output_lu ) { char matdata[MAX_LINE]; sprintf( matdata, "OUT/%s.dat", io.HBnameF ); outputLU( lu, matdata ); } io.tm_p = tm2 - tm1; io.fillfact = (double)nnz_ilu( lu )/(double)(io.nnz + 1); fprintf( flog, "ilut ends, fill factor (mem used) = %f\n", io.fillfact ); if( condestLU( lu, sol, x, flog ) != 0 ) { fprintf( flog, "Not attempting iterative solution.\n" ); fprintf( io.fout, "Not attempting iterative solution.\n" ); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } /*-------------------- initial guess */ /* for( i = 0; i < io.ndim; i++ ) x[i] = 0.0; */ randvec(x, n); /*-------------------- create a file for printing 'its -- time -- res' info from fgmres */ if(plotting ) { sprintf( pltfile, "OUT/%s_ILUT_F%05d_T%08.6f", io.HBnameF, lfil,tol); if( NULL == ( fits = fopen( pltfile, "w" ) ) ) { fprintf( flog, "Can't open output file %s...\n", pltfile ); goto ERROR_HANDLE; } } else fits =NULL; /*-------------------- set up the structs before calling fgmr */ MAT->n = n; MAT->CSR = csmat; MAT->matvec = matvecCSR; PRE->ILU = lu; PRE->precon = preconILU; /*-------------------- call fgmr */ io.its = io.maxits; tm1 = sys_timer(); fgmr(MAT, PRE, rhs, x, io.tol, io.im, &io.its, fits ); tm2 = sys_timer(); io.tm_i = tm2 - tm1; if( io.its < io.maxits ) fprintf( flog, "param %03d OK: converged in %d steps...\n\n", iparam, io.its ); else fprintf( flog, "not converged in %d steps...\n\n", io.maxits ); if( fits ) fclose( fits ); /*-------------------- calculate error and res norms */ terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( x[i] - 1.0 ) * ( x[i] - 1.0 ); io.enorm = sqrt(terr); matvec( csmat, x, sol ); terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( rhs[i] - sol[i] ) * ( rhs[i] - sol[i] ); io.rnorm = sqrt(terr); /*-------------------- Test with next params */ NEXT_PARA: output_result( lfil, &io, iparam ); lfil += io.lfilInc; tol *= io.tolMul; cleanILU(lu); } /*-------------------- Test with next matrix */ /* NEXT_MAT: --- not used! */ cleanCS( csmat ); free( sol ); free( x ); free( rhs ); } fclose( io.fout ); if( flog != stdout ) fclose ( flog ); fclose( fmat ); free(MAT) ; free (PRE); return 0; ERROR_HANDLE: exit( -1 ); } itsol-1.0.0/TESTS_COO/makefile0000640000265600020320000000244711062577474015110 0ustar tilleaadmin# this makefile is for LINUX machines only # LINKS = -L../ -litsol \ -L/project/scicom/scicom00/SOFT/lib/Linux32 -llapack \ -L/project/scicom/scicom00/SOFT/lib/linux32 -lblas ##-L/project/scicom/scicom00/SOFT/lib/linux/linux32 -llapack_LINUX \ ## -L/project/scicom/scicom00/SOFT/lib/linux/linux32 -lblas_LINUX # FC = f77 FCFLAGS = -c -g -Wall CC = cc CCFLAGS = -c -DLINUX -Wall -O3 LD = f77 LDFLAGS = # # clear list of default suffixes, and declare default suffixes .SUFFIXES: .SUFFIXES: .f .c .o # default rule to make .o files from .f files .f.o : ; $(FC) $(FCFLAGS) $*.f -o $*.o .c.o : ; $(CC) $(CCFLAGS) $*.c -o $*.o # #all: arms.ex iluk.ex ilut.ex iluc.ex vbiluk.ex vbilut.ex all: arms.ex iluk.ex ilut.ex vbiluk.ex vbilut.ex arms.ex: mainARMScoo.o $(LD) $(LDFLAGS) mainARMScoo.o $(LINKS) -o arms.ex iluk.ex: mainILUKcoo.o $(LD) $(LDFLAGS) mainILUKcoo.o $(LINKS) -o iluk.ex ilut.ex: mainILUTcoo.o $(LD) $(LDFLAGS) mainILUTcoo.o $(LINKS) -o ilut.ex ##iluc.ex: mainILUCcoo.o ## $(LD) $(LDFLAGS) mainILUCcoo.o $(LINKS) -o iluc.ex vbiluk.ex: mainVBILUKcoo.o $(LD) $(LDFLAGS) mainVBILUKcoo.o $(LINKS) -o vbiluk.ex vbilut.ex: mainVBILUTcoo.o $(LD) $(LDFLAGS) mainVBILUTcoo.o $(LINKS) -o vbilut.ex # clean : rm -f *.o *.ex *~ core *.cache OUT/* itsol-1.0.0/TESTS_COO/OUT/0000750000265600020320000000000011062574350014035 5ustar tilleaadminitsol-1.0.0/TESTS_COO/OUT/ILUK.out0000640000265600020320000000315211062577474015346 0ustar tilleaadmin ====================================================== MATRIX TESTED MATRIX PORES3 ------------------------------------------------------ SIZE = 532 NonZeros = 3474 PRECONDITIONER = ILUK ====================================================== ------------------------------------------------------------------------- | lf | tol | P-T | I-T | nz(LU)/nz | Its | ErrNorm | RsdNorm | ------------------------------------------------------------------------- | 2 | 0 | 0.000 | 0.000 | 1.939 | 12 | 3.9e-05 | 0.00029 | ------------------------------------------------------------------------- | 3 | 0 | 0.000 | 0.010 | 2.608 | 11 | 7.5e-05 | 0.001 | ------------------------------------------------------------------------- ====================================================== MATRIX TESTED MATRIX SHERMAN5 ------------------------------------------------------ SIZE = 3312 NonZeros = 20793 PRECONDITIONER = ILUK ====================================================== ------------------------------------------------------------------------- | lf | tol | P-T | I-T | nz(LU)/nz | Its | ErrNorm | RsdNorm | ------------------------------------------------------------------------- | 2 | 0 | 0.030 | 0.040 | 3.075 | 16 | 0.0001 | 1.6e-05 | ------------------------------------------------------------------------- | 3 | 0 | 0.070 | 0.020 | 5.121 | 12 | 0.00017 | 3.7e-05 | ------------------------------------------------------------------------- itsol-1.0.0/TESTS_COO/OUT/ILUT.out0000640000265600020320000000315211062577474015357 0ustar tilleaadmin ====================================================== MATRIX TESTED MATRIX PORES3 ------------------------------------------------------ SIZE = 532 NonZeros = 3474 PRECONDITIONER = ILUT ====================================================== ------------------------------------------------------------------------- | lf | tol | P-T | I-T | nz(LU)/nz | Its | ErrNorm | RsdNorm | ------------------------------------------------------------------------- | 30 | 0.1 | 0.000 | 0.000 | 1.097 | 24 | 0.00023 | 0.00043 | ------------------------------------------------------------------------- | 35 | 0.01 | 0.010 | -0.000 | 1.376 | 14 | 4.9e-05 | 0.00023 | ------------------------------------------------------------------------- ====================================================== MATRIX TESTED MATRIX SHERMAN5 ------------------------------------------------------ SIZE = 3312 NonZeros = 20793 PRECONDITIONER = ILUT ====================================================== ------------------------------------------------------------------------- | lf | tol | P-T | I-T | nz(LU)/nz | Its | ErrNorm | RsdNorm | ------------------------------------------------------------------------- | 30 | 0.1 | -0.000 | 0.020 | 1.246 | 20 | 1.5e-05 | 7.4e-06 | ------------------------------------------------------------------------- | 35 | 0.01 | 0.020 | 0.030 | 2.291 | 13 | 4.2e-06 | 4.9e-06 | ------------------------------------------------------------------------- itsol-1.0.0/TESTS_COO/OUT/ARMS.out0000640000265600020320000000315211062577474015344 0ustar tilleaadmin ====================================================== MATRIX TESTED MATRIX PORES3 ------------------------------------------------------ SIZE = 532 NonZeros = 3474 PRECONDITIONER = ARMS ====================================================== ------------------------------------------------------------------------- | lf | tol | P-T | I-T | nz(LU)/nz | Its | ErrNorm | RsdNorm | ------------------------------------------------------------------------- | 30 | 0.1 | 0.000 | 0.030 | 0.346 | 142 | 0.0022 | 0.0016 | ------------------------------------------------------------------------- | 35 | 0.01 | 0.000 | 0.010 | 0.613 | 38 | 0.00034 | 0.0011 | ------------------------------------------------------------------------- ====================================================== MATRIX TESTED MATRIX SHERMAN5 ------------------------------------------------------ SIZE = 3312 NonZeros = 20793 PRECONDITIONER = ARMS ====================================================== ------------------------------------------------------------------------- | lf | tol | P-T | I-T | nz(LU)/nz | Its | ErrNorm | RsdNorm | ------------------------------------------------------------------------- | 30 | 0.1 | 0.010 | 0.090 | 0.573 | 56 | 2e-05 | 3.6e-05 | ------------------------------------------------------------------------- | 35 | 0.01 | 0.010 | 0.030 | 1.258 | 15 | 3.4e-06 | 1.3e-05 | ------------------------------------------------------------------------- itsol-1.0.0/TESTS_COO/OUT/VBILUK.out0000640000265600020320000000534611062577474015605 0ustar tilleaadmin ====================================================== MATRIX TESTED MATRIX PORES3 ------------------------------------------------------ SIZE = 532 NonZeros = 3474 PRECONDITIONER = Variable Block ILUK (VBILUK) | with angle tolerance : 0.80 | ====================================================== =============== PRECONDITIONER STATS ================= | Time of Hash | Time of Angle | Time of Total | ------------------------------------------------------ | -0.000 | -0.000 | -0.000 | ------------------------------------------------------ | V cmpr. rate | E cmpr. rate | Cmpr. Effc. (%) | ------------------------------------------------------ | 1.68 | 2.62 | 81.28 | ====================================================== ------------------------------------------------------------------------- | lf | tol | P-T | I-T | nz(LU)/nz | Its | ErrNorm | RsdNorm | ------------------------------------------------------------------------- | 2 | 0 | -0.000 | 0.010 | 2.073 | 12 | 3.8e-05 | 0.00028 | ------------------------------------------------------------------------- | 3 | 0 | -0.000 | 0.010 | 2.857 | 11 | 5.9e-05 | 0.00097 | ------------------------------------------------------------------------- ====================================================== MATRIX TESTED MATRIX SHERMAN5 ------------------------------------------------------ SIZE = 3312 NonZeros = 20793 PRECONDITIONER = Variable Block ILUK (VBILUK) | with angle tolerance : 0.80 | ====================================================== =============== PRECONDITIONER STATS ================= | Time of Hash | Time of Angle | Time of Total | ------------------------------------------------------ | -0.000 | 0.010 | 0.010 | ------------------------------------------------------ | V cmpr. rate | E cmpr. rate | Cmpr. Effc. (%) | ------------------------------------------------------ | 1.18 | 1.86 | 83.14 | ====================================================== ------------------------------------------------------------------------- | lf | tol | P-T | I-T | nz(LU)/nz | Its | ErrNorm | RsdNorm | ------------------------------------------------------------------------- | 2 | 0 | 0.050 | 0.090 | 3.316 | 16 | 6e-06 | 1.5e-05 | ------------------------------------------------------------------------- | 3 | 0 | 0.100 | 0.100 | 5.386 | 13 | 3.4e-06 | 4.8e-06 | ------------------------------------------------------------------------- itsol-1.0.0/TESTS_COO/mainARMScoo.c0000640000265600020320000002163111062577473015657 0ustar tilleaadmin/*---------------------------------------------------------------------------* * main test driver for the ARMS2 preconditioner for * Matrices in the Coordinate format *---------------------------------------------------------------------------* * Yousef Saad - Aug. 2005. * * * * Report bugs / send comments to: saad@cs.umn.edu * *---------------------------------------------------------------------------*/ #include #include #include "string.h" #include #include "../LIB/globheads.h" #include "../LIB/defs.h" #include "../LIB/protos.h" #include "../ios.h" #include #define TOL_DD 0.2 /* diagonal dominance tolerance for ind-*/ /*-ependent sets */ /*-------------------- protos */ void output_header(io_t *pio ); void output_result(int lfil, io_t *pio, int iparam ); void set_arms_pars(io_t* io, int Dscale, int *ipar, double *tolcoef, int *lfil); int read_coo(double **VAL, int **COL, int **ROW, io_t *pio, double **rhs, double **sol); int read_inputs( char *in_file, io_t *pio ); int get_matrix_info( FILE *fmat, io_t *pio ); void randvec (double *v, int n); /*-------------------- end protos */ int main () { int ierr = 0; /*------------------------------------------------------------------- * options *-----------------------------------------------------------------*/ int plotting = 0, diagscal = 1; char pltfile[256]; FILE *fits = NULL; double tol, tolind = TOL_DD; int j, lfil; csptr csmat = NULL; /* matrix in csr formt */ arms ArmsSt = NULL; /* arms preconditioner structure */ SMatptr MAT = NULL; /* Matrix structure for matvecs */ SPreptr PRE = NULL; /* general precond structure */ double *sol = NULL, *x = NULL, *rhs = NULL; /*-------------------- method for incrementing lfil is set here */ int lfil_arr[7]; double droptol[7], dropcoef[7]; int ipar[18]; /*-------------------- coordinate format temporary arrays */ double *VAL; int *ROW, *COL; int nnz, n; /*-------------------- IO-related */ FILE *flog = stdout; /* to output stats */ FILE *fmat = NULL; /* matrix file */ io_t io; /* structure for handling I/O functions + a few other things */ double tm1, tm2; int mat, numat, iparam, i; double terr; char line[MAX_LINE]; MAT = (SMatptr)Malloc( sizeof(SMat), "main:MAT" ); PRE = (SPreptr)Malloc( sizeof(SPre), "main:PRE" ); /*------------------------------------------------------------------- * reads matrix from Harwell Boeing file * solves using ARMS preconditioned fgmres *-----------------------------------------------------------------*/ memset(&io, 0, sizeof(io) ); /*-----------------------------------------------------------------*/ if( read_inputs( "inputs", &io ) != 0 ) { fprintf( flog, "ERROR reading inputs from file...\n" ); goto ERROR_HANDLE; } /*-------------------- matfile_coo contains paths to matrices */ if( NULL == ( fmat = fopen( "matfile_coo", "r" ) ) ) { fprintf( flog, "Can't open matfile_coo...\n" ); goto ERROR_HANDLE; } memset(line, 0, MAX_LINE ); fgets(line, MAX_LINE, fmat ); if( (numat = atoi( line ) ) <= 0 ) { fprintf( flog, "Invalid count of matrices...\n" ); goto ERROR_HANDLE; } /*-------------------- set parameters for arms */ set_arms_pars(&io, diagscal, ipar, dropcoef, lfil_arr); /*-------------------- open file OUT/ARMS.out for all performance results of this run (all matrices and params) also set io->PrecMeth */ /* sprintf( io.outfile, "OUT/%s_ARMS.out", io.HBnameF );*/ if (io.perm_type){ strcpy(io.outfile,"OUT/ARMS_DDPQ.out"); strcpy(io.PrecMeth,"ARMS_DDPQ"); } else{ strcpy(io.outfile,"OUT/ARMS.out"); strcpy(io.PrecMeth,"ARMS"); } if( NULL == ( io.fout = fopen( io.outfile, "w" ) ) ) { fprintf(flog,"Can't open output file %s...\n", io.outfile); goto ERROR_HANDLE; } /*-------------------- LOOP through matrices -*/ for( mat = 1; mat <= numat; mat++ ) { if( get_matrix_info( fmat, &io ) != 0 ) { fprintf( flog, "Invalid format in matfile_coo...\n" ); goto ERROR_HANDLE; } fprintf( flog, "MATRIX: %s...\n", io.HBnameF ); /*-------------------- Read matrix in COO format*/ csmat = (csptr)Malloc( sizeof(SparMat), "main:csmat" ); ierr = read_coo(&VAL,&COL, &ROW, &io, &rhs, &sol); n = io.ndim; nnz = io.nnz; if( ierr != 0 ) { fprintf( flog, "read_coo error = %d\n", ierr ); goto ERROR_HANDLE; } else fprintf(stdout," matrix read successfully \n"); /*-------------------- conversion from COO to CS format */ if( ( ierr = COOcs( n, nnz, VAL, COL, ROW, csmat ) ) != 0 ) { fprintf( stderr, "ARMS: COOcs error\n" ); return ierr; } /*-------------------- COO arrays no longer needed -- free */ free(ROW); ROW = NULL; free(VAL); VAL = NULL; free(COL); COL = NULL; /*---------------------------------------------------------------------- | The right-hand side is generated by assuming the solution is | a vector of ones. To be changed if rhs is available from data. |---------------------------------------------------------------------*/ x = (double *)Malloc( io.ndim * sizeof(double), "main" ); for( i = 0; i < io.ndim; i++ ) x[i] = 1.0; matvec(csmat, x, rhs) ; output_header(&io ); /*-------------------- set initial lfil and tol */ lfil = io.lfil0; tol = io.tol0; /*-------------------- LOOP THROUGH PARAMETERS */ for( iparam = 1; iparam <= io.nparam; iparam++ ) { fprintf( flog, "Parameter case = %d\n", iparam ); for (j=0; j<7; j++) { lfil_arr[j] = lfil*((int) io.nnz/n); droptol[j] = tol*dropcoef[j]; } ArmsSt = (arms) Malloc(sizeof(armsMat),"main:ArmsSt"); setup_arms(ArmsSt); fprintf( flog, "begin arms\n" ); tm1 = sys_timer(); /*-------------------- call ARMS preconditioner set-up */ ierr = arms2(csmat, ipar, droptol, lfil_arr, tolind, ArmsSt, flog); tm2 = sys_timer(); if( ierr != 0) { fprintf( io.fout, " ** ARMS2 error - code %d...\n",ierr); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } io.tm_p = tm2 - tm1; io.fillfact = (double)nnz_arms( ArmsSt, flog)/(double)(io.nnz + 1); fprintf( flog, "ARMS ends, fill factor (mem used) = %f\n", io.fillfact ); /*-------------------- get rough idea of cond number - exit if too big */ if(condestArms(ArmsSt, x, flog ) != 0 ) { fprintf( flog, "Not attempting iterative solution.\n" ); fprintf( io.fout, "Not attempting iterative solution.\n" ); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } /*-------------------- initial guess */ /* for(i=0; i < io.ndim; i++ ) x[i] = 0.0 */ randvec(x, n); /*-------------------- create a file for printing 'its -- time -- res' info from fgmres */ if(plotting ) { sprintf(pltfile, "OUT/%s_ARMS_F%05d_T%08.6f", io.HBnameF, lfil,tol); if( NULL == (fits = fopen( pltfile, "w" ) ) ) { fprintf(flog, "Can't open output file %s...\n", pltfile ); goto ERROR_HANDLE; } } else fits =NULL; /*-------------------- set up the structs before calling fgmr */ MAT->n = n; MAT->CSR = csmat; MAT->matvec = matvecCSR; PRE->ARMS = ArmsSt; PRE->precon = preconARMS; /*-------------------- call fgmr */ io.its = io.maxits; tm1 = sys_timer(); fgmr(MAT, PRE, rhs, x, io.tol, io.im, &io.its, fits); tm2 = sys_timer(); io.tm_i = tm2 - tm1; if( io.its < io.maxits ) fprintf( flog, "param %03d OK: converged in %d steps...\n", iparam, io.its ); else fprintf( flog, "not converged in %d steps...\n", io.maxits ); if( fits ) fclose( fits ); /*-------------------- calculate error norm from assumed solution of all 1's */ terr = 0.0; for( i = 0; i < io.ndim; i++ ) { terr += ( x[i] - 1.0 ) * ( x[i] - 1.0 ); } io.enorm = sqrt(terr); /*-------------------- calculate residual norm from generated rhs */ matvec(csmat, x, sol ); terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( rhs[i] - sol[i] ) * ( rhs[i] - sol[i] ); io.rnorm = sqrt(terr); /*----------------------------- go to next param case */ NEXT_PARA: output_result(lfil, &io, iparam ); lfil += io.lfilInc; tol *= io.tolMul; cleanARMS( ArmsSt); } /*-------------------- NEXT_MAT: */ cleanCS(csmat); free( sol ); free( x ); free( rhs ); } fclose( io.fout ); if( flog != stdout ) fclose ( flog ); fclose( fmat ); free(MAT); free(PRE); return 0; ERROR_HANDLE: exit( -1 ); } itsol-1.0.0/TESTS_COO/mainVBILUKcoo.c0000640000265600020320000002467511062577473016124 0ustar tilleaadmin/*---------------------------------------------------------------------------* * main test driver for VBILU * *---------------------------------------------------------------------------* * Na Li, Aug 26, 2001 -- Y.Saad 07/05 * * * * Report bugs / send comments to: saad@cs.umn.edu, nli@cs.umn.edu * *---------------------------------------------------------------------------*/ #include #include #include #include #include "../LIB/globheads.h" #include "../LIB/defs.h" #include "../LIB/protos.h" #include "../ios.h" #include /*-------------------- protos */ void output_header_vb( io_t *pio ); void output_result(int lfil, io_t *pio, int iparam ); int read_coo(double **VAL, int **COL, int **ROW, io_t *pio, double **rhs, double **sol); int read_inputs( char *in_file, io_t *pio ); int get_matrix_info(FILE *fmat, io_t *pio ); void randvec (double *v, int n); void output_blocks( int nBlock, int *nB, FILE *f ); void output_perm( int n, int *perm, FILE *f ); /*-------------------- end protos */ int main () { int ierr = 0; /*------------------------------------------------------------------- * options *-----------------------------------------------------------------*/ int plotting = 0, output_mat = 0, diagscal = 0; char pltfile[256]; FILE *fits = NULL; csptr csmat = NULL; vbsptr vbmat = NULL; vbiluptr lu = NULL; SMatptr MAT; SPreptr PRE; double *sol = NULL, *x = NULL, *rhs0 = NULL, *rhs = NULL; int lfil, nBlock, *nB = NULL, *perm = NULL; /*-------------------- temp HB arrays - fortran style */ int *ROW, *COL; double *VAL; int n, nnz; FILE *flog = stdout, *fmat = NULL; io_t io; double tm1, tm2; int mat, numat, iparam, i; double terr; char line[MAX_LINE]; MAT = (SMatptr)Malloc( sizeof(SMat), "main:MAT" ); PRE = (SPreptr)Malloc( sizeof(SPre), "main:PRE" ); /*------------------------------------------------------------------- * reads matrix from file in coordinate format * * solves using block level of fill ILU preconditioned fgmres * *-----------------------------------------------------------------*/ memset( &io, 0, sizeof(io) ); /*-----------------------------------------------------------------*/ if( read_inputs( "inputs", &io ) != 0 ) { fprintf( flog, "Invalid inputs file...\n" ); goto ERROR_HANDLE; } /* set any parameters manually */ /* io.eps is the angle tolerance for grouping two columns in same supernode. This is a cosine and should be <= 1. */ io.eps = 0.8; /*----------------------Read COO mat list-----------------------------------*/ if( NULL == ( fmat = fopen( "matfile_coo", "r" ) ) ) { fprintf( flog, "Can't open matfile_coo...\n" ); goto ERROR_HANDLE; } memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, fmat ); if( ( numat = atoi( line ) ) <= 0 ) { fprintf( flog, "Invalid count of matrices...\n" ); goto ERROR_HANDLE; } /*-------------------- open file OUT/VBILUK.out for all performance results of this run (all matrices and params) also set io->PrecMeth */ /* sprintf( io.outfile, "OUT/%s_VBILUK.out", io.HBnameF );*/ strcpy(io.outfile,"OUT/VBILUK.out"); strcpy(io.PrecMeth,"Variable Block ILUK (VBILUK)"); if( NULL == ( io.fout = fopen( io.outfile, "w" ) ) ) { fprintf(flog,"Can't open output file %s...\n", io.outfile); goto ERROR_HANDLE; } /*------------------------------------------------------------*/ /*-------------------- LOOP through MATRICES */ /*------------------------------------------------------------*/ for( mat = 1; mat <= numat; mat++ ) { if( get_matrix_info( fmat, &io ) != 0 ) { fprintf( flog, "Invalid format in matfile_coo...\n" ); goto ERROR_HANDLE; } fprintf( flog, "MATRIX: %s...\n", io.HBnameF ); /* Read in matrix and allocate memory------------------------------*/ csmat = (csptr)Malloc( sizeof(SparMat), "main" ); ierr = read_coo(&VAL,&COL, &ROW, &io, &rhs, &sol); n = io.ndim; nnz = io.nnz; if( ierr != 0 ) { fprintf( flog, "read_coo error = %d\n", ierr ); goto ERROR_HANDLE; } else fprintf(stdout," matrix read successfully \n"); /*-------------------- convert to C-style CSR matrix */ if( ( ierr = COOcs( n, nnz, VAL, COL, ROW, csmat ) ) != 0 ) { fprintf( stderr, "VBILUK: COOcs error\n" ); return ierr; } /* Free memory */ free( VAL); VAL = NULL; free( COL ); COL = NULL; free( ROW ); ROW = NULL; /*-------------------- DIAGONAL SCALING ----- */ if (diagscal ==1) { int nrm=1; double *diag; diag = (double *)Malloc( sizeof(double)*n, "mainILUC:diag" ); ierr = roscalC( csmat, diag, nrm); if( ierr != 0 ) { fprintf( stderr, "main-vbiluk: roscal: a zero row...\n" ); return ierr; } ierr = coscalC( csmat, diag, nrm ); if( ierr != 0 ) { fprintf( stderr, "main-vbiluk: roscal: a zero col...\n" ); return ierr; } free(diag); } /*---------------------------------------------------------------------- | The right-hand side is generated by assuming the solution is | a vector of ones. To be changed if rhs0 is available from data. |---------------------------------------------------------------------*/ rhs0 = (double *)Malloc( io.ndim * sizeof(double), "main" ); rhs = (double *)Malloc( io.ndim * sizeof(double), "main" ); x = (double *)Malloc( io.ndim * sizeof(double), "main" ); for( i = 0; i < io.ndim; i++ ) x[i] = 1.0; matvec( csmat, x, rhs0 ); ierr = init_blocks( csmat, &nBlock, &nB, &perm, io.eps, &io.tm_h, &io.tm_a ); io.tm_b = io.tm_h + io.tm_a; if( ierr != 0 ) { fprintf( flog, "*** in init_blocks ierr != 0 ***\n" ); goto ERROR_HANDLE; } /*-------------------- permutes the rows and columns of the matrix */ if( dpermC( csmat, perm ) != 0 ) { fprintf( flog, "*** dpermC error ***\n" ); goto ERROR_HANDLE; } /*-------------------- permutes right hand side */ for( i = 0; i < io.ndim; i++ ) rhs[perm[i]] = rhs0[i]; /*-------------------- convert to block matrix. */ vbmat = (vbsptr)Malloc( sizeof(VBSparMat), "main" ); ierr = csrvbsrC( 1, nBlock, nB, csmat, vbmat ); if( ierr != 0 ) { fprintf( flog, "*** in csrvbsr ierr != 0 ***\n" ); goto ERROR_HANDLE; } if( output_mat ) { char matdata[MAX_LINE]; FILE *fmatlab; int ii, jj; sprintf( matdata, "OUT/%s.dat", io.HBnameF ); if( NULL != ( fmatlab = fopen( matdata, "w" ) ) ) { fprintf( fmatlab, "%d %d 0\n", csmat->n, csmat->n ); for( ii = 0; ii < csmat->n; ii++ ) for( jj = 0; jj < csmat->nzcount[ii]; jj++ ) fprintf( fmatlab, "%d %d 1\n", ii+1, csmat->ja[ii][jj]+1 ); fclose( fmatlab ); } } io.rt_v = (double)csmat->n / (double)vbmat->n; io.rt_e = (double)nnzCS( csmat ) / (double)nnzVBMat( vbmat ); io.ceff = (double)nnzCS( csmat ) / (double)memVBMat( vbmat ) * 100; output_header_vb( &io ); lfil = io.fill_lev; /* make sure this is set to zero*/ io.tol0 = 0.0; /*-------------------- LOOP through parameters */ for( iparam = 1; iparam <= io.nparam; iparam++ ) { fprintf( flog, "iparam = %d\n", iparam ); lu = (vbiluptr)Malloc( sizeof(VBILUSpar), "main" ); fprintf( flog, "begin vbiluk\n" ); tm1 = sys_timer(); /*-------------------- call VBILUK preconditioner set-up */ ierr = vbilukC( lfil, vbmat, lu, flog ); tm2 = sys_timer(); if( ierr == -2 ) { fprintf( io.fout, "Singular diagonal block...\n" ); cleanVBILU( lu ); goto NEXT_MAT; } else if( ierr != 0 ) { fprintf( flog, "*** vbilu error, ierr != 0 ***\n" ); goto ERROR_HANDLE; } io.tm_p = tm2 - tm1; io.fillfact = (double)nnz_vbilu( lu )/(double)(io.nnz + 1); fprintf( flog, "vbiluk ends, fill factor (mem used) = %f\n", io.fillfact ); if( VBcondestC( lu, sol, x, flog ) != 0 ) { fprintf( flog, "Not attempting iterative solution.\n" ); fprintf( io.fout, "Not attempting iterative solution.\n" ); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } /*-------------------- initial guess */ /* for( i = 0; i < io.ndim; i++ ) x[i] = 0.0; */ randvec(x, n); /*-------------------- create a file for printing 'its -- time -- res' info from fgmres */ if (plotting ) { sprintf( pltfile, "OUT/%s_VBILUK_F%05d", io.HBnameF, lfil); if( NULL == ( fits = fopen( pltfile, "w" ) ) ) { fprintf( flog, "Can't open output file %s...\n", pltfile ); goto ERROR_HANDLE; } } else fits =NULL; /*-------------------- set up the structs before calling fgmr */ MAT->n = n; MAT->CSR = csmat; MAT->matvec = matvecCSR; PRE->VBILU = lu; PRE->precon = preconVBR; /*-------------------- call fgmr */ io.its = io.maxits; tm1 = sys_timer(); fgmr(MAT, PRE, rhs, x, io.tol, io.im, &io.its, fits); tm2 = sys_timer(); io.tm_i = tm2 - tm1; if( io.its < io.maxits ) fprintf( flog, "param %03d OK: converged in %d steps...\n\n", iparam, io.its ); else fprintf( flog, "not converged in %d steps...\n\n", io.maxits ); if( fits ) fclose( fits ); /*-------------------- calculate error and residual norms */ vbmatvec( vbmat, x, sol ); terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( rhs[i] - sol[i] ) * ( rhs[i] - sol[i] ); io.rnorm = sqrt(terr); /* get sol vector of original matrix (before permutation) */ for( i = 0; i < io.ndim; i++ ) sol[perm[i]] = x[i]; /* calculate error norm */ terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( sol[i] - 1.0 ) * ( sol[i] - 1.0 ); io.enorm = sqrt(terr); /*-------------------- next params */ NEXT_PARA: output_result( lfil, &io, iparam ); lfil += io.fill_lev_inc; cleanVBILU( lu ); } /*-------------------- next matrix */ NEXT_MAT: /* output_blocks( nBlock, nB, io.fout );*/ cleanCS( csmat ); cleanVBMat( vbmat ); free( nB ); free( perm ); free( sol ); free( x ); free( rhs0 ); free( rhs ); } fclose( io.fout ); if( flog != stdout ) fclose ( flog ); fclose( fmat ); free(MAT); free(PRE); return 0; ERROR_HANDLE: errexit( "main.c\n" ); return 1; } itsol-1.0.0/TESTS_COO/mainILUKcoo.c0000640000265600020320000001635411062577473015667 0ustar tilleaadmin#include #include #include #include #include "../LIB/globheads.h" #include "../LIB/defs.h" #include "../LIB/protos.h" #include "../ios.h" #include /*-------------------- protos */ void output_header( io_t *pio ); void output_result(int lfil, io_t *pio, int iparam ); int read_coo(double **VAL, int **COL, int **ROW, io_t *pio, double **rhs, double **sol); int read_inputs( char *in_file, io_t *pio ); int get_matrix_info(FILE *fmat, io_t *pio ); void randvec (double *v, int n); /*-------------------- end protos */ int main(){ int ierr = 0; /*------------------------------------------------------------------- * options *-----------------------------------------------------------------*/ int plotting = 0, skip_its = 0; char pltfile[256]; FILE *fits = NULL; csptr csmat = NULL; SMatptr MAT; SPreptr PRE; double *VAL; int *ROW, *COL; iluptr lu = NULL; double *sol = NULL, *x = NULL, *rhs = NULL; int n, lfil, nnz; FILE *flog = stdout, *fmat = NULL; io_t io; double tm1, tm2; int mat, numat, iparam, i; double terr; char line[MAX_LINE]; MAT = (SMatptr)Malloc( sizeof(SMat), "main:MAT" ); PRE = (SPreptr)Malloc( sizeof(SPre), "main:PRE" ); /*------------------------------------------------------------------- * reads matrix from file in Coordinate format * * solves using block level of fill ILU preconditioned fgmres * *-----------------------------------------------------------------*/ memset( &io, 0, sizeof(io) ); /*-----------------------------------------------------------------*/ if( read_inputs( "inputs", &io ) != 0 ) { fprintf( flog, "Invalid inputs file...\n" ); goto ERROR_HANDLE; } /*----------------------Read COO mat list-----------------------------------*/ if( NULL == ( fmat = fopen( "matfile_coo", "r" ) ) ) { fprintf( flog, "Can't open matfile_coo...\n" ); goto ERROR_HANDLE; } memset( line, 0, MAX_LINE ); fgets( line, MAX_LINE, fmat ); if( ( numat = atoi( line ) ) <= 0 ) { fprintf( flog, "Invalid count of matrices...\n" ); goto ERROR_HANDLE; } /*-------------------- open file OUT/ILUK.out for all performance results of this run (all matrices and params) also set io->PrecMeth */ /* sprintf( io.outfile, "OUT/%s_ILUK.out", io.HBnameF );*/ strcpy(io.outfile,"OUT/ILUK.out"); strcpy(io.PrecMeth,"ILUK"); if( NULL == ( io.fout = fopen( io.outfile, "w" ) ) ) { fprintf(flog,"Can't open output file %s...\n", io.outfile); goto ERROR_HANDLE; } /* LOOP THROUGH MATRICES ------------------------------------------*/ for( mat = 1; mat <= numat; mat++ ) { if( get_matrix_info( fmat, &io ) != 0 ) { fprintf( flog, "Invalid format in matfile_coo...\n" ); goto ERROR_HANDLE; } fprintf( flog, "MATRIX: %s...\n", io.HBnameF ); /*-------------------- Read in matrix and allocate memory-------*/ csmat = (csptr)Malloc( sizeof(SparMat), "main" ); ierr = read_coo(&VAL,&COL, &ROW, &io, &rhs, &sol); n = io.ndim; nnz = io.nnz; if( ierr != 0 ) { fprintf( flog, "read_coo error = %d\n", ierr ); goto ERROR_HANDLE; } else fprintf(stdout," matrix read successfully \n"); /*-------------------- conversion from COO to CS format */ if( ( ierr = COOcs( n, nnz, VAL, COL, ROW, csmat ) ) != 0 ) { fprintf( stderr, "ILUK: COOcs error\n" ); return ierr; } /*-------------------- COO arrays no longer needed -- free */ free(ROW); ROW = NULL; free(VAL); VAL = NULL; free(COL); COL = NULL; /*---------------------------------------------------------------------- | The right-hand side is generated by assuming the solution is | a vector of ones. To be changed if rhs0 is available from data. |---------------------------------------------------------------------*/ x = (double *)Malloc( io.ndim * sizeof(double), "main" ); for( i = 0; i < io.ndim; i++ ) x[i] = 1.0; matvec(csmat, x, rhs ); output_header( &io ); lfil = io.fill_lev; /* make sure this is set to zero*/ io.tol0 = 0.0; /* LOOP THROUGH PARAMETERS ---------------------------------------*/ for( iparam = 1; iparam <= io.nparam; iparam++ ) { fprintf( flog, "iparam = %d\n", iparam ); lu = (iluptr)Malloc( sizeof(ILUSpar), "main" ); fprintf( flog, "begin iluk\n" ); tm1 = sys_timer(); /*-------------------- call ILUK preconditioner set-up */ ierr = ilukC(lfil, csmat, lu, flog ); tm2 = sys_timer(); if( ierr == -2 ) { fprintf( io.fout, "zero diagonal element found...\n" ); cleanILU( lu ); goto NEXT_MAT; } else if( ierr != 0 ) { fprintf( flog, "*** iluk error, ierr != 0 ***\n" ); goto ERROR_HANDLE; } io.tm_p = tm2 - tm1; io.fillfact = (double)nnz_ilu( lu )/(double)(io.nnz + 1); fprintf( flog, "iluk ends, fill factor (mem used) = %f\n", io.fillfact ); if( skip_its ) { io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } // check condition number estimation if( condestLU( lu, sol, x, flog ) != 0 ) { fprintf( flog, "Not attempting iterative solution.\n" ); fprintf( io.fout, "Not attempting iterative solution.\n" ); io.its = -1; io.tm_i = -1; io.enorm = -1; io.rnorm = -1; goto NEXT_PARA; } /* initial guess */ /* for( i = 0; i < io.ndim; i++ ) { sol[i] = 0.0; } */ randvec (sol,n); /* initial guess */ /*-------------------- create a file for printing 'its -- time -- res' info from fgmres */ if (plotting ) { sprintf( pltfile, "OUT/%s_ILUK_F%05d", io.HBnameF, lfil); if( NULL == ( fits = fopen( pltfile, "w" ) ) ) { fprintf( flog, "Can't open output file %s...\n", pltfile ); goto ERROR_HANDLE; } } else fits =NULL; io.its = io.maxits; tm1 = sys_timer(); /*-------------------- set up the structs before calling fgmr */ MAT->n = n; MAT->CSR = csmat; MAT->matvec = matvecCSR; PRE->ILU = lu; PRE->precon = preconILU; /*-------------------- call fgmr */ fgmr(MAT, PRE, rhs, sol, io.tol, io.im, &io.its, fits); tm2 = sys_timer(); io.tm_i = tm2 - tm1; if( io.its < io.maxits ) fprintf( flog, "param %03d OK: converged in %d steps...\n\n", iparam, io.its ); else fprintf( flog, "not converged in %d steps...\n\n", io.maxits ); if( fits ) fclose( fits ); /*-------------------- calculate error and residual norms */ terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( sol[i] - 1.0 ) * ( sol[i] - 1.0 ); io.enorm = sqrt(terr); matvec( csmat, sol, x ); terr = 0.0; for( i = 0; i < io.ndim; i++ ) terr += ( rhs[i] - x[i] ) * ( rhs[i] - x[i] ); io.rnorm = sqrt(terr); /*-------------------- Test with next params */ NEXT_PARA: output_result( lfil, &io, iparam ); lfil += io.fill_lev_inc; cleanILU( lu ); } /*-------------------- Test with next matrix */ NEXT_MAT: cleanCS( csmat ); free( sol ); free( x ); free( rhs ); } fclose( io.fout ); if( flog != stdout ) fclose ( flog ); fclose( fmat ); free(MAT) ; free (PRE); return 0; ERROR_HANDLE: errexit( "main.c\n" ); return(1) ; } itsol-1.0.0/TESTS_COO/runall0000750000265600020320000000020411062577473014616 0ustar tilleaadmin#/bin/sh ## (cd ..; make lib) make all ./arms.ex ./ilut.ex ###./iluc.ex ./iluk.ex ./vbiluk.ex ./vbilut.ex echo 'DONE -) ' itsol-1.0.0/TESTS_COO/inputs0000640000265600020320000000342011062577473014644 0ustar tilleaadmin2 1. nparam = number of tests for the preconditioner (see below) 60 2. dim = dimension of Krylov subspace in (outer) FGMRES 300 3. maxits = maxits in outer fgmres. 1.0e-8 4. tol = tolerance for stopping iteration 30 5. lfil0 = initial lfil 5 6. lfilInc = increment for lfil 0.1 7. tol0 = initial tol 0.1 8. tolMul = multiple increment for tol0 2 9. USED BY ILUK ONLY: fill_lev = fill level 0 10. ARMS ONLY: PQ perms or Ind. Sets. 400 11. ARMS ONLY: Block-size for independent sets/ last block ### end INPUT PARAMETERS in file "inputs": ---------------------------------- nparam : number of tests dim : dimension of Krylov subspace in (outer) FGMRES maxits : Maximum number of outer iterations tol : tolerance for stopping iteration eps : not available in Hash-based algorithm. <= 1. indicating how close are two rows or columns which can be grouped in the same block. lfil0 : initial fill-in parameter lfilInc : increment for the fill-in parameter after each test **** next two are for VBILUT only -- tol0 : the initial threshold for dropping small terms in the actorization tolMul : multiple for the threshold after each test **** next two are for ILUK only -- fill_lev : Level of fill for ILUK preconditioner **** next are for ARMS only perm_type: PQ or Indset ordering Bsize : block size - This has a dual role. It is the block size for indset permutations. It is also the last block size for PQ orderings [i.e, algorithm stops when schur complement reaches a size <= Bsize] itsol-1.0.0/TESTS_COO/matfile_coo0000750000265600020320000000064211062577473015610 0ustar tilleaadmin2 'MATRICES/PORES3.COO' 'PORES3' 'MATRICES/SHERMAN5.COO' 'SHERMAN5' first line is the number of matrices to be tested [called numat in drivers] The second line gives the full path name of the file and the name of the file. This may be something like '/project/scicom00/DATA/MATRICES/MATRICES/SIMON/RAEFSKY6' 'RAEFSKY6' the name is printed in the output table Repeat for as many matrices as indicated by numat itsol-1.0.0/TESTS_COO/MATRICES/0000750000265600020320000000000011062574347014603 5ustar tilleaadminitsol-1.0.0/TESTS_COO/MATRICES/SHERMAN5.COO0000640000265600020320000231757411062577474016357 0ustar tilleaadmin 3312 3312 20793 0 0 1.000000 1 1 1.000000 2 2 1.000000 3 3 1.000000 4 4 1.000000 5 5 1.000000 6 6 1.000000 7 7 1.000000 8 8 1.000000 9 9 1.000000 10 10 1.000000 11 11 1.000000 12 12 1.000000 13 13 1.000000 14 14 1.000000 15 15 1.000000 16 16 1.000000 17 17 1.000000 18 18 1.000000 19 19 1.000000 20 20 1.000000 21 21 1.000000 22 22 1.000000 23 23 1.000000 24 24 1.000000 25 25 1.000000 26 26 1.000000 27 27 1.000000 28 28 1.000000 29 29 1.000000 30 30 1.000000 31 31 1.000000 32 32 1.000000 33 33 1.000000 34 34 1.000000 35 35 1.000000 36 36 1.000000 37 37 1.000000 38 38 1.000000 39 39 1.000000 40 40 1.000000 41 41 1.000000 42 42 1.000000 43 43 1.000000 44 44 1.000000 45 45 1.000000 46 46 1.000000 47 47 1.000000 48 48 1.000000 49 49 1.000000 50 50 1.000000 51 51 1.000000 52 52 1.000000 53 53 1.000000 54 54 1.000000 55 55 1.000000 56 56 1.000000 57 57 1.000000 58 58 1.000000 59 59 1.000000 60 60 1.000000 61 61 1.000000 62 62 1.000000 63 63 1.000000 64 64 1.000000 65 65 1.000000 66 66 1.000000 67 67 1.000000 68 68 1.000000 69 69 1.000000 70 70 1.000000 71 71 1.000000 72 72 1.000000 73 73 1.000000 74 74 1.000000 75 75 1.000000 76 76 1.000000 77 77 1.000000 78 78 1.000000 79 79 1.000000 80 80 1.000000 81 81 1.000000 82 82 1.000000 83 83 1.000000 84 84 1.000000 85 85 1.000000 86 86 1.000000 87 87 1.000000 88 88 1.000000 89 89 1.000000 90 90 1.000000 91 91 1.000000 92 92 1.000000 93 93 1.000000 94 94 1.000000 95 95 1.000000 96 96 1.000000 97 97 1.000000 98 98 1.000000 99 99 1.000000 100 100 1.000000 101 101 1.000000 102 102 1.000000 103 103 1.000000 104 104 1.000000 105 105 1.000000 106 106 1.000000 107 107 1.000000 108 108 1.000000 109 109 1.000000 110 110 1.000000 111 111 582.315010 111 112 -356.631800 111 113 -602.850390 111 114 -1.699825 111 115 1.421529 111 116 2.402950 111 159 -9.503341 112 112 -88.662401 112 113 75.193603 112 116 -0.239244 113 111 0.524924 113 112 4.332326 113 113 7.323361 113 114 -0.275505 113 115 -1.909477 113 116 -3.227777 113 159 -0.168072 113 160 -2.413004 113 161 -4.078942 114 111 -2.020336 114 114 583.726240 114 115 -357.315190 114 116 -604.005140 114 162 -9.352778 115 115 -82.875303 115 116 70.151506 116 111 -0.275505 116 112 -1.909477 116 113 -3.227777 116 114 0.631241 116 115 3.818367 116 116 6.454563 116 162 -0.274064 116 163 -1.899689 116 164 -3.211232 117 117 1.000000 118 118 1.000000 119 119 1.000000 120 120 1.000000 121 121 1.000000 122 122 1.000000 123 123 538.324420 123 124 -330.894890 123 125 -559.344730 123 126 -1.398013 123 127 1.385140 123 128 2.341438 123 171 -10.275334 124 124 -74.442006 124 125 63.483385 124 128 -0.260478 125 123 0.537820 125 124 3.790360 125 125 6.407222 125 126 -0.155175 125 127 -2.125118 125 128 -3.592297 125 171 -0.301098 125 172 -1.656978 125 173 -2.800956 126 123 -0.637335 126 126 501.981760 126 127 -312.884400 126 128 -528.899400 126 129 -1.410730 126 130 4.368932 126 131 7.385242 126 174 -5.272018 127 127 -75.938657 127 128 65.540651 127 131 -0.932014 128 123 -0.155175 128 124 -2.125118 128 125 -3.592297 128 126 0.476894 128 127 6.617771 128 128 11.186675 128 129 -0.086217 128 130 -2.368262 128 131 -4.003311 128 174 -0.154486 128 175 -2.115960 128 176 -3.576816 129 126 -0.632247 129 129 465.862280 129 130 -294.078520 129 131 -497.110330 129 132 -1.401070 129 133 8.390147 129 134 14.182692 129 177 -4.796889 130 130 -74.441522 130 131 65.294128 130 134 -1.869240 131 126 -0.086217 131 127 -2.368262 131 128 -4.003311 131 129 0.293833 131 130 7.232501 131 131 12.225815 131 132 -0.042128 131 133 -2.525359 131 134 -4.268863 131 177 -0.084836 131 178 -2.330615 131 179 -3.939671 132 129 -0.380131 132 132 420.147670 132 133 -273.866150 132 134 -462.942920 132 135 -1.120559 132 136 7.390262 132 137 12.492498 132 180 -2.343169 132 1236 -2.599414 132 1237 10.350072 132 1238 17.495750 133 133 -70.163194 133 134 63.568717 133 137 -1.677661 133 1238 -1.841669 134 129 -0.042128 134 130 -2.525359 134 131 -4.268863 134 132 0.286647 134 133 8.404594 134 134 14.207117 134 135 -0.028088 134 136 -2.477089 134 137 -4.187271 134 180 -0.041440 134 181 -2.484443 134 182 -4.199699 134 1236 -0.094695 134 1237 -0.909913 134 1238 -1.538115 135 132 -0.450436 135 135 396.056260 135 136 -259.653660 135 137 -438.918540 135 138 -0.810894 135 139 5.690333 135 140 9.618929 135 183 -1.580018 135 1239 -2.030441 135 1240 11.063571 135 1241 18.701860 136 136 -67.508510 136 137 61.392103 136 140 -1.356962 136 1241 -2.218537 137 132 -0.028088 137 133 -2.477089 137 134 -4.187271 137 135 0.212898 137 136 8.612924 137 137 14.559283 137 138 -0.019132 137 139 -2.453026 137 140 -4.146592 137 183 -0.027944 137 184 -2.464650 137 185 -4.166244 137 1239 -0.057589 137 1240 -1.210663 137 1241 -2.046506 138 135 -0.432568 138 138 371.806670 138 139 -242.255770 138 140 -409.508770 138 141 -0.583798 138 142 3.444575 138 143 5.822710 138 186 -1.797449 138 1242 -1.579838 138 1243 10.271379 138 1244 17.362727 139 139 -64.514006 139 140 58.423373 139 143 -0.831536 139 1244 -2.245782 140 135 -0.019132 140 136 -2.453026 140 137 -4.146592 140 138 0.167902 140 139 8.765548 140 140 14.817273 140 141 -0.012197 140 142 -2.425760 140 143 -4.100505 140 186 -0.018759 140 187 -2.405538 140 188 -4.066317 140 1242 -0.037800 140 1243 -1.474060 140 1244 -2.491750 141 138 -0.275762 141 141 347.699300 141 142 -225.070850 141 143 -380.459760 141 189 -1.144882 141 1245 -1.244929 141 1246 9.960731 141 1247 16.837620 142 142 -61.460330 142 143 55.129317 142 1247 -2.290819 143 138 -0.012197 143 139 -2.425760 143 140 -4.100505 143 141 0.127852 143 142 6.564631 143 143 11.096852 143 189 -0.011949 143 190 -2.376726 143 191 -4.017618 143 1245 -0.023820 143 1246 -1.755319 143 1247 -2.967192 144 144 1.000000 145 145 1.000000 146 146 1.000000 147 147 1.000000 148 148 1.000000 149 149 1.000000 150 150 1.000000 151 151 1.000000 152 152 1.000000 153 153 1.000000 154 154 1.000000 155 155 1.000000 156 156 1.000000 157 157 1.000000 158 158 1.000000 159 111 -5.625223 159 112 26.312807 159 113 44.479169 159 159 587.156400 159 160 -364.039640 159 161 -615.372610 159 162 -0.383105 159 207 -1.071063 159 1263 -0.943418 159 1264 7.787189 159 1265 13.163464 160 113 -5.018385 160 160 -104.203570 160 161 90.595331 160 1265 -1.764236 161 111 -0.168072 161 112 -2.413004 161 113 -4.078942 161 159 0.207687 161 160 11.702675 161 161 19.782202 161 162 -0.011226 161 163 -4.128844 161 164 -6.979397 161 207 -0.011178 161 208 -4.111735 161 209 -6.950478 161 1263 -0.015589 161 1264 -1.037506 161 1265 -1.753800 162 114 -7.351602 162 115 25.567757 162 116 43.219704 162 159 -0.662631 162 160 1.011229 162 161 1.709382 162 162 588.775170 162 163 -362.752100 162 164 -613.195720 162 165 -0.692613 162 210 -2.181488 162 1266 -1.367922 162 1267 7.241435 162 1268 12.240915 163 116 -4.303068 163 161 -0.248088 163 163 -101.865610 163 164 88.189741 163 1268 -1.474653 164 114 -0.274064 164 115 -1.899689 164 116 -3.211232 164 159 -0.011226 164 160 -4.128844 164 161 -6.979397 164 162 0.375837 164 163 14.544988 164 164 24.586836 164 165 -0.028606 164 166 -3.844660 164 167 -6.499008 164 210 -0.022767 164 211 -3.823585 164 212 -6.463384 164 1266 -0.037421 164 1267 -0.836888 164 1268 -1.414675 165 162 -0.976213 165 163 0.720350 165 164 1.217678 165 165 579.642800 165 166 -360.805590 165 167 -609.905760 165 168 -0.749369 165 169 1.651997 165 170 2.792533 165 213 -2.727542 165 1269 -1.530755 165 1270 7.358764 165 1271 12.439255 166 164 -0.170634 166 166 -92.549851 166 167 101.138490 166 170 -0.394662 166 1271 -1.468541 167 162 -0.028606 167 163 -3.844660 167 164 -6.499008 167 165 0.212361 167 166 12.072043 167 167 20.406572 167 168 -0.028598 167 169 -3.728159 167 170 -6.302076 167 213 -0.028466 167 214 -3.710244 167 215 -6.271797 167 1269 -0.046029 167 1270 -0.777765 167 1271 -1.314734 168 165 -0.646595 168 168 579.607820 168 169 -363.238520 168 170 -614.017980 168 171 -0.920277 168 172 4.980819 168 173 8.419576 168 216 -2.727779 168 1272 -1.517127 168 1273 7.278280 168 1274 12.303195 169 169 -100.896640 169 170 87.613858 169 173 -1.181672 169 1274 -1.452577 170 165 -0.028598 170 166 -3.728159 170 167 -6.302076 170 168 0.206123 170 169 12.039996 170 170 20.352399 170 171 -0.022406 170 172 -3.811667 170 173 -6.443242 170 216 -0.028468 170 217 -3.711677 170 218 -6.274214 170 1272 -0.045989 170 1273 -0.777278 170 1274 -1.313910 171 123 -8.979267 171 124 26.986678 171 125 45.618281 171 168 -0.506603 171 171 578.414980 171 172 -362.918670 171 173 -613.477720 171 174 -0.883766 171 175 6.499227 171 176 10.986285 171 219 -2.138599 171 1275 -1.322505 171 1276 7.017312 171 1277 11.862064 172 125 -4.533438 172 172 -99.874183 172 173 88.241532 172 176 -1.577905 172 1277 -1.457503 173 123 -0.301098 173 124 -1.656978 173 125 -2.800956 173 168 -0.022406 173 169 -3.811667 173 170 -6.443242 173 171 0.401055 173 172 13.885676 173 173 23.472342 173 174 -0.017768 173 175 -3.739562 173 176 -6.321352 173 219 -0.022319 173 220 -3.797303 173 221 -6.418961 173 1275 -0.035749 173 1276 -0.869064 173 1277 -1.469066 174 126 -5.728719 174 127 27.415937 174 128 46.343867 174 171 -0.606339 174 174 538.190490 174 175 -345.019640 174 176 -583.220820 174 177 -0.802106 174 178 7.400167 174 179 12.509242 174 222 -1.677874 174 1278 -1.199037 174 1279 7.544192 174 1280 12.752693 175 128 -5.155625 175 175 -94.437882 175 176 84.628322 175 179 -1.798823 175 1280 -1.645748 176 126 -0.154486 176 127 -2.115960 176 128 -3.576816 176 171 -0.017768 176 172 -3.739562 176 173 -6.321352 176 174 0.228605 176 175 14.167430 176 176 23.948610 176 177 -0.010733 176 178 -3.593010 176 179 -6.073624 176 222 -0.017511 176 223 -3.686029 176 224 -6.230859 176 1278 -0.026535 176 1279 -1.022372 176 1280 -1.728216 177 129 -4.331139 177 130 25.448551 177 131 43.018230 177 174 -0.366293 177 177 491.205390 177 178 -319.535410 177 179 -540.142660 177 180 -0.608820 177 181 8.039746 177 182 13.590380 177 225 -1.013116 177 1281 -0.944299 177 1282 7.000426 177 1283 11.833520 178 131 -5.428882 178 178 -87.270037 178 179 79.198658 178 182 -2.017901 178 1283 -1.596528 179 129 -0.084836 179 130 -2.330615 179 131 -3.939671 179 174 -0.010733 179 175 -3.593010 179 176 -6.073624 179 177 0.132486 179 178 14.135047 179 179 23.893881 179 180 -0.007063 179 181 -3.416753 179 182 -5.775677 179 225 -0.010573 179 226 -3.539884 179 227 -5.983820 179 1281 -0.017904 179 1282 -1.245084 179 1283 -2.104691 180 132 -3.013261 180 133 27.643276 180 134 46.728152 180 177 -0.399343 180 180 453.087360 180 181 -298.422780 180 182 -504.453590 180 183 -0.380855 180 184 7.686549 180 185 12.993343 180 228 -0.666030 180 1284 -0.491136 180 1285 4.357175 180 1286 7.365364 181 134 -6.158643 181 181 -81.860502 181 182 74.924081 181 185 -2.007533 181 1286 -1.034987 182 132 -0.041440 182 133 -2.484443 182 134 -4.199699 182 177 -0.007063 182 178 -3.416753 182 179 -5.775677 182 180 0.068672 182 181 14.079488 182 182 23.799955 182 183 -0.003175 182 184 -3.291580 182 185 -5.564087 182 228 -0.006951 182 229 -3.363208 182 230 -5.685164 182 1284 -0.008811 182 1285 -1.514404 182 1286 -2.559947 183 135 -2.423607 183 136 27.643725 183 137 46.728953 183 180 -0.179528 183 183 417.040120 183 184 -275.544570 183 185 -465.780540 183 186 -0.282214 183 187 7.257302 183 188 12.267737 183 231 -0.299310 183 1287 -0.351352 183 1288 3.147673 183 1289 5.320826 184 137 -6.275392 184 184 -76.543503 184 185 70.327031 184 188 -1.859816 184 1289 -0.772960 185 135 -0.027944 185 136 -2.464650 185 137 -4.166244 185 180 -0.003175 185 181 -3.291580 185 182 -5.564087 185 183 0.042225 185 184 13.835576 185 185 23.387654 185 186 -0.002166 185 187 -3.073406 185 188 -5.195282 185 231 -0.003124 185 232 -3.238818 185 233 -5.474898 185 1287 -0.004734 185 1288 -1.758612 185 1289 -2.972758 186 138 -2.075542 186 139 25.159407 186 140 42.529422 186 183 -0.122471 186 186 382.328450 186 187 -252.490980 186 188 -426.810540 186 189 -0.225522 186 190 5.081460 186 191 8.589700 186 234 -0.203938 186 1290 -0.282224 186 1291 2.700400 186 1292 4.564753 187 140 -5.999714 187 187 -70.502971 187 188 64.538446 187 191 -1.311001 187 1292 -0.681726 188 138 -0.018759 188 139 -2.405538 188 140 -4.066317 188 183 -0.002166 188 184 -3.073406 188 185 -5.195282 188 186 0.029595 188 187 13.352024 188 188 22.570249 188 189 -0.001815 188 190 -2.872657 188 191 -4.855939 188 234 -0.002128 188 235 -3.020461 188 236 -5.105784 188 1290 -0.003753 188 1291 -1.972124 188 1292 -3.333675 189 141 -1.502558 189 142 23.436855 189 143 39.617660 189 186 -0.173899 189 189 358.278520 189 190 -232.379710 189 191 -392.814660 189 237 -0.173077 189 1293 -0.246779 189 1294 2.622451 189 1295 4.432992 190 143 -5.657766 190 190 -66.372454 190 191 59.555841 190 1295 -0.672051 191 141 -0.011949 191 142 -2.376726 191 143 -4.017618 191 186 -0.001815 191 187 -2.872657 191 188 -4.855939 191 189 0.019645 191 190 10.250425 191 191 17.327318 191 237 -0.001806 191 238 -2.859445 191 239 -4.833606 191 1293 -0.003169 191 1294 -2.134217 191 1295 -3.607681 192 192 1.000000 193 193 1.000000 194 194 1.000000 195 195 1.000000 196 196 1.000000 197 197 1.000000 198 198 1.000000 199 199 1.000000 200 200 1.000000 201 201 1.000000 202 202 1.000000 203 203 1.000000 204 204 1.000000 205 205 1.000000 206 206 1.000000 207 159 -1.491788 207 160 32.774276 207 161 55.401636 207 207 576.640830 207 208 -369.516890 207 209 -624.631340 207 210 -0.234093 207 255 -0.233263 207 1311 -0.229676 207 1312 3.269776 207 1313 5.527229 208 161 -8.040622 208 208 -107.390810 208 209 94.914364 208 1313 -0.823536 209 159 -0.011178 209 160 -4.111735 209 161 -6.950478 209 207 0.020060 209 208 14.473053 209 209 24.465248 209 210 -0.002443 209 211 -4.532473 209 212 -7.661692 209 255 -0.002434 209 256 -4.516995 209 257 -7.635529 209 1311 -0.002559 209 1312 -1.299896 209 1313 -2.197344 210 162 -2.157987 210 163 31.763844 210 164 53.693564 210 207 -0.246733 210 208 1.259814 210 209 2.129590 210 210 578.106290 210 211 -368.961330 210 212 -623.691830 210 213 -0.257621 210 258 -0.256800 210 1314 -0.246681 210 1315 3.196033 210 1316 5.402570 211 164 -7.524094 211 209 -0.327836 211 211 -107.204770 211 212 94.574832 211 1316 -0.797235 212 162 -0.022767 212 163 -3.823585 212 164 -6.463384 212 207 -0.002443 212 208 -4.532473 212 209 -7.661692 212 210 0.034919 212 211 18.657388 212 212 31.538432 212 213 -0.002689 212 214 -4.508297 212 215 -7.620820 212 258 -0.002680 212 259 -4.494527 212 260 -7.597543 212 1314 -0.002884 212 1315 -1.286574 212 1316 -2.174823 213 165 -2.632690 213 166 30.535283 213 167 51.616842 213 210 -0.265122 213 211 0.742490 213 212 1.255104 213 213 578.926990 213 214 -368.930260 213 215 -623.639720 213 216 -0.337672 213 217 0.981476 213 218 1.659086 213 261 -0.303425 213 1317 -0.284439 213 1318 3.266429 213 1319 5.521572 214 167 -7.294636 214 212 -0.192187 214 214 -98.002191 214 215 109.111050 214 218 -0.250001 214 1319 -0.799477 215 165 -0.028466 215 166 -3.710244 215 167 -6.271797 215 210 -0.002689 215 211 -4.508297 215 212 -7.620820 215 213 0.042733 215 214 18.375718 215 215 31.062304 215 216 -0.003420 215 217 -4.436648 215 218 -7.499705 215 261 -0.003167 215 262 -4.447221 215 263 -7.517583 215 1317 -0.003515 215 1318 -1.261418 215 1319 -2.132301 216 168 -2.681311 216 169 31.315243 216 170 52.935250 216 213 -0.327694 216 216 579.080540 216 217 -371.282340 216 218 -627.615270 216 219 -0.360129 216 220 3.210720 216 221 5.427401 216 264 -0.326674 216 1320 -0.264566 216 1321 3.087606 216 1322 5.219286 217 170 -7.481215 217 217 -106.649090 217 218 94.589072 217 221 -0.817855 217 1322 -0.776395 218 168 -0.028468 218 169 -3.711677 218 170 -6.274214 218 213 -0.003420 218 214 -4.436648 218 215 -7.499705 218 216 0.044058 218 217 18.269537 218 218 30.882809 218 219 -0.003419 218 220 -4.436568 218 221 -7.499575 218 264 -0.003409 218 265 -4.423341 218 266 -7.477211 218 1320 -0.003855 218 1321 -1.249434 218 1322 -2.112042 219 171 -2.254950 219 172 34.272320 219 173 57.933929 219 216 -0.327557 219 219 578.472800 219 220 -375.136440 219 221 -634.130630 219 222 -0.317936 219 223 4.768057 219 224 8.059917 219 267 -0.326652 219 1323 -0.253489 219 1324 2.848195 219 1325 4.814589 220 173 -8.130919 220 220 -106.648860 220 221 95.574845 220 224 -1.229284 220 1325 -0.716338 221 171 -0.022319 221 172 -3.797303 221 173 -6.418961 221 216 -0.003419 221 217 -4.436568 221 218 -7.499575 221 219 0.037288 221 220 18.317866 221 221 30.964516 221 222 -0.002811 221 223 -4.398270 221 224 -7.434830 221 267 -0.003409 221 268 -4.424803 221 269 -7.479687 221 1323 -0.003843 221 1324 -1.249054 221 1325 -2.111401 222 174 -2.102805 222 175 34.671114 222 176 58.608013 222 219 -0.269392 222 222 554.749030 222 223 -363.906820 222 224 -615.147650 222 225 -0.248259 222 226 6.483881 222 227 10.960352 222 270 -0.268693 222 1326 -0.245458 222 1327 2.655669 222 1328 4.489140 223 176 -8.417571 223 223 -102.780840 223 224 93.163769 223 227 -1.701721 223 1328 -0.660239 224 174 -0.017511 224 175 -3.686029 224 176 -6.230859 224 219 -0.002811 224 220 -4.398270 224 221 -7.434830 224 222 0.029553 224 223 18.064403 224 224 30.536050 224 225 -0.001902 224 226 -4.246385 224 227 -7.178089 224 270 -0.002804 224 271 -4.387421 224 272 -7.416492 224 1326 -0.003119 224 1327 -1.334860 224 1328 -2.256445 225 177 -1.506565 225 178 34.709746 225 179 58.673355 225 222 -0.182276 225 225 519.204870 225 226 -344.192000 225 227 -581.822160 225 228 -0.198586 225 229 7.888630 225 230 13.334930 225 273 -0.179974 225 1329 -0.169640 225 1330 2.296972 225 1331 3.882801 226 179 -8.437202 226 226 -96.916962 226 227 88.768635 226 230 -2.097495 226 1331 -0.592136 227 177 -0.010573 227 178 -3.539884 227 179 -5.983820 227 222 -0.001902 227 223 -4.246385 227 224 -7.178089 227 225 0.018823 227 226 17.439049 227 227 29.478962 227 228 -0.001234 227 229 -3.973355 227 230 -6.716554 227 273 -0.001878 227 274 -4.193291 227 275 -7.088339 227 1329 -0.001949 227 1330 -1.475347 227 1331 -2.493926 228 180 -1.250029 228 181 32.776872 228 182 55.405994 228 225 -0.118274 228 228 472.529580 228 229 -316.510790 228 230 -535.029440 228 231 -0.116440 228 232 8.666418 228 233 14.649713 228 276 -0.116666 228 1332 -0.136430 228 1333 1.852238 228 1334 3.131021 229 182 -8.226689 229 229 -88.678619 229 230 82.092491 229 233 -2.356370 229 1334 -0.473197 230 180 -0.006951 230 181 -3.363208 230 182 -5.685164 230 225 -0.001234 230 226 -3.973355 230 227 -6.716554 230 228 0.012075 230 229 16.662947 230 230 28.167030 230 231 -0.000294 230 232 -3.735226 230 233 -6.314026 230 276 -0.001218 230 277 -3.919831 230 278 -6.626076 230 1332 -0.001227 230 1333 -1.661456 230 1334 -2.808524 231 183 -0.962820 231 184 30.072650 231 185 50.834807 231 228 -0.028192 231 231 437.380550 231 232 -294.062540 231 233 -497.083310 231 234 -0.110235 231 235 9.098386 231 236 15.379904 231 279 -0.027787 231 1335 -0.094692 231 1336 1.413489 231 1337 2.389362 232 185 -7.854217 232 232 -82.802041 232 233 77.003990 232 236 -2.491765 232 1337 -0.370686 233 183 -0.003124 233 184 -3.238818 233 185 -5.474898 233 228 -0.000294 233 229 -3.735226 233 230 -6.314026 233 231 0.005596 233 232 15.978837 233 233 27.010623 233 234 -0.000017 233 235 -3.476036 233 236 -5.875887 233 279 -0.000290 233 280 -3.681971 233 281 -6.224003 233 1335 -0.000838 233 1336 -1.837569 233 1337 -3.106227 234 186 -0.466885 234 187 27.264523 234 188 46.087927 234 231 -0.001622 234 234 402.695510 234 235 -269.895040 234 236 -456.230340 234 237 -0.141628 234 238 8.707568 234 239 14.719273 234 282 -0.001597 234 1338 -0.059816 234 1339 1.184940 234 1340 2.003021 235 188 -6.987032 235 235 -76.449015 235 236 70.887220 235 239 -2.384761 235 1340 -0.315517 236 186 -0.002128 236 187 -3.020461 236 188 -5.105784 236 231 -0.000017 236 232 -3.476036 236 233 -5.875887 236 234 0.003717 236 235 15.194425 236 236 25.684645 236 237 -0.000015 236 238 -3.240484 236 239 -5.477714 236 282 -0.000017 236 283 -3.422994 236 284 -5.786226 236 1338 -0.000599 236 1339 -2.025941 236 1340 -3.424648 237 189 -0.340413 237 190 22.538935 237 191 38.099815 237 234 -0.001474 237 237 379.567110 237 238 -243.324810 237 239 -411.316260 237 285 -0.001449 237 1341 -0.001005 237 1342 1.053015 237 1343 1.780016 238 191 -5.814974 238 238 -72.082031 238 239 63.780781 238 1343 -0.285622 239 189 -0.001806 239 190 -2.859445 239 191 -4.833606 239 234 -0.000015 239 235 -3.240484 239 236 -5.477714 239 237 0.002734 239 238 11.483163 239 239 19.411139 239 285 -0.000015 239 286 -3.186243 239 287 -5.386026 239 1341 -0.000010 239 1342 -2.188966 239 1343 -3.700229 240 240 1.000000 241 241 1.000000 242 242 1.000000 243 243 1.000000 244 244 1.000000 245 245 1.000000 246 246 1.000000 247 247 1.000000 248 248 1.000000 249 249 1.000000 250 250 1.000000 251 251 1.000000 252 252 1.000000 253 253 1.000000 254 254 1.000000 255 207 -0.502753 255 208 38.055507 255 209 64.329029 255 255 575.079160 255 256 -373.053960 255 257 -630.610410 255 258 -0.002390 255 303 -0.002385 255 1359 -0.000730 255 1360 1.678820 255 1361 2.837878 256 209 -9.903012 256 256 -100.229230 256 257 112.992100 256 1361 -0.450112 257 207 -0.002434 257 208 -4.516995 257 209 -7.635529 257 255 0.003836 257 256 15.487904 257 257 26.180753 257 258 -0.000025 257 259 -4.770568 257 260 -8.064167 257 303 -0.000025 257 304 -4.762029 257 305 -8.049733 257 1359 -0.000008 257 1360 -1.426136 257 1361 -2.410741 258 210 -0.572549 258 211 38.015026 258 212 64.260557 258 255 -0.061331 258 256 1.205691 258 257 2.038100 258 258 575.127750 258 259 -374.036510 258 260 -632.270920 258 261 -0.002404 258 306 -0.002399 258 1362 -0.000734 258 1363 1.717198 258 1364 2.902749 259 212 -9.839850 259 257 -0.330190 259 259 -109.251310 259 260 98.012889 259 1364 -0.455689 260 210 -0.002680 260 211 -4.494527 260 212 -7.597543 260 255 -0.000025 260 256 -4.770568 260 257 -8.064167 260 258 0.004107 260 259 20.220255 260 260 34.180302 260 261 -0.000025 260 262 -4.770618 260 263 -8.064247 260 306 -0.000025 260 307 -4.760680 260 308 -8.047449 260 1362 -0.000008 260 1363 -1.411688 260 1364 -2.386316 261 213 -0.696206 261 214 38.721161 261 215 65.454250 261 258 -0.087124 261 259 1.446488 261 260 2.445142 261 261 575.156410 261 262 -374.643450 261 263 -633.297290 261 264 -0.002432 261 309 -0.002425 261 1365 -0.083649 261 1366 1.765941 261 1367 2.985147 262 215 -9.916144 262 260 -0.396133 262 262 -109.245110 262 263 98.193118 262 1367 -0.461354 263 213 -0.003167 263 214 -4.447221 263 215 -7.517583 263 258 -0.000025 263 259 -4.770618 263 260 -8.064247 263 261 0.005277 263 262 20.149213 263 263 34.060225 263 264 -0.000025 263 265 -4.770972 263 266 -8.064851 263 309 -0.000025 263 310 -4.758173 263 311 -8.043216 263 1365 -0.000691 263 1366 -1.390058 263 1367 -2.349753 264 216 -0.734888 264 217 40.088522 264 218 67.765594 264 261 -0.007934 264 262 0.390336 264 263 0.659823 264 264 575.293290 264 265 -376.362580 264 266 -636.202910 264 267 -0.063768 264 268 1.595729 264 269 2.697421 264 312 -0.024186 264 1368 -0.090841 264 1369 1.726506 264 1370 2.918483 265 218 -10.211302 265 263 -0.106896 265 265 -109.072050 265 266 98.474973 265 269 -0.432764 265 1370 -0.448680 266 216 -0.003409 266 217 -4.423341 266 218 -7.477211 266 261 -0.000025 266 262 -4.770972 266 263 -8.064851 266 264 0.006302 266 265 20.050582 266 266 33.893491 266 267 -0.000496 266 268 -4.724186 266 269 -7.985765 266 312 -0.000252 266 313 -4.737192 266 314 -8.007744 266 1368 -0.000765 266 1369 -1.382738 266 1370 -2.337379 267 219 -0.751303 267 220 41.711503 267 221 70.509125 267 264 -0.047553 267 267 575.383530 267 268 -379.657950 267 269 -641.773800 267 270 -0.063582 267 271 3.564133 267 272 6.024807 267 315 -0.047438 267 1371 -0.096814 267 1372 1.612247 267 1373 2.725342 268 221 -10.625014 268 268 -108.886460 268 269 99.168081 268 272 -0.976066 268 1373 -0.416776 269 219 -0.003409 269 220 -4.424803 269 221 -7.479687 269 264 -0.000496 269 265 -4.724186 269 266 -7.985765 269 267 0.006629 269 268 20.020417 269 269 33.842508 269 270 -0.000025 269 271 -4.770303 269 272 -8.063716 269 315 -0.000495 269 316 -4.713297 269 317 -7.967358 269 1371 -0.000840 269 1372 -1.375697 269 1373 -2.325478 270 222 -0.673352 270 223 42.136737 270 224 71.227889 270 267 -0.002414 270 270 575.258730 270 271 -382.003880 270 272 -645.739000 270 273 -0.114481 270 274 5.745762 270 275 9.712636 270 318 -0.002409 270 1374 -0.065999 270 1375 1.435957 270 1376 2.427339 271 224 -10.863549 271 271 -109.245510 271 272 100.208510 271 275 -1.573535 271 1376 -0.377117 272 222 -0.002804 272 223 -4.387421 272 224 -7.416492 272 267 -0.000025 272 268 -4.770303 272 269 -8.063716 272 270 0.004838 272 271 19.950620 272 272 33.724511 272 273 -0.000024 272 274 -4.622886 272 275 -7.814527 272 318 -0.000025 272 319 -4.761428 272 320 -8.048713 272 1374 -0.000616 272 1375 -1.396409 272 1376 -2.360487 273 225 -0.518847 273 226 40.524145 273 227 68.502014 273 270 -0.002303 273 273 540.678330 273 274 -363.064230 273 275 -613.723770 273 276 -0.153708 273 277 7.859068 273 278 13.284960 273 321 -0.002299 273 1377 -0.000772 273 1378 1.281349 273 1379 2.165992 274 227 -10.635726 274 274 -102.693650 274 275 95.280061 274 278 -2.152302 274 1379 -0.341669 275 225 -0.001878 275 226 -4.193291 275 227 -7.088339 275 270 -0.000024 275 271 -4.622886 275 272 -7.814527 275 273 0.003220 275 274 19.287736 275 275 32.603984 275 276 -0.000022 275 277 -4.336491 275 278 -7.330400 275 321 -0.000024 275 322 -4.614695 275 323 -7.800680 275 1377 -0.000008 275 1378 -1.508930 275 1379 -2.550695 276 228 -0.367419 276 229 37.856342 276 230 63.992312 276 273 -0.002126 276 276 506.167270 276 277 -342.279590 276 278 -578.589030 276 279 -0.148128 276 280 9.560603 276 281 16.161243 276 324 -0.002100 276 1380 -0.000812 276 1381 1.032550 276 1382 1.745421 277 230 -10.065562 277 277 -96.142388 277 278 89.845061 277 281 -2.618312 277 1382 -0.280897 278 228 -0.001218 278 229 -3.919831 278 230 -6.626076 278 273 -0.000022 278 274 -4.336491 278 275 -7.330400 278 276 0.002473 278 277 18.194383 278 278 30.755768 278 279 -0.000020 278 280 -3.998508 278 281 -6.759078 278 324 -0.000022 278 325 -4.283847 278 326 -7.241411 278 1380 -0.000008 278 1381 -1.644991 278 1382 -2.780692 279 231 -0.209472 279 232 34.447542 279 233 58.230126 279 276 -0.001924 279 279 460.094230 279 280 -315.055630 279 281 -532.570030 279 282 -0.165332 279 283 11.886166 279 284 20.092362 279 327 -0.001877 279 1383 -0.000877 279 1384 0.833644 279 1385 1.409192 280 233 -9.366170 280 280 -87.403089 280 281 82.741962 280 284 -3.255230 280 1385 -0.228305 281 231 -0.000290 281 232 -3.681971 281 233 -6.224003 281 276 -0.000020 281 277 -3.998508 281 278 -6.759078 281 279 0.001432 281 280 17.081396 281 281 28.874387 281 282 -0.000018 281 283 -3.667843 281 284 -6.200118 281 327 -0.000020 281 328 -3.900897 281 329 -6.594076 281 1383 -0.000009 281 1384 -1.822437 281 1385 -3.080647 282 234 -0.123537 282 235 29.659902 282 236 50.137073 282 279 -0.001735 282 282 425.643530 282 283 -299.018730 282 284 -505.460930 282 285 -0.267757 282 286 20.669061 282 287 34.938980 282 330 -0.001688 282 1386 -0.000932 282 1387 0.721203 282 1388 1.219121 283 236 -8.122925 283 283 -80.847251 283 284 78.617985 283 287 -5.660657 283 1388 -0.197513 284 234 -0.000017 284 235 -3.422994 284 236 -5.786226 284 279 -0.000018 284 280 -3.667843 284 281 -6.200118 284 282 0.001073 284 283 16.020787 284 284 27.081526 284 285 -0.000016 284 286 -3.380930 284 287 -5.715124 284 330 -0.000018 284 331 -3.569419 284 332 -6.033741 284 1386 -0.000010 284 1387 -1.970592 284 1388 -3.331087 285 237 -0.001847 285 238 16.689927 285 239 28.212653 285 282 -0.001552 285 285 391.011080 285 286 -245.169820 285 287 -414.435060 285 1389 -0.000985 285 1390 0.710329 285 1391 1.200740 286 239 -4.570908 286 286 -74.289358 286 287 64.143619 286 1391 -0.194539 287 237 -0.000015 287 238 -3.186243 287 239 -5.386026 287 282 -0.000016 287 283 -3.380930 287 284 -5.715124 287 285 0.000955 287 286 8.721027 287 287 14.742025 287 1389 -0.000010 287 1390 -2.145576 287 1391 -3.626882 288 288 1.000000 289 289 1.000000 290 290 1.000000 291 291 1.000000 292 292 1.000000 293 293 1.000000 294 294 1.000000 295 295 1.000000 296 296 1.000000 297 297 1.000000 298 298 1.000000 299 299 1.000000 300 300 1.000000 301 301 1.000000 302 302 1.000000 303 255 -0.240533 303 256 41.710395 303 257 70.507252 303 303 574.853820 303 304 -378.188000 303 305 -639.289000 303 306 -0.002452 303 351 -0.002444 303 1407 -0.000749 303 1408 1.133197 303 1409 1.915557 304 257 -11.422778 304 304 -100.264510 304 305 114.312160 304 1409 -0.310332 305 255 -0.000025 305 256 -4.762029 305 257 -8.049733 305 303 0.001428 305 304 15.762163 305 305 26.644360 305 306 -0.000026 305 307 -4.771610 305 308 -8.065930 305 351 -0.000026 305 352 -4.758091 305 353 -8.043076 305 1407 -0.000008 305 1408 -1.458242 305 1409 -2.465013 306 258 -0.248114 306 259 42.446987 306 260 71.752342 306 303 -0.069041 306 304 1.955428 306 305 3.305456 306 306 574.864580 306 307 -380.943930 306 308 -643.947180 306 309 -0.002456 306 354 -0.002448 306 1410 -0.000751 306 1411 1.144864 306 1412 1.935277 307 260 -11.624465 307 305 -0.535505 307 307 -109.285730 307 308 99.820041 307 1412 -0.313526 308 258 -0.000025 308 259 -4.760680 308 260 -8.047449 308 303 -0.000026 308 304 -4.771610 308 305 -8.065930 308 306 0.001453 308 307 20.531953 308 308 34.707196 308 309 -0.000026 308 310 -4.771707 308 311 -8.066088 308 354 -0.000026 308 355 -4.756790 308 356 -8.040872 308 1410 -0.000008 308 1411 -1.458976 308 1412 -2.466251 309 261 -0.241840 309 262 44.102251 309 263 74.550445 309 306 -0.080982 309 307 3.128247 309 308 5.287986 309 309 574.848610 309 310 -383.753620 309 311 -648.697130 309 312 -0.002463 309 357 -0.002455 309 1413 -0.000754 309 1414 1.160065 309 1415 1.960974 310 263 -12.077701 310 308 -0.856687 310 310 -109.282580 310 311 100.596740 310 1415 -0.317392 311 261 -0.000025 311 262 -4.758173 311 263 -8.043216 311 306 -0.000026 311 307 -4.771707 311 308 -8.066088 311 309 0.001454 311 310 20.527605 311 311 34.699859 311 312 -0.000026 311 313 -4.771829 311 314 -8.066300 311 357 -0.000026 311 358 -4.755391 311 359 -8.038513 311 1413 -0.000008 311 1414 -1.458317 311 1415 -2.465140 312 264 -0.306743 312 265 46.208999 312 266 78.111643 312 309 -0.051146 312 310 2.489980 312 311 4.209062 312 312 574.900450 312 313 -385.057820 312 314 -650.901250 312 315 -0.002473 312 360 -0.002464 312 1416 -0.000756 312 1417 1.193951 312 1418 2.018254 313 266 -12.595337 313 311 -0.681893 313 313 -109.281340 313 314 100.956820 313 1418 -0.325025 314 264 -0.000252 314 265 -4.737192 314 266 -8.007744 314 309 -0.000026 314 310 -4.771829 314 311 -8.066300 314 312 0.001681 314 313 20.498379 314 314 34.650441 314 315 -0.000026 314 316 -4.771781 314 317 -8.066213 314 360 -0.000026 314 361 -4.755227 314 362 -8.038230 314 1416 -0.000008 314 1417 -1.450162 314 1418 -2.451353 315 267 -0.370517 315 268 47.904941 315 269 80.978512 315 312 -0.026877 315 313 0.104478 315 314 0.176609 315 315 574.918290 315 316 -387.272960 315 317 -654.646210 315 318 -0.058354 315 319 3.198995 315 320 5.407578 315 363 -0.002469 315 1419 -0.000757 315 1420 1.185961 315 1421 2.004748 316 269 -12.991897 316 314 -0.028612 316 316 -100.254000 316 317 116.824520 316 320 -0.876061 316 1421 -0.321222 317 267 -0.000495 317 268 -4.713297 317 269 -7.967358 317 312 -0.000026 317 313 -4.771781 317 314 -8.066213 317 315 0.001924 317 316 20.466586 317 317 34.596706 317 318 -0.000026 317 319 -4.771299 317 320 -8.065399 317 363 -0.000026 317 364 -4.755185 317 365 -8.038164 317 1419 -0.000008 317 1420 -1.442837 317 1421 -2.438972 318 270 -0.330881 318 271 48.289200 318 272 81.628018 318 315 -0.002462 318 318 574.936420 318 319 -390.526490 318 320 -660.145610 318 321 -0.130907 318 322 5.742553 318 323 9.707211 318 366 -0.002454 318 1422 -0.000753 318 1423 1.113833 318 1424 1.882822 319 272 -13.224376 319 319 -109.280150 319 320 102.457520 319 323 -1.572631 319 1424 -0.303215 320 270 -0.000025 320 271 -4.761428 320 272 -8.048713 320 315 -0.000026 320 316 -4.771299 320 317 -8.065399 320 318 0.001454 320 319 20.521060 320 320 34.688785 320 321 -0.000026 320 322 -4.770479 320 323 -8.064017 320 366 -0.000026 320 367 -4.755219 320 368 -8.038218 320 1422 -0.000008 320 1423 -1.450448 320 1424 -2.451836 321 273 -0.308332 321 274 46.980387 321 275 79.415645 321 318 -0.002448 321 321 575.019100 321 322 -391.294910 321 323 -661.444910 321 324 -0.184205 321 325 7.981406 321 326 13.491762 321 369 -0.002442 321 1425 -0.000749 321 1426 1.010525 321 1427 1.708192 322 275 -12.866050 322 322 -109.284480 322 323 102.657800 322 326 -2.185763 322 1427 -0.276737 323 273 -0.000024 323 274 -4.614695 323 275 -7.800680 323 318 -0.000026 323 319 -4.770479 323 320 -8.064017 323 321 0.001451 323 322 20.186025 323 323 34.122453 323 324 -0.000024 323 325 -4.571862 323 326 -7.728272 323 369 -0.000025 323 370 -4.758024 323 371 -8.042964 323 1425 -0.000008 323 1426 -1.458776 323 1427 -2.465915 324 276 -0.265474 324 277 43.895681 324 278 74.201208 324 321 -0.002328 324 324 529.093330 324 325 -361.834940 324 326 -611.645450 324 327 -0.160385 324 328 8.502203 324 329 14.372125 324 372 -0.002254 324 1428 -0.000807 324 1429 0.951356 324 1430 1.608170 325 278 -12.021368 325 325 -100.547760 325 326 94.936056 325 329 -2.328398 325 1430 -0.260535 326 276 -0.000022 326 277 -4.283847 326 278 -7.241411 326 321 -0.000024 326 322 -4.571862 326 323 -7.728272 326 324 0.001337 326 325 19.068643 326 326 32.233618 326 327 -0.000022 326 328 -4.190238 326 329 -7.083178 326 372 -0.000024 326 373 -4.426915 326 374 -7.483253 326 1428 -0.000008 326 1429 -1.584564 326 1430 -2.678545 327 279 -0.236963 327 280 41.382436 327 281 69.952869 327 324 -0.002114 327 327 483.053590 327 328 -330.908030 327 329 -559.366940 327 330 -0.120180 327 331 7.045998 327 332 11.910547 327 375 -0.002064 327 1431 -0.000876 327 1432 0.871833 327 1433 1.473746 328 281 -11.333192 328 328 -91.807741 328 329 86.820392 328 332 -1.929613 328 1433 -0.238759 329 279 -0.000020 329 280 -3.900897 329 281 -6.594076 329 324 -0.000022 329 325 -4.190238 329 326 -7.083178 329 327 0.001221 329 328 17.737475 329 329 29.983424 329 330 -0.000020 329 331 -3.807946 329 332 -6.436947 329 375 -0.000022 329 376 -4.092152 329 377 -6.917374 329 1431 -0.000009 329 1432 -1.736001 329 1433 -2.934535 330 282 -0.265106 330 283 42.827330 330 284 72.395271 330 327 -0.001905 330 330 437.022830 330 331 -298.436390 330 332 -504.476560 330 378 -0.001855 330 1434 -0.000960 330 1435 0.824705 330 1436 1.394080 331 284 -11.728997 331 331 -83.065671 331 332 78.286656 331 1436 -0.225853 332 282 -0.000018 332 283 -3.569419 332 284 -6.033741 332 327 -0.000020 332 328 -3.807946 332 329 -6.436947 332 330 0.001088 332 331 13.013397 332 332 21.997831 332 378 -0.000019 332 379 -3.707993 332 380 -6.267987 332 1434 -0.000010 332 1435 -1.918772 332 1436 -3.243489 333 333 1.000000 334 334 1.000000 335 335 1.000000 336 336 1.000000 337 337 1.000000 338 338 1.000000 339 339 1.000000 340 340 1.000000 341 341 1.000000 342 342 1.000000 343 343 1.000000 344 344 1.000000 345 345 1.000000 346 346 1.000000 347 347 1.000000 348 348 1.000000 349 349 1.000000 350 350 1.000000 351 303 -0.239149 351 304 46.140393 351 305 77.995721 351 351 574.789460 351 352 -382.660890 351 353 -646.849970 351 354 -0.002557 351 399 -0.002436 351 1455 -0.000782 351 1456 1.051910 351 1457 1.778149 352 305 -12.635806 352 352 -100.305820 352 353 115.435320 352 1457 -0.288065 353 303 -0.000026 353 304 -4.758091 353 305 -8.043076 353 351 0.001430 353 352 15.551099 353 353 26.287578 353 354 -0.000027 353 355 -4.772839 353 356 -8.068006 353 399 -0.000025 353 400 -4.547600 353 401 -7.687263 353 1455 -0.000008 353 1456 -1.460362 353 1457 -2.468596 354 306 -0.232010 354 307 47.718748 354 308 80.663716 354 351 -0.062044 354 352 3.551726 354 353 6.003837 354 354 574.843860 354 355 -387.852090 354 356 -655.624830 354 357 -0.002565 354 402 -0.002499 354 1458 -0.000785 354 1459 1.145018 354 1460 1.935538 355 308 -13.068034 355 353 -0.972638 355 355 -109.328350 355 356 101.605680 355 1460 -0.313563 356 306 -0.000026 356 307 -4.756790 356 308 -8.040872 356 351 -0.000027 356 352 -4.772839 356 353 -8.068006 356 354 0.001457 356 355 20.425388 356 356 34.527060 356 357 -0.000027 356 358 -4.772648 356 359 -8.067680 356 402 -0.000026 356 403 -4.650736 356 404 -7.861600 356 1458 -0.000008 356 1459 -1.460166 356 1460 -2.468263 357 309 -0.243872 357 310 51.162626 357 311 86.485303 357 354 -0.093051 357 355 6.598658 357 356 11.154366 357 357 574.933090 357 358 -394.520180 357 359 -666.896920 357 360 -0.002580 357 405 -0.002568 357 1461 -0.000789 357 1462 1.295786 357 1463 2.190397 358 311 -14.011138 358 356 -1.807035 358 358 -109.328750 358 359 103.430250 358 1463 -0.354849 359 309 -0.000026 359 310 -4.755391 359 311 -8.038513 359 354 -0.000027 359 355 -4.772648 359 356 -8.067680 359 357 0.001458 359 358 20.524561 359 359 34.694713 359 360 -0.000027 359 361 -4.772618 359 362 -8.067633 359 405 -0.000027 359 406 -4.751601 359 407 -8.032107 359 1461 -0.000008 359 1462 -1.460094 359 1463 -2.468143 360 312 -0.304690 360 313 54.850702 360 314 92.719559 360 357 -0.112290 360 358 6.193038 360 359 10.468712 360 360 574.921320 360 361 -397.940350 360 362 -672.677880 360 363 -0.002595 360 408 -0.002584 360 1464 -0.000794 360 1465 1.452377 360 1466 2.455096 361 314 -15.021105 361 359 -1.695952 361 361 -109.326800 361 362 104.371310 361 1466 -0.397730 362 312 -0.000026 362 313 -4.755227 362 314 -8.038230 362 357 -0.000027 362 358 -4.772618 362 359 -8.067633 362 360 0.001459 362 361 20.528588 362 362 34.701505 362 363 -0.000027 362 364 -4.772747 362 365 -8.067845 362 408 -0.000027 362 409 -4.754914 362 410 -8.037701 362 1464 -0.000008 362 1465 -1.460875 362 1466 -2.469460 363 315 -0.328281 363 316 57.167553 363 317 96.636031 363 360 -0.050669 363 361 2.429992 363 362 4.107656 363 363 574.917050 363 364 -399.750220 363 365 -675.737770 363 366 -0.057928 363 367 3.143767 363 368 5.314221 363 411 -0.002590 363 1467 -0.000796 363 1468 1.526241 363 1469 2.579958 364 317 -15.655569 364 362 -0.665447 364 364 -109.325560 364 365 104.869620 364 368 -0.860912 364 1469 -0.417957 365 315 -0.000026 365 316 -4.755185 365 317 -8.038164 365 360 -0.000027 365 361 -4.772747 365 362 -8.067845 365 363 0.001459 365 364 20.528470 365 365 34.701317 365 366 -0.000027 365 367 -4.772566 365 368 -8.067542 365 411 -0.000027 365 412 -4.754903 365 413 -8.037688 365 1467 -0.000008 365 1468 -1.460863 365 1469 -2.469443 366 318 -0.328822 366 319 57.223219 366 320 96.730076 366 363 -0.002593 366 366 574.959350 366 367 -401.671520 366 368 -678.985270 366 369 -0.126107 366 370 7.551997 366 371 12.765896 366 414 -0.002583 366 1470 -0.000794 366 1471 1.466363 366 1472 2.478738 367 320 -15.670861 367 367 -109.326520 367 368 105.393740 367 371 -2.068102 367 1472 -0.401560 368 318 -0.000026 368 319 -4.755219 368 320 -8.038218 368 363 -0.000027 368 364 -4.772566 368 365 -8.067542 368 366 0.001459 368 367 20.529394 368 368 34.702875 368 369 -0.000027 368 370 -4.772133 368 371 -8.066813 368 414 -0.000027 368 415 -4.756286 368 416 -8.040022 368 1470 -0.000008 368 1471 -1.460983 368 1472 -2.469644 369 321 -0.333924 369 322 55.453699 369 323 93.738933 369 366 -0.002575 369 369 575.007240 369 370 -401.783220 369 371 -679.174360 369 372 -0.176068 369 373 9.558048 369 374 16.156913 369 417 -0.002567 369 1473 -0.000788 369 1474 1.317196 369 1475 2.226588 370 323 -15.186317 370 370 -109.327940 370 371 105.421310 370 374 -2.617468 370 1475 -0.360713 371 321 -0.000025 371 322 -4.758024 371 323 -8.042964 371 366 -0.000027 371 367 -4.772133 371 368 -8.066813 371 369 0.001457 371 370 20.383029 371 371 34.455466 371 372 -0.000026 371 373 -4.623909 371 374 -7.816251 371 417 -0.000027 371 418 -4.756408 371 419 -8.040232 371 1473 -0.000008 371 1474 -1.460347 371 1475 -2.468570 372 324 -0.320531 372 325 50.170634 372 326 84.808394 372 369 -0.002473 372 372 540.553300 372 373 -376.743370 372 374 -636.846550 372 375 -0.198073 372 376 10.116997 372 377 17.101772 372 420 -0.002441 372 1476 -0.000831 372 1477 1.183747 372 1478 2.001004 373 326 -13.739575 373 373 -102.771570 373 374 98.833318 373 377 -2.770551 373 1478 -0.324169 374 324 -0.000024 374 325 -4.426915 374 326 -7.483253 374 369 -0.000026 374 370 -4.623909 374 371 -7.816251 374 372 0.001371 374 373 19.517038 374 374 32.991584 374 375 -0.000024 374 376 -4.337745 374 377 -7.332525 374 420 -0.000025 374 421 -4.564156 374 422 -7.715244 374 1476 -0.000009 374 1477 -1.552835 374 1478 -2.624910 375 327 -0.266104 375 328 45.134249 375 329 76.294935 375 372 -0.002297 375 375 506.055980 375 376 -349.110060 375 377 -590.135650 375 378 -0.130371 375 379 7.799108 375 380 13.183603 375 423 -0.002265 375 1479 -0.000878 375 1480 1.038250 375 1481 1.755057 376 329 -12.360385 376 376 -96.216272 376 377 91.532256 376 380 -2.135804 376 1481 -0.284326 377 327 -0.000022 377 328 -4.092152 377 329 -6.917374 377 372 -0.000024 377 373 -4.337745 377 374 -7.332525 377 375 0.001283 377 376 18.374990 377 377 31.061078 377 378 -0.000022 377 379 -4.000002 377 380 -6.761598 377 423 -0.000024 377 424 -4.276954 377 425 -7.229763 377 1479 -0.000009 377 1480 -1.657390 377 1481 -2.801652 378 330 -0.237342 378 331 40.527498 378 332 68.507639 378 375 -0.002101 378 378 459.883580 378 379 -309.758740 378 380 -523.615800 378 426 -0.002022 378 1482 -0.000959 378 1483 0.959498 378 1484 1.621934 379 332 -11.098836 379 379 -87.470802 379 380 81.123098 379 1484 -0.262761 380 330 -0.000019 380 331 -3.707993 380 332 -6.267987 380 375 -0.000022 380 376 -4.000002 380 377 -6.761598 380 378 0.001147 380 379 13.394024 380 380 22.641243 380 426 -0.000021 380 427 -3.849901 380 428 -6.507868 380 1482 -0.000010 380 1483 -1.826358 380 1484 -3.087274 381 381 1.000000 382 382 1.000000 383 383 1.000000 384 384 1.000000 385 385 1.000000 386 386 1.000000 387 387 1.000000 388 388 1.000000 389 389 1.000000 390 390 1.000000 391 391 1.000000 392 392 1.000000 393 393 1.000000 394 394 1.000000 395 395 1.000000 396 396 505.517050 396 397 -310.196010 396 398 -524.355000 396 399 -0.074876 396 400 13.837884 396 401 23.391558 396 444 -0.189581 396 1500 -0.000949 396 1501 0.967368 396 1502 1.635238 397 397 -96.262683 397 398 80.758997 397 401 -3.789401 397 1502 -0.264905 398 396 0.001241 398 397 9.786258 398 398 16.542684 398 399 -0.000025 398 400 -4.294039 398 401 -7.258644 398 444 -0.000023 398 445 -3.809722 398 446 -6.439950 398 1500 -0.000010 398 1501 -1.671730 398 1502 -2.825890 399 351 -0.223521 399 352 49.071106 399 353 82.949797 399 396 -0.002406 399 399 528.658800 399 400 -358.894870 399 401 -606.675880 399 402 -0.002513 399 447 -0.002270 399 1503 -0.000894 399 1504 1.107872 399 1505 1.872748 400 353 -13.438094 400 400 -100.626270 400 401 93.934360 400 1505 -0.303383 401 351 -0.000025 401 352 -4.547600 401 353 -7.687263 401 396 -0.000025 401 397 -4.294039 401 398 -7.258644 401 399 0.001346 401 400 18.984973 401 401 32.092198 401 402 -0.000026 401 403 -4.485373 401 404 -7.582075 401 447 -0.000024 401 448 -4.051385 401 449 -6.848461 401 1503 -0.000009 401 1504 -1.595325 401 1505 -2.696737 402 354 -0.244770 402 355 51.214427 402 356 86.572821 402 399 -0.073997 402 400 4.331028 402 401 7.321170 402 402 551.772320 402 403 -379.066620 402 404 -640.773810 402 405 -0.002631 402 450 -0.002448 402 1506 -0.000859 402 1507 1.370675 402 1508 2.316988 403 356 -14.025016 403 401 -1.186020 403 403 -105.000440 403 404 99.271279 403 1508 -0.375349 404 354 -0.000026 404 355 -4.650736 404 356 -7.861600 404 399 -0.000026 404 400 -4.485373 404 401 -7.582075 404 402 0.001404 404 403 19.704360 404 404 33.308234 404 405 -0.000027 404 406 -4.676416 404 407 -7.905008 404 450 -0.000026 404 451 -4.352907 404 452 -7.358149 404 1506 -0.000009 404 1507 -1.527188 404 1508 -2.581557 405 357 -0.316568 405 358 58.288778 405 359 98.531351 405 402 -0.156686 405 403 12.333979 405 404 20.849344 405 405 574.922960 405 406 -407.928120 405 407 -689.561680 405 408 -0.002714 405 453 -0.002612 405 1509 -0.000832 405 1510 1.778705 405 1511 3.006723 406 359 -15.962269 406 404 -3.377559 406 406 -109.377610 406 407 106.979650 406 1511 -0.487082 407 357 -0.000027 407 358 -4.751601 407 359 -8.032107 407 402 -0.000027 407 403 -4.676416 407 404 -7.905008 407 405 0.001462 407 406 20.272988 407 407 34.269454 407 408 -0.000028 407 409 -4.773878 407 410 -8.069763 407 453 -0.000027 407 454 -4.595281 407 455 -7.767864 407 1509 -0.000009 407 1510 -1.463582 407 1511 -2.474039 408 360 -0.366171 408 361 65.469467 408 362 110.669510 408 405 -0.161983 408 406 13.362148 408 407 22.587375 408 408 575.070180 408 409 -416.697170 408 410 -704.384500 408 411 -0.002744 408 456 -0.002727 408 1512 -0.000839 408 1513 2.322363 408 1514 3.925721 409 362 -17.928632 409 407 -3.659093 409 409 -109.380610 409 410 109.372870 409 1514 -0.635955 410 360 -0.000027 410 361 -4.754914 410 362 -8.037701 410 405 -0.000028 410 406 -4.773878 410 407 -8.069763 410 408 0.001465 410 409 20.519955 410 410 34.686913 410 411 -0.000029 410 412 -4.773891 410 413 -8.069780 410 456 -0.000028 410 457 -4.744732 410 458 -8.020490 410 1512 -0.000009 410 1513 -1.460309 410 1514 -2.468505 411 363 -0.409294 411 364 69.707805 411 365 117.834070 411 408 -0.094099 411 409 6.685379 411 410 11.300958 411 411 575.065950 411 412 -418.959700 411 413 -708.209480 411 414 -0.070760 411 415 4.390156 411 416 7.421117 411 459 -0.002743 411 1515 -0.000844 411 1516 2.663612 411 1517 4.502570 412 365 -19.089266 412 410 -1.830714 412 412 -109.381040 412 413 109.990850 412 416 -1.202192 412 1517 -0.729400 413 363 -0.000027 413 364 -4.754903 413 365 -8.037688 413 408 -0.000029 413 409 -4.773891 413 410 -8.069780 413 411 0.001466 413 412 20.522181 413 413 34.690686 413 414 -0.000029 413 415 -4.773896 413 416 -8.069790 413 459 -0.000029 413 460 -4.746953 413 461 -8.024250 413 1515 -0.000009 413 1516 -1.460307 413 1517 -2.468503 414 366 -0.396773 414 367 68.486522 414 368 115.769570 414 411 -0.002750 414 414 575.107380 414 415 -418.331300 414 416 -707.146920 414 417 -0.146766 414 418 11.865530 414 419 20.057491 414 462 -0.002737 414 1518 -0.000841 414 1519 2.450524 414 1520 4.142363 415 368 -18.754848 415 415 -109.381500 415 416 109.818010 415 419 -3.249253 415 1520 -0.671049 416 366 -0.000027 416 367 -4.756286 416 368 -8.040022 416 411 -0.000029 416 412 -4.773896 416 413 -8.069790 416 414 0.001465 416 415 20.527906 416 416 34.700360 416 417 -0.000028 416 418 -4.773719 416 419 -8.069494 416 462 -0.000029 416 463 -4.752297 416 464 -8.033280 416 1518 -0.000009 416 1519 -1.459477 416 1520 -2.467098 417 369 -0.376333 417 370 64.191733 417 371 108.509700 417 414 -0.002722 417 417 575.070290 417 418 -416.266450 417 419 -703.656800 417 420 -0.200023 417 421 14.573841 417 422 24.635603 417 465 -0.002712 417 1521 -0.000833 417 1522 2.005103 417 1523 3.389426 418 371 -17.578799 418 418 -109.379080 418 419 109.259190 418 422 -3.990925 418 1523 -0.549078 419 369 -0.000027 419 370 -4.756408 419 371 -8.040232 419 414 -0.000028 419 415 -4.773719 419 416 -8.069494 419 417 0.001464 419 418 20.483830 419 419 34.625861 419 420 -0.000028 419 421 -4.725012 419 422 -7.987154 419 465 -0.000028 419 466 -4.756032 419 467 -8.039597 419 1521 -0.000009 419 1522 -1.460429 419 1523 -2.468710 420 372 -0.341759 420 373 56.952369 420 374 96.272217 420 417 -0.002661 420 420 563.528350 420 421 -403.020410 420 422 -681.265200 420 423 -0.236419 420 424 15.644070 420 425 26.444736 420 468 -0.002651 420 1524 -0.000840 420 1525 1.604189 420 1526 2.711719 421 374 -15.596386 421 421 -107.190430 421 422 105.730240 421 425 -4.284033 421 1526 -0.439295 422 372 -0.000025 422 373 -4.564156 422 374 -7.715244 422 417 -0.000028 422 418 -4.725012 422 419 -7.987154 422 420 0.001433 422 421 20.027838 422 422 33.855038 422 423 -0.000026 422 424 -4.528858 422 425 -7.655582 422 468 -0.000028 422 469 -4.706510 422 470 -7.955879 422 1524 -0.000009 422 1525 -1.491316 422 1526 -2.520918 423 375 -0.292316 423 376 48.568136 423 377 82.099576 423 420 -0.002515 423 423 528.961250 423 424 -372.813210 423 425 -630.203450 423 426 -0.261328 423 427 14.276224 423 428 24.132512 423 471 -0.002454 423 1527 -0.000884 423 1528 1.321505 423 1529 2.233873 424 377 -13.300440 424 424 -100.628620 424 425 97.740717 424 428 -3.909488 424 1529 -0.361887 425 375 -0.000024 425 376 -4.276954 425 377 -7.229763 425 420 -0.000026 425 421 -4.528858 425 422 -7.655582 425 423 0.001345 425 424 18.965360 425 425 32.059040 425 426 -0.000024 425 427 -4.137203 425 428 -6.993523 425 471 -0.000026 425 472 -4.419515 425 473 -7.470749 425 1527 -0.000009 425 1528 -1.591578 425 1529 -2.690404 426 378 -0.145449 426 379 37.938706 426 380 64.131542 426 423 -0.002265 426 426 471.366340 426 427 -314.136120 426 428 -531.015340 426 474 -0.002185 426 1530 -0.000976 426 1531 1.157591 426 1532 1.956790 427 380 -10.389604 427 427 -89.695520 427 428 82.134742 427 1532 -0.317002 428 378 -0.000021 428 379 -3.849901 428 380 -6.507868 428 423 -0.000024 428 424 -4.137203 428 425 -6.993523 428 426 0.001180 428 427 13.771905 428 428 23.280012 428 474 -0.000023 428 475 -3.991607 428 476 -6.747407 428 1530 -0.000010 428 1531 -1.783164 428 1532 -3.014258 429 429 1.000000 430 430 1.000000 431 431 1.000000 432 432 1.000000 433 433 1.000000 434 434 1.000000 435 435 1.000000 436 436 1.000000 437 437 1.000000 438 438 1.000000 439 439 1.000000 440 440 1.000000 441 441 1.000000 442 442 1.000000 443 443 1.000000 444 396 -0.002207 444 397 19.835020 444 398 33.529096 444 444 425.372960 444 445 -269.140690 444 446 -454.955080 444 447 -0.002126 444 492 -0.022188 444 1548 -0.001147 444 1549 1.028724 444 1550 1.738954 445 398 -5.431630 445 445 -80.988821 445 446 70.082321 445 1550 -0.281703 446 396 -0.000023 446 397 -3.809722 446 398 -6.439950 446 444 0.001072 446 445 12.675962 446 446 21.427431 446 447 -0.000022 446 448 -3.670066 446 449 -6.203874 446 492 -0.000020 446 493 -3.206808 446 494 -5.420784 446 1548 -0.000012 446 1549 -1.980295 446 1550 -3.347488 447 399 -0.008443 447 400 37.150315 447 401 62.798893 447 444 -0.126281 447 445 2.718758 447 446 4.595786 447 447 459.711700 447 448 -309.652200 447 449 -523.436070 447 450 -0.002325 447 495 -0.010442 447 1551 -0.001067 447 1552 1.285298 447 1553 2.172668 448 401 -10.173335 448 446 -0.744497 448 448 -87.547250 448 449 80.902187 448 1553 -0.351962 449 399 -0.000024 449 400 -4.051385 449 401 -6.848461 449 444 -0.000022 449 445 -3.670066 449 446 -6.203874 449 447 0.001179 449 448 17.112696 449 449 28.927296 449 450 -0.000024 449 451 -4.001457 449 452 -6.764063 449 495 -0.000022 449 496 -3.543110 449 497 -5.989273 449 1551 -0.000011 449 1552 -1.836874 449 1553 -3.105053 450 402 -0.137826 450 403 49.956892 450 404 84.447076 450 447 -0.184408 450 448 13.093529 450 449 22.133302 450 450 505.916180 450 451 -360.192350 450 452 -608.868820 450 453 -0.002553 450 498 -0.002277 450 1554 -0.000981 450 1555 1.850248 450 1556 3.127657 451 404 -13.680288 451 449 -3.585488 451 451 -96.302513 451 452 94.350579 451 1556 -0.506663 452 402 -0.000026 452 403 -4.352907 452 404 -7.358149 452 447 -0.000024 452 448 -4.001457 452 449 -6.764063 452 450 0.001293 452 451 18.242362 452 452 30.836875 452 453 -0.000027 452 454 -4.339397 452 455 -7.335312 452 498 -0.000024 452 499 -3.870643 452 500 -6.542931 452 1554 -0.000010 452 1555 -1.667175 452 1556 -2.818189 453 405 -0.313866 453 406 64.594518 453 407 109.190570 453 450 -0.304404 453 451 22.638721 453 452 38.268474 453 453 540.601510 453 454 -405.612280 453 455 -685.646990 453 456 -0.002777 453 501 -0.002562 453 1557 -0.000938 453 1558 2.896472 453 1559 4.896196 454 407 -17.688576 454 452 -6.199264 454 454 -102.870770 454 455 106.489070 454 1559 -0.793148 455 405 -0.000027 455 406 -4.595281 455 407 -7.767864 455 450 -0.000027 455 451 -4.339397 455 452 -7.335312 455 453 0.001383 455 454 19.402726 455 455 32.798363 455 456 -0.000029 455 457 -4.626525 455 458 -7.820678 455 501 -0.000027 455 502 -4.267851 455 503 -7.214375 455 1557 -0.000010 455 1558 -1.562151 455 1559 -2.640660 456 408 -0.538198 456 409 80.044732 456 410 135.307540 456 453 -0.365817 456 454 25.964243 456 455 43.889957 456 456 575.128090 456 457 -445.928850 456 458 -753.797640 456 459 -0.002929 456 504 -0.002848 456 1560 -0.000901 456 1561 4.281811 456 1562 7.237969 457 410 -21.919324 457 455 -7.109820 457 457 -109.437850 457 458 117.232730 457 1562 -1.172486 458 408 -0.000028 458 409 -4.744732 458 410 -8.020490 458 453 -0.000029 458 454 -4.626525 458 455 -7.820678 458 456 0.001471 458 457 20.272320 458 458 34.268312 458 459 -0.000031 458 460 -4.775163 458 461 -8.071929 458 504 -0.000030 458 505 -4.644802 458 506 -7.851568 458 1560 -0.000009 458 1561 -1.468842 458 1562 -2.482929 459 411 -0.629079 459 412 88.993349 459 413 150.434360 459 456 -0.185425 459 457 15.650290 459 458 26.455233 459 459 575.203220 459 460 -455.297780 459 461 -769.635370 459 462 -0.099876 459 463 9.533252 459 464 16.114999 459 507 -0.002946 459 1563 -0.000911 459 1564 5.459841 459 1565 9.229315 460 413 -24.369717 460 458 -4.285481 460 460 -109.441740 460 461 119.787440 460 464 -2.610460 460 1565 -1.495057 461 411 -0.000029 461 412 -4.746953 461 413 -8.024250 461 456 -0.000031 461 457 -4.775163 461 458 -8.071929 461 459 0.001474 461 460 20.525033 461 461 34.695505 461 462 -0.000031 461 463 -4.774974 461 464 -8.071610 461 507 -0.000031 461 508 -4.748494 461 509 -8.026854 461 1563 -0.000010 461 1564 -1.467191 461 1565 -2.480140 462 414 -0.600986 462 415 83.975321 462 416 141.951820 462 459 -0.002942 462 462 575.164940 462 463 -445.732740 462 464 -753.466160 462 465 -0.268356 462 466 21.512569 462 467 36.364846 462 510 -0.002923 462 1566 -0.000902 462 1567 4.625658 462 1568 7.819207 463 416 -22.995641 463 463 -109.438060 463 464 117.178100 463 467 -5.890780 463 1568 -1.266638 464 414 -0.000029 464 415 -4.752297 464 416 -8.033280 464 459 -0.000031 464 460 -4.774974 464 461 -8.071610 464 462 0.001473 464 463 20.524459 464 464 34.694530 464 465 -0.000030 464 466 -4.774392 464 467 -8.070633 464 510 -0.000031 464 511 -4.745694 464 512 -8.022116 464 1566 -0.000009 464 1567 -1.464845 464 1568 -2.476172 465 417 -0.480449 465 418 74.431540 465 419 125.819070 465 462 -0.002892 465 465 575.208150 465 466 -436.815800 465 467 -738.393420 465 468 -0.311075 465 469 23.423199 465 470 39.594554 465 513 -0.002875 465 1569 -0.000886 465 1570 3.338117 465 1571 5.642754 466 419 -20.382310 466 466 -109.434080 466 467 114.747480 466 470 -6.414040 466 1571 -0.914080 467 417 -0.000028 467 418 -4.756032 467 419 -8.039597 467 462 -0.000030 467 463 -4.774392 467 464 -8.070633 467 465 0.001471 467 466 20.524231 467 467 34.694155 467 468 -0.000030 467 469 -4.773109 467 470 -8.068458 467 513 -0.000030 467 514 -4.746594 467 515 -8.023642 467 1569 -0.000009 467 1570 -1.461849 467 1571 -2.471110 468 420 -0.367998 468 421 65.074723 468 422 110.002230 468 465 -0.002838 468 468 575.142680 468 469 -426.832260 468 470 -721.516840 468 471 -0.366704 468 472 23.835402 468 473 40.291363 468 516 -0.002822 468 1572 -0.000870 468 1573 2.352503 468 1574 3.976670 469 422 -17.820172 469 469 -109.431520 469 470 112.021640 469 473 -6.526994 469 1574 -0.644195 470 420 -0.000028 470 421 -4.706510 470 422 -7.955879 470 465 -0.000030 470 466 -4.773109 470 467 -8.068458 470 468 0.001468 470 469 20.326504 470 470 34.359905 470 471 -0.000028 470 472 -4.625558 470 473 -7.819042 470 516 -0.000029 470 517 -4.746523 470 518 -8.023518 470 1572 -0.000009 470 1573 -1.462551 470 1574 -2.472294 471 423 -0.225901 471 424 53.596444 471 425 90.599428 471 468 -0.002696 471 471 540.768090 471 472 -406.134360 471 473 -686.529530 471 474 -0.435125 471 475 35.331745 471 476 59.724749 471 519 -0.002628 471 1575 -0.000906 471 1576 1.800159 471 1577 3.042988 472 425 -14.677058 472 472 -102.867650 472 473 106.642090 472 476 -9.675294 472 1577 -0.492950 473 423 -0.000026 473 424 -4.419515 473 425 -7.470749 473 468 -0.000028 473 469 -4.625558 473 470 -7.819042 473 471 0.001379 473 472 19.409339 473 473 32.809543 473 474 -0.000025 473 475 -4.288222 473 476 -7.248807 473 519 -0.000027 473 520 -4.510282 473 521 -7.624180 473 1575 -0.000009 473 1576 -1.554243 473 1577 -2.627293 474 426 -0.051082 474 427 29.290310 474 428 49.512306 474 471 -0.002419 474 474 494.424700 474 475 -319.051060 474 476 -539.323610 474 1578 -0.000959 474 1579 1.337859 474 1580 2.261516 475 428 -8.021037 475 475 -94.106391 475 476 83.202806 475 1580 -0.366362 476 426 -0.000023 476 427 -3.991607 476 428 -6.747407 476 471 -0.000025 476 472 -4.288222 476 473 -7.248807 476 474 0.001214 476 475 9.990103 476 476 16.887259 476 1578 -0.000010 476 1579 -1.699738 476 1580 -2.873235 477 477 1.000000 478 478 1.000000 479 479 1.000000 480 480 1.000000 481 481 1.000000 482 482 1.000000 483 483 1.000000 484 484 1.000000 485 485 1.000000 486 486 1.000000 487 487 1.000000 488 488 1.000000 489 489 1.000000 490 490 1.000000 491 491 1.000000 492 444 -0.001907 492 445 22.310249 492 446 37.713218 492 492 356.249580 492 493 -231.453830 492 494 -391.249300 492 495 -0.001868 492 540 -0.004887 492 1596 -0.001403 492 1597 1.059790 492 1598 1.791468 493 446 -6.109375 493 493 -67.884610 493 494 60.276811 493 1598 -0.290205 494 444 -0.000020 494 445 -3.206808 494 446 -5.420784 494 492 0.000905 494 493 11.464227 494 494 19.379115 494 495 -0.000019 494 496 -3.140288 494 497 -5.308339 494 540 -0.000017 494 541 -2.750727 494 542 -4.649826 494 1596 -0.000015 494 1597 -2.358791 494 1598 -3.987297 495 447 -0.002132 495 448 32.643080 495 449 55.179862 495 492 -0.120564 495 493 9.409640 495 494 15.906044 495 495 402.409670 495 496 -278.459320 495 497 -470.707630 495 498 -0.002094 495 543 -0.001852 495 1599 -0.001258 495 1600 1.515665 495 1601 2.562080 496 449 -8.938871 496 494 -2.576667 496 496 -76.645502 496 497 72.743432 496 1601 -0.415036 497 447 -0.000022 497 448 -3.543110 497 449 -5.989273 497 492 -0.000019 497 493 -3.140288 497 494 -5.308339 497 495 0.001037 497 496 15.340356 497 497 25.931334 497 498 -0.000022 497 499 -3.480093 497 500 -5.882749 497 543 -0.000019 497 544 -3.078045 497 545 -5.203128 497 1599 -0.000013 497 1600 -2.090224 497 1601 -3.533314 498 450 -0.146500 498 451 47.247510 498 452 79.867150 498 495 -0.298212 498 496 21.802822 498 497 36.855490 498 498 437.055990 498 499 -326.928450 498 500 -552.639430 498 501 -0.002374 498 546 -0.002104 498 1602 -0.001187 498 1603 2.784652 498 1604 4.707173 499 452 -12.938001 499 497 -5.970284 499 499 -83.216692 499 500 85.709818 499 1604 -0.762515 500 450 -0.000024 500 451 -3.870643 500 452 -6.542931 500 495 -0.000022 500 496 -3.480093 500 497 -5.882749 500 498 0.001126 500 499 16.556385 500 500 27.986897 500 501 -0.000025 500 502 -3.853724 500 503 -6.514330 500 546 -0.000022 500 547 -3.415351 500 548 -5.773305 500 1602 -0.000012 500 1603 -1.927240 500 1604 -3.257804 501 453 -0.323361 501 454 69.551885 501 455 117.570510 501 498 -0.416408 501 499 35.863226 501 500 60.623151 501 501 494.934260 501 502 -399.201730 501 503 -674.810610 501 504 -0.002761 501 549 -0.002446 501 1605 -0.001082 501 1606 5.196654 501 1607 8.784423 502 455 -19.045476 502 500 -9.820310 502 502 -94.176106 502 503 104.971530 502 1607 -1.422962 503 453 -0.000027 503 454 -4.267851 503 455 -7.214375 503 498 -0.000025 503 499 -3.853724 503 500 -6.514330 503 501 0.001273 503 502 18.002224 503 503 30.430955 503 504 -0.000029 503 505 -4.333073 503 506 -7.324626 503 549 -0.000026 503 550 -3.838932 503 551 -6.489330 503 1605 -0.000011 503 1606 -1.698078 503 1607 -2.870432 504 456 -0.585961 504 457 100.390860 504 458 169.700600 504 501 -0.560884 504 502 47.350486 504 503 80.041261 504 504 552.652800 504 505 -478.995230 504 506 -809.692940 504 507 -0.003098 504 552 -0.002891 504 1608 -0.026456 504 1609 9.027047 504 1610 15.259307 505 458 -27.489782 505 503 -12.965548 505 505 -105.138580 505 506 126.283570 505 1610 -2.471763 506 456 -0.000030 506 457 -4.644802 506 458 -7.851568 506 501 -0.000029 506 502 -4.333073 506 503 -7.324626 506 504 0.001422 506 505 19.561832 506 506 33.067302 506 507 -0.000032 506 508 -4.679025 506 509 -7.909418 506 552 -0.000030 506 553 -4.367382 506 554 -7.382617 506 1608 -0.000010 506 1609 -1.525749 506 1610 -2.579124 507 459 -0.859684 507 460 125.415760 507 461 212.002800 507 504 -0.438609 507 505 37.782580 507 506 63.867626 507 507 576.103930 507 508 -540.566210 507 509 -913.773110 507 510 -0.248034 507 511 28.689754 507 512 48.497120 507 555 -0.003235 507 1611 -0.067715 507 1612 13.074018 507 1613 22.100320 508 461 -34.342032 508 506 -10.345390 508 508 -109.529350 508 509 142.911690 508 512 -7.855611 508 1613 -3.579853 509 459 -0.000031 509 460 -4.748494 509 461 -8.026854 509 504 -0.000032 509 505 -4.679025 509 506 -7.909418 509 507 0.001484 509 508 20.434084 509 509 34.541762 509 510 -0.000033 509 511 -4.776600 509 512 -8.074358 509 555 -0.000034 509 556 -4.756352 509 557 -8.040138 509 1611 -0.000010 509 1612 -1.461315 509 1613 -2.470208 510 462 -0.712202 510 463 106.312150 510 464 179.709950 510 507 -0.003185 510 510 575.508870 510 511 -494.093410 510 512 -835.214800 510 513 -0.412417 510 514 42.569293 510 515 71.959131 510 558 -0.003169 510 1614 -0.031451 510 1615 9.523716 510 1616 16.098875 511 464 -29.111112 511 511 -109.513980 511 512 130.227040 511 515 -11.656244 511 1616 -2.607751 512 462 -0.000031 512 463 -4.745694 512 464 -8.022116 512 507 -0.000033 512 508 -4.776600 512 509 -8.074358 512 510 0.001483 512 511 20.528275 512 512 34.700975 512 513 -0.000032 512 514 -4.775995 512 515 -8.073342 512 558 -0.000033 512 559 -4.752496 512 560 -8.033613 512 1614 -0.000010 512 1615 -1.465199 512 1616 -2.476771 513 465 -0.569316 513 466 85.410030 513 467 144.377110 513 510 -0.003088 513 513 575.190690 513 514 -462.341610 513 515 -781.542260 513 516 -0.432905 513 517 35.396470 513 518 59.834150 513 561 -0.003071 513 1617 -0.000949 513 1618 5.839888 513 1619 9.871747 514 467 -23.387800 514 514 -109.495420 514 515 121.581330 514 518 -9.692364 514 1619 -1.599082 515 465 -0.000030 515 466 -4.746594 515 467 -8.023642 515 510 -0.000032 515 511 -4.775995 515 512 -8.073342 515 513 0.001480 515 514 20.527064 515 515 34.698943 515 516 -0.000031 515 517 -4.774870 515 518 -8.071435 515 561 -0.000032 515 562 -4.749453 515 563 -8.028476 515 1617 -0.000010 515 1618 -1.467869 515 1619 -2.481286 516 468 -0.448327 516 469 73.511831 516 470 124.264330 516 513 -0.003007 516 516 575.031490 516 517 -434.504680 516 518 -734.486180 516 519 -0.320382 516 520 21.665194 516 521 36.622843 516 564 -0.002991 516 1620 -0.000925 516 1621 3.618782 516 1622 6.117184 517 470 -20.129948 517 517 -109.488270 517 518 113.979230 517 521 -5.932490 517 1622 -0.990911 518 468 -0.000029 518 469 -4.746523 518 470 -8.023518 518 513 -0.000031 518 514 -4.774870 518 515 -8.071435 518 516 0.001476 518 517 20.429436 518 518 34.533900 518 519 -0.000030 518 520 -4.676981 518 521 -7.905968 518 564 -0.000031 518 565 -4.750618 518 566 -8.030439 518 1620 -0.000010 518 1621 -1.468165 518 1622 -2.481784 519 471 -0.474622 519 472 72.197736 519 473 122.043050 519 516 -0.002896 519 519 551.862820 519 520 -397.097000 519 521 -671.252780 519 567 -0.002853 519 1623 -0.000947 519 1624 2.694064 519 1625 4.554046 520 473 -19.770349 520 520 -96.452757 520 521 118.568970 520 1625 -0.737707 521 471 -0.000027 521 472 -4.510282 521 473 -7.624180 521 516 -0.000030 521 517 -4.676981 521 518 -7.905968 521 519 0.001387 521 520 15.336972 521 521 25.925617 521 567 -0.000030 521 568 -4.608696 521 569 -7.790540 521 1623 -0.000010 521 1624 -1.529225 521 1625 -2.585002 522 522 1.000000 523 523 1.000000 524 524 1.000000 525 525 1.000000 526 526 1.000000 527 527 1.000000 528 528 1.000000 529 529 1.000000 530 530 1.000000 531 531 1.000000 532 532 1.000000 533 533 1.000000 534 534 1.000000 535 535 1.000000 536 536 1.000000 537 537 1.000000 538 538 1.000000 539 539 1.000000 540 492 -0.001676 540 493 17.558430 540 494 29.680750 540 540 310.311670 540 541 -199.818900 540 542 -337.773660 540 543 -0.001654 540 588 -0.001478 540 1644 -0.001644 540 1645 1.028863 540 1646 1.739189 541 494 -4.808072 541 541 -59.147403 541 542 51.959485 541 1646 -0.281732 542 492 -0.000017 542 493 -2.750727 542 494 -4.649826 542 540 0.000793 542 541 10.598055 542 542 17.914941 542 543 -0.000017 542 544 -2.715436 542 545 -4.590171 542 588 -0.000015 542 589 -2.425963 542 590 -4.100845 542 1644 -0.000017 542 1645 -2.699288 542 1646 -4.562874 543 495 -0.058779 543 496 25.787942 543 497 43.591937 543 540 -0.157654 543 541 13.552430 543 542 22.909013 543 543 344.968990 543 544 -242.550890 543 545 -410.008020 543 546 -0.001889 543 591 -0.001683 543 1647 -0.001509 543 1648 1.811281 543 1649 3.061789 544 497 -7.061532 544 542 -3.711043 544 544 -65.723061 544 545 63.344299 544 1649 -0.495976 545 495 -0.000019 545 496 -3.078045 545 497 -5.203128 545 540 -0.000017 545 541 -2.715436 545 542 -4.590171 545 543 0.000896 545 544 13.987573 545 545 23.644591 545 546 -0.000020 545 547 -3.043823 545 548 -5.145278 545 591 -0.000018 545 592 -2.711463 545 593 -4.583457 545 1647 -0.000016 545 1648 -2.431426 545 1649 -4.110083 546 498 -0.153820 546 499 40.410594 546 500 68.310016 546 543 -0.339727 546 544 29.580329 546 545 50.002588 546 546 391.257370 546 547 -302.268870 546 548 -510.954950 546 549 -0.002203 546 594 -0.001954 546 1650 -0.001382 546 1651 4.066569 546 1652 6.874122 547 500 -11.065501 547 545 -8.099846 547 547 -74.494601 547 548 79.264038 547 1652 -1.113509 548 498 -0.000022 548 499 -3.415351 548 500 -5.773305 548 543 -0.000020 548 544 -3.043823 548 545 -5.145278 548 546 0.001013 548 547 15.085272 548 548 25.500128 548 549 -0.000023 548 550 -3.427032 548 551 -5.793050 548 594 -0.000020 548 595 -3.040504 548 596 -5.139664 548 1650 -0.000014 548 1651 -2.150194 548 1652 -3.634685 549 501 -0.496300 549 502 68.230276 549 503 115.336460 549 546 -0.658889 549 547 52.248365 549 548 88.320577 549 549 437.480580 549 550 -385.403360 549 551 -651.485830 549 552 -0.002640 549 597 -0.002385 549 1653 -0.033804 549 1654 9.723325 549 1655 16.436308 550 503 -18.682869 550 548 -14.306604 550 550 -83.267654 550 551 101.589140 550 1655 -2.662369 551 501 -0.000026 551 502 -3.838932 551 503 -6.489330 551 546 -0.000023 551 547 -3.427032 551 548 -5.793050 551 549 0.001136 551 550 16.619424 551 551 28.093470 551 552 -0.000028 551 553 -3.895894 551 554 -6.585619 551 597 -0.000025 551 598 -3.520970 551 599 -5.951847 551 1653 -0.000013 551 1654 -1.927240 551 1655 -3.257807 552 504 -0.938093 552 505 124.629870 552 506 210.674180 552 549 -0.837358 552 550 84.500754 552 551 142.840070 552 552 507.531190 552 553 -525.361380 552 554 -888.070320 552 555 -0.003250 552 600 -0.002941 552 1656 -0.147248 552 1657 20.895887 552 1658 35.322382 553 506 -34.125373 553 551 -23.137098 553 553 -96.452559 553 554 139.189230 553 1658 -5.721368 554 504 -0.000030 554 505 -4.367382 554 506 -7.382617 554 549 -0.000028 554 550 -3.895894 554 551 -6.585619 554 552 0.001317 554 553 18.456140 554 554 31.198243 554 555 -0.000034 554 556 -4.472219 554 557 -7.559835 554 600 -0.000031 554 601 -4.047197 554 602 -6.841377 554 1656 -0.000012 554 1657 -1.662597 554 1658 -2.810452 555 507 -1.865817 555 508 210.807250 555 509 356.348580 555 552 -1.212934 555 553 106.698780 555 554 180.363510 555 555 578.495670 555 556 -794.504070 555 557 -1343.029600 555 558 -1.107990 555 559 104.125460 555 560 176.013540 555 603 -0.003643 555 1659 -0.311618 555 1660 37.096615 555 1661 62.708117 556 509 -57.720843 556 554 -29.213649 556 556 -109.636470 556 557 212.154200 556 560 -28.508945 556 1661 -10.156920 557 507 -0.000034 557 508 -4.756352 557 509 -8.040138 557 552 -0.000034 557 553 -4.472219 557 554 -7.559835 557 555 0.001497 557 556 20.151920 557 557 34.064795 557 558 -0.000036 557 559 -4.778585 557 560 -8.077714 557 603 -0.000038 557 604 -4.667354 557 605 -7.889694 557 1659 -0.000011 557 1660 -1.465065 557 1661 -2.476546 558 510 -1.009273 558 511 135.622740 558 512 229.256500 558 555 -0.003495 558 558 576.448190 558 559 -579.757610 558 560 -980.021550 558 561 -0.925034 558 562 88.420532 558 563 149.466060 558 606 -0.003484 558 1662 -0.138558 558 1663 20.050906 558 1664 33.894031 559 512 -37.135191 559 559 -109.600890 559 560 153.457880 559 563 -24.210075 559 1664 -5.489996 560 510 -0.000033 560 511 -4.752496 560 512 -8.033613 560 555 -0.000036 560 556 -4.778585 560 557 -8.077714 560 558 0.001495 560 559 20.548189 560 560 34.734637 560 561 -0.000034 560 562 -4.777680 560 563 -8.076190 560 606 -0.000036 560 607 -4.764557 560 608 -8.054001 560 1662 -0.000011 560 1663 -1.462541 560 1664 -2.472278 561 513 -0.499113 561 514 89.964943 561 515 152.076740 561 558 -0.003294 561 561 575.588620 561 562 -491.699180 561 563 -831.168280 561 564 -0.644451 561 565 56.210454 561 566 95.018084 561 609 -0.003284 561 1665 -0.034525 561 1666 9.810796 561 1667 16.584170 562 515 -24.634033 562 562 -109.569110 562 563 129.432720 562 566 -15.391186 562 1667 -2.686297 563 513 -0.000032 563 514 -4.749453 563 515 -8.028476 563 558 -0.000034 563 559 -4.777680 563 560 -8.076190 563 561 0.001488 563 562 20.541572 563 563 34.723467 563 564 -0.000033 563 565 -4.776347 563 566 -8.073932 563 609 -0.000034 563 610 -4.764002 563 611 -8.053068 563 1665 -0.000010 563 1666 -1.461775 563 1667 -2.470984 564 516 -0.288863 564 517 69.290058 564 518 117.127830 564 561 -0.003165 564 564 575.169750 564 565 -440.688990 564 566 -744.940170 564 567 -0.408672 564 568 30.525309 564 569 51.599982 564 612 -0.003158 564 1668 -0.000968 564 1669 5.218038 564 1670 8.820564 565 518 -18.973202 565 565 -109.553980 565 566 115.507080 565 569 -8.358371 565 1670 -1.428781 566 516 -0.000031 566 517 -4.750618 566 518 -8.030439 566 561 -0.000033 566 562 -4.776347 566 563 -8.073932 566 564 0.001483 566 565 20.495125 566 566 34.644941 566 567 -0.000032 566 568 -4.727536 566 569 -7.991427 566 612 -0.000033 566 613 -4.767156 566 614 -8.058394 566 1668 -0.000010 566 1669 -1.461161 566 1670 -2.469944 567 519 -0.197502 567 520 58.806825 567 521 99.407057 567 564 -0.003063 567 567 563.321930 567 568 -391.261510 567 569 -661.388460 567 615 -0.003057 567 1671 -0.000966 567 1672 3.531435 567 1673 5.969537 568 521 -16.102830 568 568 -107.360000 568 569 102.085340 568 1673 -0.966975 569 519 -0.000030 569 520 -4.608696 569 521 -7.790540 569 564 -0.000032 569 565 -4.727536 569 566 -7.991427 569 567 0.001421 569 568 15.556430 569 569 26.296589 569 615 -0.000032 569 616 -4.718009 569 617 -7.975322 569 1671 -0.000010 569 1672 -1.490128 569 1673 -2.518913 570 570 1.000000 571 571 1.000000 572 572 1.000000 573 573 1.000000 574 574 1.000000 575 575 1.000000 576 576 1.000000 577 577 1.000000 578 578 1.000000 579 579 1.000000 580 580 1.000000 581 581 1.000000 582 582 1.000000 583 583 1.000000 584 584 1.000000 585 585 229.786090 585 586 -137.744190 585 587 -232.842780 585 588 -0.001273 585 633 -0.067886 585 634 2.887011 585 635 4.880203 585 1689 -0.002224 585 1690 0.538526 585 1691 0.910325 586 586 -43.816660 586 587 35.667017 586 635 -0.790548 586 1691 -0.147464 587 585 0.000586 587 586 7.642448 587 587 12.918794 587 588 -0.000013 587 589 -2.084537 587 590 -3.523702 587 633 -0.000012 587 634 -1.910469 587 635 -3.229456 587 1689 -0.000023 587 1690 -3.642522 587 1691 -6.157318 588 540 -0.009114 588 541 8.196763 588 542 13.855800 588 585 -0.035185 588 586 5.845952 588 587 9.881998 588 588 275.853340 588 589 -176.079070 588 590 -297.643870 588 591 -0.001498 588 636 -0.063957 588 1692 -0.001874 588 1693 0.874103 588 1694 1.477584 589 542 -2.244508 589 587 -1.600787 589 589 -52.585057 589 590 45.741228 589 1694 -0.239353 590 540 -0.000015 590 541 -2.425963 590 542 -4.100845 590 585 -0.000013 590 586 -2.084537 590 587 -3.523702 590 588 0.000722 590 589 12.065069 590 590 20.394783 590 591 -0.000016 590 592 -2.428302 590 593 -4.104799 590 636 -0.000013 590 637 -2.083366 590 638 -3.521720 590 1692 -0.000020 590 1693 -3.036994 590 1694 -5.133732 591 543 -0.044240 591 544 15.120848 591 545 25.560282 591 588 -0.171453 591 589 17.455773 591 590 29.507220 591 591 310.471090 591 592 -215.746540 591 593 -364.697950 591 594 -0.001720 591 639 -0.066318 591 1695 -0.001711 591 1696 1.886361 591 1697 3.188705 592 545 -4.140472 592 590 -4.779852 592 592 -59.166043 592 593 56.273456 592 1697 -0.516528 593 543 -0.000018 593 544 -2.711463 593 545 -4.583457 593 588 -0.000016 593 589 -2.428302 593 590 -4.104799 593 591 0.000811 593 592 12.989807 593 593 21.957967 593 594 -0.000018 593 595 -2.715978 593 596 -4.591089 593 639 -0.000016 593 640 -2.425874 593 641 -4.100698 593 1695 -0.000018 593 1696 -2.701541 593 1697 -4.566685 594 546 -0.107945 594 547 25.803312 594 548 43.617890 594 591 -0.355167 594 592 34.295519 594 593 57.973145 594 594 345.232090 594 595 -266.749480 594 596 -450.913030 594 597 -0.002070 594 642 -0.068363 594 1698 -0.001609 594 1699 5.216788 594 1700 8.818452 595 548 -7.065442 595 593 -9.390862 595 595 -65.753455 595 596 69.892338 595 1700 -1.428435 596 546 -0.000020 596 547 -3.040504 596 548 -5.139664 596 591 -0.000018 596 592 -2.715978 596 593 -4.591089 596 594 0.000902 596 595 14.087562 596 596 23.813602 596 597 -0.000022 596 598 -3.127775 596 599 -5.287188 596 642 -0.000019 596 643 -2.764945 596 644 -4.673860 596 1698 -0.000017 596 1699 -2.430966 596 1700 -4.109303 597 549 -0.250918 597 550 50.320737 597 551 85.062173 597 594 -0.713002 597 595 65.837486 597 596 111.291620 597 597 414.870000 597 598 -380.853550 597 599 -643.794840 597 600 -0.002601 597 645 -0.222839 597 646 8.474940 597 647 14.326038 597 1701 -0.082985 597 1702 14.531280 597 1703 24.563675 598 551 -13.778289 598 596 -18.027209 598 598 -78.927659 598 599 100.442290 598 647 -2.320455 598 1703 -3.978735 599 549 -0.000025 599 550 -3.520970 599 551 -5.951847 599 594 -0.000022 599 595 -3.127775 599 596 -5.287188 599 597 0.001080 599 598 15.582531 599 599 26.340706 599 600 -0.000027 599 601 -3.664737 599 602 -6.194871 599 645 -0.000024 599 646 -3.233439 599 647 -5.465805 599 1701 -0.000015 599 1702 -2.026727 599 1703 -3.425978 600 552 -1.063721 600 553 128.569370 600 554 217.333520 600 597 -1.489375 600 598 143.520640 600 599 242.607280 600 600 474.731490 600 601 -658.028090 600 602 -1112.330000 600 603 -0.003377 600 648 -0.844516 600 649 67.680332 600 650 114.406750 600 1704 -0.371759 600 1705 42.979748 600 1706 72.652915 601 554 -35.201717 601 599 -39.295989 601 601 -89.945654 601 602 175.644280 601 650 -18.529986 601 1706 -11.767451 602 552 -0.000031 602 553 -4.047197 602 554 -6.841377 602 597 -0.000027 602 598 -3.664737 602 599 -6.194871 602 600 0.001238 602 601 17.444635 602 602 29.488395 602 603 -0.000035 602 604 -4.229546 602 605 -7.149619 602 648 -0.000029 602 649 -3.712836 602 650 -6.276174 602 1704 -0.000014 602 1705 -1.780177 602 1706 -3.009209 603 555 -4.374731 603 556 464.899400 603 557 785.865920 603 600 -3.999187 603 601 387.814680 603 602 655.561520 603 603 569.079730 603 604 -2104.427400 603 605 -3557.323700 603 606 -4.313237 603 607 425.140240 603 608 718.656680 603 651 -4.005310 603 652 376.374790 603 653 636.223930 603 1707 -1.268047 603 1708 131.315640 603 1709 221.975960 604 557 -127.280260 604 602 -106.174040 604 604 -105.456400 604 605 570.353420 604 608 -116.392560 604 653 -103.040430 604 1709 -35.950514 605 555 -0.000038 605 556 -4.667354 605 557 -7.889694 605 600 -0.000035 605 601 -4.229546 605 602 -7.149619 605 603 0.001579 605 604 31.506343 605 605 53.258311 605 606 -0.000039 605 607 -4.684476 605 608 -7.918634 605 651 -0.000038 605 652 -4.434885 605 653 -7.496729 605 1707 -0.000013 605 1708 -1.520875 605 1709 -2.570887 606 558 -1.183074 606 559 145.975050 606 560 246.756050 606 603 -0.003752 606 606 578.381960 606 607 -754.675520 606 608 -1275.702800 606 609 -1.639264 606 610 161.062080 606 611 272.259340 606 654 -0.971628 606 655 74.628540 606 656 126.152010 606 1710 -0.313619 606 1711 37.277203 606 1712 63.013350 607 560 -39.967119 607 607 -109.684780 607 608 201.126190 607 611 -44.098175 607 656 -20.432140 607 1712 -10.206158 608 558 -0.000036 608 559 -4.764557 608 560 -8.054001 608 603 -0.000039 608 604 -4.684476 608 605 -7.918634 608 606 0.001505 608 607 20.472160 608 608 34.606123 608 609 -0.000036 608 610 -4.779495 608 611 -8.079258 608 654 -0.000038 608 655 -4.771501 608 656 -8.065741 608 1710 -0.000011 608 1711 -1.459765 608 1712 -2.467585 609 561 -0.471061 609 562 73.575168 609 563 124.371460 609 606 -0.003462 609 609 575.776600 609 610 -498.270230 609 611 -842.275980 609 612 -0.813377 609 613 75.140097 609 614 127.016720 609 657 -0.159873 609 1713 -0.075291 609 1714 13.815885 609 1715 23.354372 610 563 -20.145325 610 610 -109.623250 610 611 131.093260 610 614 -20.573825 610 1715 -3.782819 611 561 -0.000034 611 562 -4.764002 611 563 -8.053068 611 606 -0.000036 611 607 -4.779495 611 608 -8.079258 611 609 0.001496 611 610 20.564645 611 611 34.762469 611 612 -0.000034 611 613 -4.778098 611 614 -8.076891 611 657 -0.000036 611 658 -4.770393 611 659 -8.063872 611 1713 -0.000011 611 1714 -1.460318 611 1715 -2.468522 612 564 -0.302914 612 565 54.752635 612 566 92.553790 612 609 -0.003291 612 612 575.196000 612 613 -444.684610 612 614 -751.694290 612 615 -0.557331 612 616 47.641436 612 617 80.533082 612 660 -0.003286 612 1716 -0.001237 612 1717 6.523691 612 1718 11.027642 613 566 -14.992013 613 613 -109.598750 613 614 116.487500 613 617 -13.044827 613 1718 -1.786246 614 564 -0.000033 614 565 -4.767156 614 566 -8.058394 614 609 -0.000034 614 610 -4.778098 614 611 -8.076891 614 612 0.001489 614 613 20.565455 614 614 34.763825 614 615 -0.000033 614 616 -4.777470 614 617 -8.075835 614 660 -0.000034 614 661 -4.771325 614 662 -8.065441 614 1716 -0.000010 614 1717 -1.459079 614 1718 -2.466425 615 567 -0.157166 615 568 37.600113 615 569 63.559232 615 612 -0.003181 615 615 574.753180 615 616 -377.321360 615 617 -637.824030 615 1719 -0.000972 615 1720 4.089250 615 1721 6.912468 616 569 -10.295578 616 616 -109.586940 616 617 98.074874 616 1721 -1.119695 617 567 -0.000032 617 568 -4.718009 617 569 -7.975322 617 612 -0.000033 617 613 -4.777470 617 614 -8.075835 617 615 0.001419 617 616 10.968069 617 617 18.540423 617 1719 -0.000010 617 1720 -1.460268 617 1721 -2.468436 618 618 1.000000 619 619 1.000000 620 620 1.000000 621 621 1.000000 622 622 1.000000 623 623 1.000000 624 624 1.000000 625 625 1.000000 626 626 1.000000 627 627 1.000000 628 628 1.000000 629 629 1.000000 630 630 1.000000 631 631 1.000000 632 632 1.000000 633 585 -0.001160 633 633 229.858440 633 634 -143.349450 633 635 -242.317910 633 636 -0.001160 633 681 -0.115957 633 682 8.538711 633 683 14.433837 633 1737 -0.002212 633 1738 0.478337 633 1739 0.808582 634 634 -43.819004 634 635 37.196344 634 683 -2.338173 634 1739 -0.130983 635 585 -0.000012 635 586 -1.910469 635 587 -3.229456 635 633 0.000597 635 634 9.380071 635 635 15.856072 635 636 -0.000012 635 637 -1.910369 635 638 -3.229288 635 681 -0.000012 635 682 -1.910672 635 683 -3.229801 635 1737 -0.000023 635 1738 -3.643639 635 1739 -6.159207 636 588 -0.001286 636 589 0.352535 636 590 0.595925 636 633 -0.041488 636 634 8.567365 636 635 14.482274 636 636 229.957800 636 637 -149.446240 636 638 -252.623760 636 639 -0.001287 636 684 -0.103998 636 685 5.520810 636 686 9.332371 636 1740 -0.002249 636 1741 0.712025 636 1742 1.203607 637 590 -0.096533 637 635 -2.345995 637 637 -43.826616 637 638 38.846729 637 686 -1.511753 637 1742 -0.194971 638 588 -0.000013 638 589 -2.083366 638 590 -3.521720 638 633 -0.000012 638 634 -1.910369 638 635 -3.229288 638 636 0.000612 638 637 11.637723 638 638 19.672395 638 639 -0.000013 638 640 -2.084829 638 641 -3.524192 638 684 -0.000012 638 685 -1.910476 638 686 -3.229466 638 1740 -0.000023 638 1741 -3.643757 638 1742 -6.159404 639 591 -0.001544 639 592 3.407793 639 593 5.760534 639 636 -0.154229 639 637 17.561895 639 638 29.686608 639 639 276.052010 639 640 -188.741840 639 641 -319.049200 639 642 -0.001572 639 687 -0.109591 639 688 5.137241 639 689 8.683993 639 1743 -0.001932 639 1744 1.472318 639 1745 2.488807 640 593 -0.933128 640 638 -4.808908 640 640 -52.601941 640 641 49.165927 640 689 -1.406692 640 1745 -0.403152 641 591 -0.000016 641 592 -2.425874 641 593 -4.100698 641 636 -0.000013 641 637 -2.084829 641 638 -3.524192 641 639 0.000725 641 640 12.107669 641 641 20.466800 641 642 -0.000016 641 643 -2.470191 641 644 -4.175611 641 687 -0.000014 641 688 -2.084177 641 689 -3.523093 641 1743 -0.000020 641 1744 -3.036682 641 1745 -5.133207 642 594 -0.001837 642 595 3.105706 642 596 5.249882 642 639 -0.329517 642 640 30.495022 642 641 51.548785 642 642 322.147570 642 643 -234.004020 642 644 -395.560150 642 645 -0.001897 642 690 -0.180090 642 691 8.611515 642 692 14.556894 642 1746 -0.001731 642 1747 3.764654 642 1748 6.363767 643 596 -0.850385 643 641 -8.350176 643 643 -61.379794 643 644 61.111547 643 692 -2.357963 643 1748 -1.030815 644 594 -0.000019 644 595 -2.764945 644 596 -4.673860 644 639 -0.000016 644 640 -2.470191 644 641 -4.175611 644 642 0.000843 644 643 13.221950 644 644 22.350372 644 645 -0.000020 644 646 -2.854706 644 647 -4.825592 644 690 -0.000017 644 691 -2.520604 644 692 -4.260825 644 1746 -0.000018 644 1747 -2.604598 644 1748 -4.402811 645 597 -0.002276 645 642 -0.524652 645 643 49.398648 645 644 83.503422 645 645 368.474700 645 646 -296.696620 645 647 -501.535950 645 648 -0.002309 645 693 -0.350030 645 694 22.515897 645 695 38.060872 645 1749 -0.035777 645 1750 9.867783 645 1751 16.680500 646 644 -13.525992 646 646 -70.166544 646 647 77.805696 646 695 -6.165006 646 1751 -2.701845 647 597 -0.000024 647 598 -3.233439 647 599 -5.465805 647 642 -0.000020 647 643 -2.854706 647 644 -4.825592 647 645 0.000965 647 646 14.612125 647 647 24.700333 647 648 -0.000024 647 649 -3.280569 647 650 -5.545473 647 693 -0.000021 647 694 -2.955463 647 695 -4.995914 647 1749 -0.000017 647 1750 -2.280049 647 1751 -3.854194 648 600 -0.002812 648 645 -0.813184 648 646 77.270965 648 647 130.618840 648 648 426.710000 648 649 -408.814650 648 650 -691.059760 648 651 -0.002940 648 696 -0.750957 648 697 60.063016 648 698 101.530450 648 1752 -0.169267 648 1753 23.028724 648 1754 38.927728 649 647 -21.156940 649 649 -81.159344 649 650 107.888680 649 698 -16.445125 649 1754 -6.305133 650 600 -0.000029 650 601 -3.712836 650 602 -6.276174 650 645 -0.000024 650 646 -3.280569 650 647 -5.545473 650 648 0.001120 650 649 16.340623 650 650 27.622172 650 651 -0.000031 650 652 -3.882456 650 653 -6.562898 650 696 -0.000026 650 697 -3.483214 650 698 -5.888021 650 1752 -0.000015 650 1753 -1.972400 650 1754 -3.334143 651 603 -0.003610 651 648 -1.047585 651 649 97.265790 651 650 164.417970 651 651 520.639200 651 652 -672.918820 651 653 -1137.501900 651 654 -1.001697 651 655 97.489376 651 656 164.795950 651 699 -1.570580 651 700 135.694950 651 701 229.378740 651 1755 -0.343756 651 1756 40.238110 651 1757 68.018501 652 650 -26.630093 652 652 -98.742650 652 653 179.224030 652 656 -26.691085 652 701 -37.152092 652 1757 -11.016657 653 603 -0.000038 653 604 -4.434885 653 605 -7.496729 653 648 -0.000031 653 649 -3.882456 653 650 -6.562898 653 651 0.001360 653 652 18.725128 653 653 31.652947 653 654 -0.000036 653 655 -4.528771 653 656 -7.655431 653 699 -0.000033 653 700 -4.245594 653 701 -7.176753 653 1755 -0.000013 653 1756 -1.622280 653 1757 -2.742302 654 606 -0.003652 654 651 -0.003466 654 654 576.049940 654 655 -501.668340 654 656 -848.019690 654 657 -0.826285 654 658 78.714003 654 659 133.058150 654 702 -0.873933 654 703 67.319482 654 704 113.796800 654 1758 -0.136747 654 1759 19.861190 654 1760 33.573335 655 655 -109.675590 655 656 131.888100 655 659 -21.551510 655 704 -18.431643 655 1760 -5.437859 656 606 -0.000038 656 607 -4.771501 656 608 -8.065741 656 651 -0.000036 656 652 -4.528771 656 653 -7.655431 656 654 0.001502 656 655 20.323078 656 656 34.354116 656 657 -0.000036 656 658 -4.779817 656 659 -8.079803 656 702 -0.000037 656 703 -4.771426 656 704 -8.065614 656 1758 -0.000011 656 1759 -1.459200 656 1760 -2.466631 657 609 -0.003473 657 610 7.581968 657 611 12.816558 657 654 -0.003479 657 657 575.094130 657 658 -408.305770 657 659 -690.200070 657 660 -0.438161 657 661 42.804789 657 662 72.357161 657 705 -0.286397 657 706 11.770645 657 707 19.897097 657 1761 -0.040113 657 1762 10.345366 657 1763 17.487807 658 611 -2.075913 658 658 -109.647650 658 659 106.400890 658 662 -11.719986 658 707 -3.222764 658 1763 -2.832558 659 609 -0.000036 659 610 -4.770393 659 611 -8.063872 659 654 -0.000036 659 655 -4.779817 659 656 -8.079803 659 657 0.001499 659 658 20.571294 659 659 34.773710 659 660 -0.000035 659 661 -4.779443 659 662 -8.079164 659 705 -0.000036 659 706 -4.770802 659 707 -8.064564 659 1761 -0.000011 659 1762 -1.458490 659 1763 -2.465431 660 612 -0.221669 660 613 39.882149 660 614 67.416734 660 657 -0.003383 660 660 574.564930 660 661 -382.063040 660 662 -645.838900 660 708 -0.092242 660 1764 -0.001033 660 1765 6.392436 660 1766 10.805765 661 614 -10.919981 661 661 -109.631210 661 662 99.258914 661 1766 -1.750272 662 612 -0.000034 662 613 -4.771325 662 614 -8.065441 662 657 -0.000035 662 658 -4.779443 662 659 -8.079164 662 660 0.001460 662 661 15.793919 662 662 26.698019 662 708 -0.000035 662 709 -4.771853 662 710 -8.066334 662 1764 -0.000011 662 1765 -1.458956 662 1766 -2.466217 663 663 1.000000 664 664 1.000000 665 665 1.000000 666 666 1.000000 667 667 1.000000 668 668 1.000000 669 669 1.000000 670 670 1.000000 671 671 1.000000 672 672 1.000000 673 673 1.000000 674 674 1.000000 675 675 1.000000 676 676 1.000000 677 677 1.000000 678 678 241.281140 678 679 -147.772670 678 680 -249.794760 678 681 -0.001146 678 726 -0.050525 678 727 6.265440 678 728 10.591093 678 1782 -0.002034 678 1783 0.446232 678 1784 0.754311 679 679 -46.000009 679 680 38.330186 679 728 -1.715709 679 1784 -0.122194 680 678 0.000611 680 679 7.570991 680 680 12.797995 680 681 -0.000012 680 682 -1.955535 680 683 -3.305634 680 726 -0.000013 680 727 -2.140058 680 728 -3.617552 680 1782 -0.000021 680 1783 -3.470235 680 1784 -5.866081 681 633 -0.001140 681 678 -0.036745 681 679 9.268640 681 680 15.667699 681 681 229.920780 681 682 -152.015400 681 683 -256.966840 681 684 -0.001140 681 729 -0.109742 681 730 7.976835 681 731 13.484043 681 1785 -0.002176 681 1786 0.450344 681 1787 0.761261 682 680 -2.538079 682 682 -43.818310 682 683 39.571585 682 731 -2.184334 682 1787 -0.123319 683 633 -0.000012 683 634 -1.910672 683 635 -3.229801 683 678 -0.000012 683 679 -1.955535 683 680 -3.305634 683 681 0.000608 683 682 11.383840 683 683 19.243241 683 684 -0.000012 683 685 -1.909831 683 686 -3.228378 683 729 -0.000012 683 730 -1.957108 683 731 -3.308296 683 1785 -0.000023 683 1786 -3.645772 683 1787 -6.162813 684 636 -0.001166 684 681 -0.053412 684 682 11.580450 684 683 19.575592 684 684 229.988000 684 685 -154.312800 684 686 -260.850190 684 687 -0.001167 684 732 -0.109230 684 733 7.876621 684 734 13.314632 684 1788 -0.002224 684 1789 0.538798 684 1790 0.910784 685 683 -3.171098 685 685 -43.828808 685 686 40.174310 685 734 -2.156862 685 1790 -0.147538 686 636 -0.000012 686 637 -1.910476 686 638 -3.229466 686 681 -0.000012 686 682 -1.909831 686 683 -3.228378 686 684 0.000609 686 685 11.289908 686 686 19.084451 686 687 -0.000012 686 688 -1.911181 686 689 -3.230658 686 732 -0.000012 686 733 -1.910894 686 734 -3.230172 686 1788 -0.000023 686 1789 -3.642601 686 1790 -6.157449 687 639 -0.001314 687 684 -0.144933 687 685 16.910541 687 686 28.585561 687 687 230.077580 687 688 -161.204350 687 689 -272.499840 687 690 -0.001339 687 735 -0.130032 687 736 9.000899 687 737 15.215119 687 1791 -0.002298 687 1792 0.989684 687 1793 1.672961 688 686 -4.630583 688 688 -43.837882 688 689 42.037981 688 737 -2.464676 688 1793 -0.270998 689 639 -0.000014 689 640 -2.084177 689 641 -3.523093 689 684 -0.000012 689 685 -1.911181 689 686 -3.230658 689 687 0.000614 689 688 11.678161 689 689 19.740762 689 690 -0.000014 689 691 -2.123962 689 692 -3.590345 689 735 -0.000012 689 736 -1.911101 689 737 -3.230525 689 1791 -0.000024 689 1792 -3.642810 689 1793 -6.157807 690 642 -0.001656 690 687 -0.243281 690 688 24.198730 690 689 40.905532 690 690 287.652480 690 691 -207.586150 690 692 -350.903370 690 693 -0.001712 690 738 -0.238141 690 739 13.212071 690 740 22.333672 690 1794 -0.001918 690 1795 2.254502 690 1796 3.811007 691 689 -6.626157 691 691 -54.808161 691 692 54.184103 691 740 -3.617716 691 1796 -0.617318 692 642 -0.000017 692 643 -2.520604 692 644 -4.260825 692 687 -0.000014 692 688 -2.123962 692 689 -3.590345 692 690 0.000756 692 691 12.411776 692 692 20.980854 692 693 -0.000018 692 694 -2.606907 692 695 -4.406711 692 738 -0.000015 692 739 -2.234516 692 740 -3.777224 692 1794 -0.000020 692 1795 -2.919621 692 1796 -4.935323 693 645 -0.002029 693 690 -0.356629 693 691 34.155028 693 692 57.735619 693 693 345.307210 693 694 -263.854300 693 695 -446.019300 693 696 -0.002147 693 741 -0.347721 693 742 23.081303 693 743 39.016635 693 1797 -0.001670 693 1798 5.136960 693 1799 8.683518 694 692 -9.352165 694 694 -65.783412 694 695 69.023803 694 743 -6.319942 694 1799 -1.406542 695 645 -0.000021 695 646 -2.955463 695 647 -4.995914 695 690 -0.000018 695 691 -2.606907 695 692 -4.406711 695 693 0.000904 695 694 13.891176 695 695 23.481640 695 696 -0.000022 695 697 -3.128501 695 698 -5.288418 695 741 -0.000019 695 742 -2.760721 695 743 -4.666722 695 1797 -0.000017 695 1798 -2.432178 695 1799 -4.111354 696 648 -0.002501 696 693 -0.471510 696 694 43.574756 696 695 73.658766 696 696 414.536050 696 697 -336.478410 696 698 -568.782710 696 699 -0.002719 696 744 -0.554882 696 745 41.144406 696 746 69.550444 696 1800 -0.036361 696 1801 9.942274 696 1802 16.806408 697 695 -11.931066 697 697 -78.955712 697 698 88.222558 697 746 -11.265575 697 1802 -2.722204 698 648 -0.000026 698 649 -3.483214 698 650 -5.888021 698 693 -0.000022 698 694 -3.128501 698 695 -5.288418 698 696 0.001084 698 697 15.770532 698 698 26.658491 698 699 -0.000028 698 700 -3.785753 698 701 -6.399432 698 744 -0.000024 698 745 -3.337165 698 746 -5.641138 698 1800 -0.000015 698 1801 -2.027004 698 1802 -3.426445 699 651 -0.003148 699 696 -0.437077 699 697 39.122168 699 698 66.132068 699 699 506.762300 699 700 -425.700790 699 701 -719.604610 699 702 -0.153784 699 703 16.436817 699 704 27.784783 699 747 -0.805052 699 748 60.712756 699 749 102.628840 699 1803 -0.076292 699 1804 13.900146 699 1805 23.496806 700 698 -10.711566 700 700 -96.514271 700 701 111.748660 700 704 -4.500295 700 749 -16.623199 700 1805 -3.805813 701 651 -0.000033 701 652 -4.245594 701 653 -7.176753 701 696 -0.000028 701 697 -3.785753 701 698 -6.399432 701 699 0.001321 701 700 18.276708 701 701 30.894940 701 702 -0.000034 701 703 -4.474950 701 704 -7.564452 701 747 -0.000030 701 748 -4.100435 701 749 -6.931376 701 1803 -0.000013 701 1804 -1.659097 701 1805 -2.804538 702 654 -0.003499 702 699 -0.003282 702 702 575.114380 702 703 -413.320390 702 704 -698.676470 702 705 -0.237722 702 706 23.067276 702 707 38.992923 702 750 -0.666918 702 751 44.649890 702 752 75.476138 702 1806 -0.033714 702 1807 9.721189 702 1808 16.432681 703 703 -109.666930 703 704 107.725600 703 707 -6.315745 703 752 -12.225121 703 1808 -2.661640 704 654 -0.000037 704 655 -4.771426 704 656 -8.065614 704 699 -0.000034 704 700 -4.474950 704 701 -7.564452 704 702 0.001497 704 703 20.268791 704 704 34.262351 704 705 -0.000036 704 706 -4.779850 704 707 -8.079859 704 750 -0.000035 704 751 -4.770422 704 752 -8.063917 704 1806 -0.000011 704 1807 -1.459785 704 1808 -2.467619 705 657 -0.003446 705 702 -0.003452 705 705 574.617660 705 706 -364.415190 705 707 -616.007430 705 708 -0.243677 705 709 21.354776 705 710 36.098097 705 1809 -0.008868 705 1810 7.278620 705 1811 12.303779 706 706 -109.658170 706 707 94.358729 706 710 -5.846929 706 1811 -1.992885 707 657 -0.000036 707 658 -4.770802 707 659 -8.064564 707 702 -0.000036 707 703 -4.779850 707 704 -8.079859 707 705 0.001462 707 706 15.803139 707 707 26.713622 707 708 -0.000036 707 709 -4.779661 707 710 -8.079536 707 1809 -0.000011 707 1810 -1.460471 707 1811 -2.468781 708 660 -0.003398 708 661 9.642500 708 662 16.299671 708 705 -0.003403 708 708 574.442700 708 709 -350.941020 708 710 -593.230410 708 1812 -0.001039 708 1813 5.519655 708 1814 9.330418 709 662 -2.640125 709 709 -109.652150 709 710 90.685708 709 1814 -1.511292 710 660 -0.000035 710 661 -4.771853 710 662 -8.066334 710 705 -0.000036 710 706 -4.779661 710 707 -8.079536 710 708 0.001426 710 709 11.023000 710 710 18.633268 710 1812 -0.000011 710 1813 -1.459135 710 1814 -2.466520 711 711 1.000000 712 712 1.000000 713 713 1.000000 714 714 1.000000 715 715 1.000000 716 716 1.000000 717 717 1.000000 718 718 1.000000 719 719 1.000000 720 720 1.000000 721 721 1.000000 722 722 1.000000 723 723 1.000000 724 724 1.000000 725 725 1.000000 726 678 -0.001240 726 726 275.754510 726 727 -172.234060 726 728 -291.144300 726 729 -0.031715 726 774 -0.080360 726 775 10.544002 726 776 17.823566 726 1830 -0.001763 726 1831 0.473616 726 1832 0.800600 727 727 -52.567430 727 728 44.733734 727 776 -2.887367 727 1832 -0.129694 728 678 -0.000013 728 679 -2.140058 728 680 -3.617552 728 726 0.000704 728 727 9.750895 728 728 16.482902 728 729 -0.000013 728 730 -2.136405 728 731 -3.611378 728 774 -0.000014 728 775 -2.426681 728 776 -4.102058 728 1830 -0.000018 728 1831 -3.041851 728 1832 -5.141942 729 681 -0.001150 729 726 -0.001255 729 727 7.672635 729 728 12.969815 729 729 241.429160 729 730 -158.240060 729 731 -267.489000 729 732 -0.001149 729 777 -0.047710 729 778 9.078726 729 779 15.346678 729 1833 -0.002041 729 1834 0.461160 729 1835 0.779544 730 728 -2.101052 730 730 -46.008688 730 731 41.175183 730 779 -2.486095 730 1835 -0.126282 731 681 -0.000012 731 682 -1.957108 731 683 -3.308296 731 726 -0.000013 731 727 -2.136405 731 728 -3.611378 731 729 0.000636 731 730 11.667628 731 731 19.722955 731 732 -0.000012 731 733 -1.956265 731 734 -3.306871 731 777 -0.000013 731 778 -2.139502 731 779 -3.616614 731 1833 -0.000021 731 1834 -3.473180 731 1835 -5.871063 732 684 -0.001149 732 729 -0.052575 732 730 11.771221 732 731 19.898073 732 732 229.973640 732 733 -155.537230 732 734 -262.919960 732 735 -0.001148 732 780 -0.064501 732 781 8.996239 732 782 15.207231 732 1836 -0.002190 732 1837 0.472142 732 1838 0.798108 733 731 -3.223369 733 733 -43.828367 733 734 40.511193 733 782 -2.463474 733 1838 -0.129287 734 684 -0.000012 734 685 -1.910894 734 686 -3.230172 734 729 -0.000012 734 730 -1.956265 734 731 -3.306871 734 732 0.000608 734 733 11.336191 734 734 19.162684 734 735 -0.000012 734 736 -1.910188 734 737 -3.228979 734 780 -0.000012 734 781 -1.910669 734 782 -3.229792 734 1836 -0.000023 734 1837 -3.643249 734 1838 -6.158543 735 687 -0.001185 735 732 -0.124082 735 733 15.778360 735 734 26.671722 735 735 230.010510 735 736 -161.266520 735 737 -272.604930 735 738 -0.001241 735 783 -0.117258 735 784 10.506499 735 785 17.760186 735 1839 -0.002260 735 1840 0.644809 735 1841 1.089985 736 734 -4.320601 736 736 -43.837874 736 737 42.055632 736 785 -2.876985 736 1841 -0.176565 737 687 -0.000012 737 688 -1.911101 737 689 -3.230525 737 732 -0.000012 737 733 -1.910188 737 734 -3.228979 737 735 0.000611 737 736 11.383674 737 737 19.242960 737 738 -0.000013 737 739 -2.001715 737 740 -3.383699 737 783 -0.000012 737 784 -1.911252 737 785 -3.230781 737 1839 -0.000024 737 1840 -3.644487 737 1841 -6.160641 738 690 -0.001437 738 735 -0.152142 738 736 20.397004 738 737 34.479096 738 738 253.188090 738 739 -183.339790 738 740 -309.917420 738 741 -0.001514 738 786 -0.184360 738 787 13.942145 738 788 23.567784 738 1842 -0.002130 738 1843 1.277292 738 1844 2.159133 739 737 -5.585221 739 739 -48.235318 739 740 47.854592 739 788 -3.817684 739 1844 -0.349747 740 690 -0.000015 740 691 -2.234516 740 692 -3.777224 740 735 -0.000013 740 736 -2.001715 740 737 -3.383699 740 738 0.000671 740 739 11.962878 740 740 20.222038 740 741 -0.000016 740 742 -2.355314 740 743 -3.981421 740 786 -0.000013 740 787 -2.053528 740 788 -3.471281 740 1842 -0.000022 740 1843 -3.312375 740 1844 -5.599235 741 693 -0.001842 741 738 -0.276554 741 739 25.091868 741 740 42.415271 741 741 322.217860 741 742 -236.896820 741 743 -400.450390 741 744 -0.001959 741 789 -0.382956 741 790 21.121733 741 791 35.704177 741 1845 -0.001744 741 1846 2.577387 741 1847 4.356815 742 740 -6.870631 742 742 -61.399215 742 743 61.855639 742 791 -5.783500 742 1847 -0.705722 743 693 -0.000019 743 694 -2.760721 743 695 -4.666722 743 738 -0.000016 743 739 -2.355314 743 740 -3.981421 743 741 0.000844 743 742 13.243956 743 743 22.387581 743 744 -0.000020 743 745 -2.935694 743 746 -4.962497 743 789 -0.000017 743 790 -2.572364 743 791 -4.348324 743 1845 -0.000018 743 1846 -2.612950 743 1847 -4.416930 744 696 -0.002303 744 741 -0.324054 744 742 29.237469 744 743 49.423017 744 744 391.270080 744 745 -293.484850 744 746 -496.106360 744 747 -0.002479 744 792 -0.463020 744 793 31.337242 744 794 52.972422 744 1848 -0.001482 744 1849 4.525563 744 1850 7.650006 745 743 -8.005575 745 745 -74.565981 745 746 76.678890 745 794 -8.580509 745 1850 -1.239131 746 696 -0.000024 746 697 -3.337165 746 698 -5.641138 746 741 -0.000020 746 742 -2.935694 746 743 -4.962497 746 744 0.001022 746 745 15.258691 746 746 25.793274 746 747 -0.000026 746 748 -3.592570 746 749 -6.072875 746 792 -0.000023 746 793 -3.238013 746 794 -5.473533 746 1848 -0.000015 746 1849 -2.146850 746 1850 -3.629033 747 699 -0.002903 747 744 -0.306708 747 745 28.224648 747 746 47.710903 747 747 483.146660 747 748 -345.288360 747 749 -583.675450 747 750 -0.003089 747 795 -0.473559 747 796 28.960471 747 797 48.954780 747 1851 -0.001230 747 1852 5.945763 747 1853 10.050718 748 746 -7.728071 748 748 -92.121217 748 749 89.969790 748 797 -7.929536 748 1853 -1.627967 749 699 -0.000030 749 700 -4.100435 749 701 -6.931376 749 744 -0.000026 749 745 -3.592570 749 746 -6.072875 749 747 0.001259 749 748 17.763898 749 749 30.028088 749 750 -0.000032 749 751 -4.364394 749 752 -7.377571 749 795 -0.000029 749 796 -3.958055 749 797 -6.690696 749 1851 -0.000013 749 1852 -1.738063 749 1853 -2.938022 750 702 -0.003397 750 747 -0.103067 750 748 7.741826 750 749 13.086782 750 750 574.765230 750 751 -374.212130 750 752 -632.567880 750 798 -0.472096 750 799 25.400288 750 800 42.936615 750 1854 -0.001040 750 1855 5.193192 750 1856 8.778565 751 749 -2.119718 751 751 -109.669190 751 752 97.015417 751 800 -6.954676 751 1856 -1.421906 752 702 -0.000035 752 703 -4.770422 752 704 -8.063917 752 747 -0.000032 752 748 -4.364394 752 749 -7.377571 752 750 0.001457 752 751 15.329533 752 752 25.913031 752 798 -0.000034 752 799 -4.722417 752 800 -7.982768 752 1854 -0.000011 752 1855 -1.459942 752 1856 -2.467883 753 753 1.000000 754 754 1.000000 755 755 1.000000 756 756 1.000000 757 757 1.000000 758 758 1.000000 759 759 1.000000 760 760 1.000000 761 761 1.000000 762 762 1.000000 763 763 1.000000 764 764 1.000000 765 765 1.000000 766 766 1.000000 767 767 1.000000 768 768 1.000000 769 769 1.000000 770 770 1.000000 771 771 344.650670 771 772 -206.066050 771 773 -348.334050 771 774 -0.016348 771 819 -0.001612 771 820 4.004289 771 821 6.768850 771 1875 -0.001368 771 1876 0.552387 771 1877 0.933755 772 772 -65.688502 772 773 53.442501 772 821 -1.096545 772 1877 -0.151267 773 771 0.000853 773 772 8.013457 773 773 13.545947 773 774 -0.000016 773 775 -2.711276 773 776 -4.583141 773 819 -0.000017 773 820 -2.864286 773 821 -4.841788 773 1875 -0.000014 773 1876 -2.430530 773 1877 -4.108568 774 726 -0.001382 774 771 -0.001545 774 772 8.167058 774 773 13.805595 774 774 310.270710 774 775 -197.588600 774 776 -334.003530 774 777 -0.009735 774 822 -0.001546 774 823 7.543646 774 824 12.751770 774 1878 -0.001540 774 1879 0.523123 774 1880 0.884287 775 773 -2.236481 775 775 -59.131265 775 776 51.391010 775 824 -2.065763 775 1880 -0.143252 776 726 -0.000014 776 727 -2.426681 776 728 -4.102058 776 771 -0.000016 776 772 -2.711276 776 773 -4.583141 776 774 0.000803 776 775 12.985718 776 776 21.951045 776 777 -0.000015 776 778 -2.424028 776 779 -4.097574 776 822 -0.000016 776 823 -2.713573 776 824 -4.587021 776 1878 -0.000016 776 1879 -2.703527 776 1880 -4.570038 777 729 -0.001237 777 774 -0.001401 777 775 8.951589 777 776 15.131755 777 777 275.786220 777 778 -178.923550 777 779 -302.452360 777 780 -0.001203 777 825 -0.038542 777 826 8.304412 777 827 14.037779 777 1881 -0.001757 777 1882 0.479744 777 1883 0.810959 778 776 -2.451301 778 778 -52.573077 778 779 46.551825 778 827 -2.274078 778 1883 -0.131372 779 729 -0.000013 779 730 -2.139502 779 731 -3.616614 779 774 -0.000015 779 775 -2.424028 779 776 -4.097574 779 777 0.000717 779 778 12.029808 779 779 20.335185 779 780 -0.000013 779 781 -2.081491 779 782 -3.518552 779 825 -0.000014 779 826 -2.338679 779 827 -3.953303 779 1881 -0.000018 779 1882 -3.040207 779 1883 -5.139166 780 732 -0.001128 780 777 -0.032091 780 778 11.556585 780 779 19.535251 780 780 229.882960 780 781 -155.141310 780 782 -262.250680 780 783 -0.001127 780 828 -0.050981 780 829 8.790171 780 830 14.858896 780 1884 -0.002155 780 1885 0.459230 780 1886 0.776282 781 779 -3.164625 781 781 -43.822323 781 782 40.418167 781 830 -2.407072 781 1886 -0.125753 782 732 -0.000012 782 733 -1.910669 782 734 -3.229792 782 777 -0.000013 782 778 -2.081491 782 779 -3.518552 782 780 0.000608 782 781 11.509553 782 782 19.455737 782 783 -0.000012 782 784 -1.907882 782 785 -3.225081 782 828 -0.000012 782 829 -1.956488 782 830 -3.307245 782 1884 -0.000022 782 1885 -3.648100 782 1886 -6.166745 783 735 -0.001161 783 780 -0.071293 783 781 14.254211 783 782 24.095299 783 783 229.943540 783 784 -159.771020 783 785 -270.076920 783 786 -0.001187 783 831 -0.081700 783 832 10.688462 783 833 18.067775 783 1887 -0.002217 783 1888 0.509420 783 1889 0.861123 784 782 -3.903285 784 784 -43.834704 784 785 41.654598 784 833 -2.926850 784 1889 -0.139494 785 735 -0.000012 785 736 -1.911252 785 737 -3.230781 785 780 -0.000012 785 781 -1.907882 785 782 -3.225081 785 783 0.000609 785 784 11.338339 785 785 19.166326 785 786 -0.000012 785 787 -1.954691 785 788 -3.304209 785 831 -0.000012 785 832 -1.910324 785 833 -3.229212 785 1887 -0.000023 785 1888 -3.649262 785 1889 -6.168712 786 738 -0.001289 786 783 -0.092997 786 784 17.391223 786 785 29.398124 786 786 241.511390 786 787 -172.866650 786 788 -292.213570 786 789 -0.001392 786 834 -0.120154 786 835 13.639587 786 836 23.056342 786 1890 -0.002180 786 1891 0.788453 786 1892 1.332799 787 785 -4.762223 787 787 -46.041311 787 788 45.098157 787 836 -3.734897 787 1892 -0.215897 788 738 -0.000013 788 739 -2.053528 788 740 -3.471281 788 783 -0.000012 788 784 -1.954691 788 785 -3.304209 788 786 0.000640 788 787 11.712269 788 788 19.798408 788 789 -0.000015 788 790 -2.218474 788 791 -3.750105 788 834 -0.000013 788 835 -2.006779 788 836 -3.392256 788 1890 -0.000023 788 1891 -3.473617 788 1892 -5.871797 789 741 -0.001668 789 786 -0.129357 789 787 20.478718 789 788 34.617200 789 789 299.296290 789 790 -216.420270 789 791 -365.836820 789 792 -0.001826 789 837 -0.204339 789 838 19.964062 789 839 33.747250 789 1893 -0.001818 789 1894 1.426502 789 1895 2.411359 790 788 -5.607550 790 790 -57.020556 790 791 56.448122 790 839 -5.466612 790 1895 -0.390602 791 741 -0.000017 791 742 -2.572364 791 743 -4.348324 791 786 -0.000015 791 787 -2.218474 791 788 -3.750105 791 789 0.000785 791 790 12.900552 791 791 21.807090 791 792 -0.000019 791 793 -2.816056 791 794 -4.760261 791 837 -0.000016 791 838 -2.483056 791 839 -4.197358 791 1893 -0.000019 791 1894 -2.804180 791 1895 -4.740185 792 744 -0.002164 792 789 -0.327371 792 790 23.913941 792 791 40.424126 792 792 391.279950 792 793 -291.762790 792 794 -493.195350 792 795 -0.002375 792 840 -0.616488 792 841 37.103314 792 842 62.719392 792 1896 -0.001440 792 1897 2.286026 792 1898 3.864296 793 791 -6.548056 793 793 -74.567079 793 794 76.206877 793 842 -10.159607 793 1898 -0.625943 794 744 -0.000023 794 745 -3.238013 794 746 -5.473533 794 789 -0.000019 794 790 -2.816056 794 791 -4.760261 794 792 0.001017 794 793 15.008424 794 794 25.370222 794 795 -0.000025 794 796 -3.553927 794 797 -6.007552 794 840 -0.000022 794 841 -3.237423 794 842 -5.472535 794 1896 -0.000015 794 1897 -2.154605 794 1898 -3.642142 795 747 -0.002735 795 792 -0.386357 795 793 36.310525 795 794 61.379251 795 795 471.433830 795 796 -315.040320 795 797 -532.544150 795 798 -0.002950 795 1899 -0.001231 795 1900 3.358751 795 1901 5.677632 796 794 -9.942253 796 796 -89.932956 796 797 81.786007 796 1901 -0.919648 797 747 -0.000029 797 748 -3.958055 797 749 -6.690696 797 792 -0.000025 797 793 -3.553927 797 794 -6.007552 797 795 0.001199 797 796 13.571840 797 797 22.941832 797 798 -0.000031 797 799 -4.268328 797 800 -7.215182 797 1899 -0.000013 797 1900 -1.781394 797 1901 -3.011268 798 750 -0.003304 798 795 -0.184732 798 796 15.843805 798 797 26.782368 798 798 563.093880 798 799 -348.358320 798 800 -588.864490 798 1902 -0.001042 798 1903 3.379522 798 1904 5.712742 799 797 -4.338121 799 799 -107.485330 799 800 90.023638 799 1904 -0.925328 800 750 -0.000034 800 751 -4.722417 800 752 -7.982768 800 795 -0.000031 800 796 -4.268328 800 797 -7.215182 800 798 0.001393 800 799 10.492712 800 800 17.736873 800 1902 -0.000011 800 1903 -1.489850 800 1904 -2.518442 801 801 1.000000 802 802 1.000000 803 803 1.000000 804 804 1.000000 805 805 1.000000 806 806 1.000000 807 807 1.000000 808 808 1.000000 809 809 1.000000 810 810 1.000000 811 811 1.000000 812 812 1.000000 813 813 1.000000 814 814 1.000000 815 815 1.000000 816 816 1.000000 817 817 1.000000 818 818 1.000000 819 771 -0.016955 819 819 344.668580 819 820 -206.577340 819 821 -349.198340 819 822 -0.024181 819 867 -0.001603 819 868 4.480920 819 869 7.574547 819 1923 -0.001360 819 1924 0.562159 819 1925 0.950273 820 820 -60.270803 820 821 62.745862 820 869 -1.227071 820 1925 -0.153943 821 771 -0.000017 821 772 -2.864286 821 773 -4.841788 821 819 0.000871 821 820 11.026543 821 821 18.639267 821 822 -0.000017 821 823 -2.861301 821 824 -4.836742 821 867 -0.000017 821 868 -2.864372 821 869 -4.841934 821 1923 -0.000014 821 1924 -2.429223 821 1925 -4.106358 822 774 -0.009494 822 819 -0.001612 822 820 4.664749 822 821 7.885292 822 822 344.659580 822 823 -213.038160 822 824 -360.119500 822 825 -0.059415 822 870 -0.023810 822 871 6.320356 822 872 10.683921 822 1926 -0.001371 822 1927 0.527848 822 1928 0.892274 823 821 -1.277407 823 823 -65.690055 823 824 55.347981 823 872 -1.730785 823 1928 -0.144547 824 774 -0.000016 824 775 -2.713573 824 776 -4.587021 824 819 -0.000017 824 820 -2.861301 824 821 -4.836742 824 822 0.000886 824 823 13.480709 824 824 22.787778 824 825 -0.000015 824 826 -2.600280 824 827 -4.395511 824 870 -0.000017 824 871 -2.864580 824 872 -4.842282 824 1926 -0.000014 824 1927 -2.433610 824 1928 -4.113771 825 777 -0.001333 825 822 -0.001482 825 823 7.597627 825 824 12.843021 825 825 287.300140 825 826 -183.234880 825 827 -309.740230 825 828 -0.001241 825 873 -0.016360 825 874 7.221469 825 875 12.207171 825 1929 -0.001664 825 1930 0.498162 825 1931 0.842094 826 824 -2.080546 826 826 -54.755899 826 827 47.649979 826 875 -1.977539 826 1931 -0.136417 827 777 -0.000014 827 778 -2.338679 827 779 -3.953303 827 822 -0.000015 827 823 -2.600280 827 824 -4.395511 827 825 0.000746 827 826 12.428043 827 827 21.008360 827 828 -0.000013 827 829 -2.176988 827 830 -3.679980 827 873 -0.000014 827 874 -2.386958 827 875 -4.034913 827 1929 -0.000017 827 1930 -2.918994 827 1931 -4.934267 828 780 -0.001135 828 825 -0.012714 828 826 10.036045 828 827 16.964930 828 828 241.330390 828 829 -159.726540 828 830 -270.001590 828 831 -0.001133 828 876 -0.025621 828 877 8.198949 828 878 13.859495 828 1932 -0.002018 828 1933 0.455151 828 1934 0.769387 829 827 -2.748267 829 829 -46.006226 829 830 41.588697 829 878 -2.245195 829 1934 -0.124637 830 780 -0.000012 830 781 -1.956488 830 782 -3.307245 830 825 -0.000013 830 826 -2.176988 830 827 -3.679980 830 828 0.000634 830 829 11.574441 830 830 19.565427 830 831 -0.000012 830 832 -1.953385 830 833 -3.301999 830 876 -0.000012 830 877 -2.004995 830 878 -3.389242 830 1932 -0.000021 830 1933 -3.477420 830 1934 -5.878228 831 783 -0.001136 831 828 -0.040353 831 829 12.440799 831 830 21.029915 831 831 229.882320 831 832 -157.601960 831 833 -266.410360 831 834 -0.001162 831 879 -0.050339 831 880 10.360255 831 881 17.512975 831 1935 -0.002173 831 1936 0.461074 831 1937 0.779399 832 830 -3.406748 832 832 -43.828011 832 833 41.077746 832 881 -2.837012 832 1937 -0.126257 833 783 -0.000012 833 784 -1.910324 833 785 -3.229212 833 828 -0.000012 833 829 -1.953385 833 830 -3.301999 833 831 0.000608 833 832 11.384557 833 833 19.244453 833 834 -0.000012 833 835 -1.953223 833 836 -3.301729 833 879 -0.000012 833 880 -1.909517 833 881 -3.227848 833 1935 -0.000023 833 1936 -3.653182 833 1937 -6.175339 834 786 -0.001229 834 831 -0.059512 834 832 15.030646 834 833 25.407804 834 834 241.407110 834 835 -169.790470 834 836 -287.013620 834 837 -0.001356 834 882 -0.095382 834 883 13.129917 834 884 22.194797 834 1938 -0.002129 834 1939 0.585000 834 1940 0.988883 835 833 -4.115882 835 835 -46.034272 835 836 44.274019 835 884 -3.595391 835 1940 -0.160189 836 786 -0.000013 836 787 -2.006779 836 788 -3.392256 836 831 -0.000012 836 832 -1.953223 836 833 -3.301729 836 834 0.000638 836 835 11.661624 836 836 19.712798 836 837 -0.000014 836 838 -2.215379 836 839 -3.744874 836 882 -0.000012 836 883 -2.003694 836 884 -3.387043 836 1938 -0.000022 836 1939 -3.477370 836 1940 -5.878142 837 789 -0.001565 837 834 -0.079495 837 835 17.694926 837 836 29.911484 837 837 298.827460 837 838 -205.621030 837 839 -347.581780 837 840 -0.001772 837 885 -0.018481 837 886 12.425388 837 887 21.003875 837 1941 -0.001773 837 1942 0.861804 837 1943 1.456794 838 836 -4.845361 838 838 -57.012907 838 839 53.511216 838 887 -3.402391 838 1943 -0.235982 839 789 -0.000016 839 790 -2.483056 839 791 -4.197358 839 834 -0.000014 839 835 -2.215379 839 836 -3.744874 839 837 0.000782 839 838 12.812149 839 839 21.657654 839 840 -0.000018 839 841 -2.812326 839 842 -4.753955 839 885 -0.000016 839 886 -2.481705 839 887 -4.195074 839 1941 -0.000019 839 1942 -2.813264 839 1943 -4.755541 840 792 -0.002077 840 837 -0.022783 840 838 14.261129 840 839 24.107012 840 840 391.051560 840 841 -261.208570 840 842 -441.546650 840 888 -0.026512 840 889 17.605472 840 890 29.760267 840 1944 -0.001379 840 1945 1.097418 840 1946 1.855074 841 839 -3.905020 841 841 -74.574783 841 842 67.824365 841 890 -4.820781 841 1946 -0.300495 842 792 -0.000022 842 793 -3.237423 842 794 -5.472535 842 837 -0.000018 842 838 -2.812326 842 839 -4.753955 842 840 0.000989 842 841 11.401721 842 842 19.273457 842 888 -0.000021 842 889 -3.193950 842 890 -5.399049 842 1944 -0.000014 842 1945 -2.149620 842 1946 -3.633714 843 843 1.000000 844 844 1.000000 845 845 1.000000 846 846 1.000000 847 847 1.000000 848 848 1.000000 849 849 1.000000 850 850 1.000000 851 851 1.000000 852 852 1.000000 853 853 1.000000 854 854 1.000000 855 855 1.000000 856 856 1.000000 857 857 1.000000 858 858 1.000000 859 859 1.000000 860 860 1.000000 861 861 1.000000 862 862 1.000000 863 863 1.000000 864 864 1.000000 865 865 1.000000 866 866 1.000000 867 819 -0.026113 867 867 344.663030 867 868 -205.228460 867 869 -346.918190 867 870 -0.070844 867 915 -0.001594 867 916 3.131511 867 917 5.293507 867 1971 -0.001352 867 1972 0.563222 867 1973 0.952070 868 868 -60.262267 868 869 62.397303 868 917 -0.857546 868 1973 -0.154235 869 819 -0.000017 869 820 -2.864372 869 821 -4.841934 869 867 0.000870 869 868 11.027649 869 869 18.641137 869 870 -0.000017 869 871 -2.861569 869 872 -4.837196 869 915 -0.000017 869 916 -2.864796 869 917 -4.842651 869 1971 -0.000014 869 1972 -2.429554 869 1973 -4.106918 870 822 -0.001600 870 867 -0.001598 870 868 2.827902 870 869 4.780285 870 870 344.753360 870 871 -209.696840 870 872 -354.471290 870 873 -0.055632 870 918 -0.001572 870 919 4.816685 870 920 8.142119 870 1974 -0.001358 870 1975 0.531258 870 1976 0.898038 871 869 -0.774403 871 871 -65.683722 871 872 54.448839 871 920 -1.319020 871 1976 -0.145481 872 822 -0.000017 872 823 -2.864580 872 824 -4.842282 872 867 -0.000017 872 868 -2.861569 872 869 -4.837196 872 870 0.000886 872 871 13.583208 872 872 22.961043 872 873 -0.000015 872 874 -2.601715 872 875 -4.397936 872 918 -0.000016 872 919 -2.815881 872 920 -4.759962 872 1974 -0.000014 872 1975 -2.432101 872 1976 -4.111220 873 825 -0.001344 873 870 -0.001465 873 871 5.470773 873 872 9.247789 873 873 287.271430 873 874 -179.847910 873 875 -304.014910 873 876 -0.002652 873 921 -0.006287 873 922 5.975674 873 923 10.101279 873 1977 -0.001643 873 1978 0.497859 873 1979 0.841581 874 872 -1.498133 874 874 -54.747707 874 875 46.742926 874 923 -1.636398 874 1979 -0.136335 875 825 -0.000014 875 826 -2.386958 875 827 -4.034913 875 870 -0.000015 875 871 -2.601715 875 872 -4.397936 875 873 0.000745 875 874 12.427625 875 875 21.007653 875 876 -0.000013 875 877 -2.177178 875 878 -3.680302 875 921 -0.000014 875 922 -2.338077 875 923 -3.952285 875 1977 -0.000017 875 1978 -2.917556 875 1979 -4.931837 876 828 -0.001145 876 873 -0.001244 876 874 7.720605 876 875 13.050911 876 876 241.289140 876 877 -156.530410 876 878 -264.598870 876 879 -0.001115 876 924 -0.028587 876 925 7.294179 876 926 12.330072 876 1980 -0.001985 876 1981 0.449715 876 1982 0.760198 877 875 -2.114223 877 877 -45.997623 877 878 40.735007 877 926 -1.997450 877 1982 -0.123150 878 828 -0.000012 878 829 -2.004995 878 830 -3.389242 878 873 -0.000013 878 874 -2.177178 878 875 -3.680302 878 876 0.000633 878 877 11.571691 878 878 19.560777 878 879 -0.000012 878 880 -1.952097 878 881 -3.299824 878 924 -0.000011 878 925 -1.956197 878 926 -3.306753 878 1980 -0.000021 878 1981 -3.476062 878 1982 -5.875930 879 831 -0.001112 879 876 -0.013811 879 877 9.823857 879 878 16.606239 879 879 229.819580 879 880 -155.087840 879 881 -262.160480 879 882 -0.001138 879 927 -0.051645 879 928 10.488328 879 929 17.729469 879 1983 -0.002130 879 1984 0.441456 879 1985 0.746237 880 878 -2.690158 880 880 -43.818848 880 881 40.412391 880 929 -2.872120 880 1985 -0.120887 881 831 -0.000012 881 832 -1.909517 881 833 -3.227848 881 876 -0.000012 881 877 -1.952097 881 878 -3.299824 881 879 0.000606 881 880 11.386064 881 881 19.247000 881 882 -0.000012 881 883 -1.953723 881 884 -3.302573 881 927 -0.000011 881 928 -1.909016 881 929 -3.227001 881 1983 -0.000022 881 1984 -3.656789 881 1985 -6.181435 882 834 -0.001196 882 879 -0.018024 882 880 12.831785 882 881 21.690848 882 882 241.481680 882 883 -172.742630 882 884 -292.003970 882 885 -0.001324 882 930 -0.076276 882 931 18.367232 882 932 31.047948 882 1986 -0.002078 882 1987 0.512428 882 1988 0.866207 883 881 -3.513806 883 883 -46.025611 883 884 45.104546 883 932 -5.029638 883 1988 -0.140319 884 834 -0.000012 884 835 -2.003694 884 836 -3.387043 884 879 -0.000012 884 880 -1.953723 884 881 -3.302573 884 882 0.000637 884 883 11.710275 884 884 19.795037 884 885 -0.000014 884 886 -2.217911 884 887 -3.749154 884 930 -0.000012 884 931 -2.049464 884 932 -3.464412 884 1986 -0.000022 884 1987 -3.480307 884 1988 -5.883107 885 837 -0.001536 885 882 -0.168670 885 883 21.144376 885 884 35.742431 885 885 298.655140 885 886 -196.509860 885 887 -332.180270 885 888 -0.001718 885 1989 -0.001739 885 1990 0.675936 885 1991 1.142602 886 884 -5.790006 886 886 -56.998073 886 887 51.053573 886 1991 -0.185089 887 837 -0.000016 887 838 -2.481705 887 839 -4.195074 887 882 -0.000014 887 883 -2.217911 887 884 -3.749154 887 885 0.000765 887 886 10.289227 887 887 17.392906 887 888 -0.000018 887 889 -2.774568 887 890 -4.690129 887 1989 -0.000018 887 1990 -2.808630 887 1991 -4.747708 888 840 -0.002010 888 885 -0.020106 888 886 12.667573 888 887 21.413265 888 888 379.003530 888 889 -235.148880 888 890 -397.495380 888 1992 -0.001395 888 1993 0.786443 888 1994 1.329401 889 887 -3.468708 889 889 -72.360764 889 890 60.849346 889 1994 -0.215346 890 840 -0.000021 890 841 -3.193950 890 842 -5.399049 890 885 -0.000018 890 886 -2.774568 890 887 -4.690129 890 888 0.000940 890 889 8.193192 890 890 13.849764 890 1992 -0.000015 890 1993 -2.216528 890 1994 -3.746815 891 891 1.000000 892 892 1.000000 893 893 1.000000 894 894 1.000000 895 895 1.000000 896 896 1.000000 897 897 1.000000 898 898 1.000000 899 899 1.000000 900 900 1.000000 901 901 1.000000 902 902 1.000000 903 903 1.000000 904 904 1.000000 905 905 1.000000 906 906 1.000000 907 907 1.000000 908 908 1.000000 909 909 1.000000 910 910 1.000000 911 911 1.000000 912 912 1.000000 913 913 1.000000 914 914 1.000000 915 867 -0.011800 915 915 344.656670 915 916 -202.101410 915 917 -341.632220 915 918 -0.061502 915 2019 -0.001345 915 2020 0.557291 915 2021 0.942044 916 916 -65.668414 916 917 52.406411 916 2021 -0.152611 917 867 -0.000017 917 868 -2.864796 917 869 -4.842651 917 915 0.000853 917 916 8.113959 917 917 13.715837 917 918 -0.000016 917 919 -2.813742 917 920 -4.756349 917 2019 -0.000014 917 2020 -2.428066 917 2021 -4.104402 918 870 -0.019761 918 915 -0.001560 918 916 1.043216 918 917 1.763452 918 918 333.230070 918 919 -199.286750 918 920 -336.874120 918 921 -0.075083 918 966 -0.001451 918 967 2.923511 918 968 4.941899 918 2022 -0.001395 918 2023 0.520392 918 2024 0.879670 919 917 -0.285679 919 919 -63.486307 919 920 51.716900 919 968 -0.800588 919 2024 -0.142506 920 870 -0.000016 920 871 -2.815881 920 872 -4.759962 920 915 -0.000016 920 916 -2.813742 920 917 -4.756349 920 918 0.000856 920 919 13.273757 920 920 22.437948 920 921 -0.000015 920 922 -2.505335 920 923 -4.235015 920 966 -0.000015 920 967 -2.616920 920 968 -4.423638 920 2022 -0.000015 920 2023 -2.514767 920 2024 -4.250958 921 873 -0.001303 921 918 -0.001396 921 919 3.150285 921 920 5.325238 921 921 275.807050 921 922 -169.234850 921 923 -286.074590 921 924 -0.027329 921 969 -0.001192 921 970 4.394735 921 971 7.428860 921 2025 -0.001694 921 2026 0.481380 921 2027 0.813724 922 920 -0.862687 922 922 -52.550474 922 923 43.955116 922 971 -1.203474 922 2027 -0.131823 923 873 -0.000014 923 874 -2.338077 923 875 -3.952285 923 918 -0.000015 923 919 -2.505335 923 920 -4.235015 923 921 0.000716 923 922 12.108122 923 923 20.467567 923 924 -0.000012 923 925 -2.081367 923 926 -3.518343 923 969 -0.000012 923 970 -2.138675 923 971 -3.615217 923 2025 -0.000018 923 2026 -3.038776 923 2027 -5.136748 924 876 -0.001101 924 921 -0.001171 924 922 4.939394 924 923 8.349552 924 924 229.826800 924 925 -145.449890 924 926 -245.868330 924 927 -0.012405 924 972 -0.012781 924 973 5.747739 924 974 9.715972 924 2028 -0.002053 924 2029 0.438850 924 2030 0.741831 925 923 -1.352620 925 925 -43.800301 925 926 37.819564 925 974 -1.573982 925 2030 -0.120175 926 876 -0.000011 926 877 -1.956197 926 878 -3.306753 926 921 -0.000012 926 922 -2.081367 926 923 -3.518343 926 924 0.000605 926 925 11.508061 926 926 19.453216 926 927 -0.000011 926 928 -1.908146 926 929 -3.225528 926 972 -0.000011 926 973 -1.909476 926 974 -3.227776 926 2028 -0.000021 926 2029 -3.647962 926 2030 -6.166510 927 879 -0.001088 927 924 -0.001088 927 925 6.233941 927 926 10.537847 927 927 229.825240 927 928 -148.591700 927 929 -251.179420 927 930 -0.004189 927 975 -0.012881 927 976 7.593210 927 977 12.835562 927 2031 -0.002080 927 2032 0.426569 927 2033 0.721072 928 926 -1.707113 928 928 -43.809625 928 929 38.656718 928 977 -2.079341 928 2033 -0.116811 929 879 -0.000011 929 880 -1.909016 929 881 -3.227001 929 924 -0.000011 929 925 -1.908146 929 926 -3.225528 929 927 0.000605 929 928 11.378192 929 929 19.233694 929 930 -0.000012 929 931 -1.998371 929 932 -3.378046 929 975 -0.000011 929 976 -1.908820 929 977 -3.226670 929 2031 -0.000022 929 2032 -3.648922 929 2033 -6.168137 930 882 -0.001183 930 927 -0.001153 930 928 6.194594 930 929 10.471342 930 930 252.800210 930 931 -163.454440 930 932 -276.303210 930 978 -0.028943 930 979 9.057929 930 980 15.311518 930 2034 -0.001916 930 2035 0.446378 930 2036 0.754558 931 929 -1.696325 931 931 -48.199513 931 932 42.501223 931 980 -2.480426 931 2036 -0.122235 932 882 -0.000012 932 883 -2.049464 932 884 -3.464412 932 927 -0.000012 932 928 -1.998371 932 929 -3.378046 932 930 0.000648 932 931 9.520503 932 932 16.093452 932 978 -0.000013 932 979 -2.146916 932 980 -3.629146 932 2034 -0.000020 932 2035 -3.320339 932 2036 -5.612698 933 933 1.000000 934 934 1.000000 935 935 1.000000 936 936 1.000000 937 937 1.000000 938 938 1.000000 939 939 1.000000 940 940 1.000000 941 941 1.000000 942 942 1.000000 943 943 1.000000 944 944 1.000000 945 945 1.000000 946 946 1.000000 947 947 1.000000 948 948 1.000000 949 949 1.000000 950 950 1.000000 951 951 1.000000 952 952 1.000000 953 953 1.000000 954 954 1.000000 955 955 1.000000 956 956 1.000000 957 957 1.000000 958 958 1.000000 959 959 1.000000 960 960 1.000000 961 961 1.000000 962 962 1.000000 963 963 1.000000 964 964 1.000000 965 965 1.000000 966 918 -0.005334 966 966 298.709230 966 967 -175.165790 966 968 -296.100050 966 969 -0.065873 966 2070 -0.001549 966 2071 0.498117 966 2072 0.842017 967 967 -56.914730 967 968 45.417038 967 2072 -0.136407 968 918 -0.000015 968 919 -2.616920 968 920 -4.423638 968 966 0.000743 968 967 7.645461 968 968 12.923878 968 969 -0.000013 968 970 -2.216879 968 971 -3.747410 968 2070 -0.000016 968 2071 -2.805286 968 2072 -4.742052 969 921 -0.004905 969 966 -0.001225 969 967 0.708615 969 968 1.197842 969 969 241.339950 969 970 -145.704550 969 971 -246.298970 969 972 -0.041054 969 1017 -0.001081 969 1018 3.494555 969 1019 5.907196 969 2073 -0.001919 969 2074 0.457785 969 2075 0.773840 970 968 -0.194050 970 970 -42.188136 970 971 44.227243 970 1019 -0.956969 970 2075 -0.125362 971 921 -0.000012 971 922 -2.138675 971 923 -3.615217 971 966 -0.000013 971 967 -2.216879 971 968 -3.747410 971 969 0.000632 971 970 11.743620 971 971 19.851412 971 972 -0.000011 971 973 -1.955043 971 974 -3.304805 971 1017 -0.000011 971 1018 -1.956197 971 1019 -3.306755 971 2073 -0.000020 971 2074 -3.471673 971 2075 -5.868516 972 924 -0.001061 972 969 -0.001087 972 970 2.771988 972 971 4.685769 972 972 229.832460 972 973 -142.065990 972 974 -240.148210 972 975 -0.012486 972 1020 -0.001061 972 1021 4.537014 972 1022 7.669365 972 2076 -0.002026 972 2077 0.419476 972 2078 0.709082 973 971 -0.759094 973 973 -43.793757 973 974 36.909200 973 1022 -1.242439 973 2078 -0.114871 974 924 -0.000011 974 925 -1.909476 974 926 -3.227776 974 969 -0.000011 974 970 -1.955043 974 971 -3.304805 974 972 0.000603 974 973 11.332200 974 974 19.155942 974 975 -0.000011 974 976 -1.908287 974 977 -3.225767 974 1020 -0.000011 974 1021 -1.909338 974 1022 -3.227544 974 2076 -0.000021 974 2077 -3.645145 974 2078 -6.161749 975 927 -0.001071 975 972 -0.001071 975 973 4.387382 975 974 7.416427 975 975 229.796230 975 976 -145.348790 975 977 -245.697590 975 978 -0.017989 975 1023 -0.003039 975 1024 6.205289 975 1025 10.489420 975 2079 -0.002047 975 2080 0.426701 975 2081 0.721296 976 974 -1.201457 976 976 -43.800643 976 977 37.791073 976 1025 -1.699282 976 2081 -0.116849 977 927 -0.000011 977 928 -1.908820 977 929 -3.226670 977 972 -0.000011 977 973 -1.908287 977 974 -3.225767 977 975 0.000605 977 976 11.511560 977 977 19.459139 977 978 -0.000012 977 979 -2.040894 977 980 -3.449927 977 1023 -0.000012 977 1024 -1.999851 977 1025 -3.380549 977 2079 -0.000021 977 2080 -3.648793 977 2081 -6.167920 978 930 -0.001218 978 975 -0.001158 978 976 5.834263 978 977 9.862238 978 978 264.260110 978 979 -160.753540 978 980 -271.737680 978 2082 -0.001801 978 2083 0.437951 978 2084 0.740312 979 977 -1.597667 979 979 -50.380740 979 980 41.683042 979 2084 -0.119929 980 930 -0.000013 980 931 -2.146916 980 932 -3.629146 980 975 -0.000012 980 976 -2.040894 980 977 -3.449927 980 978 0.000662 980 979 7.366534 980 980 12.452383 980 2082 -0.000019 980 2083 -3.173069 980 2084 -5.363752 981 981 1.000000 982 982 1.000000 983 983 1.000000 984 984 1.000000 985 985 1.000000 986 986 1.000000 987 987 1.000000 988 988 1.000000 989 989 1.000000 990 990 1.000000 991 991 1.000000 992 992 1.000000 993 993 1.000000 994 994 1.000000 995 995 1.000000 996 996 1.000000 997 997 1.000000 998 998 1.000000 999 999 1.000000 1000 1000 1.000000 1001 1001 1.000000 1002 1002 1.000000 1003 1003 1.000000 1004 1004 1.000000 1005 1005 1.000000 1006 1006 1.000000 1007 1007 1.000000 1008 1008 1.000000 1009 1009 1.000000 1010 1010 1.000000 1011 1011 1.000000 1012 1012 1.000000 1013 1013 1.000000 1014 1014 1.000000 1015 1015 1.000000 1016 1016 1.000000 1017 969 -0.002636 1017 1017 229.806270 1017 1018 -137.022390 1017 1019 -231.622650 1017 1020 -0.041015 1017 1065 -0.001048 1017 1066 2.260580 1017 1067 3.821284 1017 2121 -0.001999 1017 2122 0.411318 1017 2123 0.695292 1018 1018 -43.781862 1018 1019 35.557344 1018 1067 -0.619052 1018 2123 -0.112638 1019 969 -0.000011 1019 970 -1.956197 1019 971 -3.306755 1019 1017 0.000592 1019 1018 9.423386 1019 1019 15.929293 1019 1020 -0.000011 1019 1021 -1.908941 1019 1022 -3.226874 1019 1065 -0.000011 1019 1066 -1.909520 1019 1067 -3.227853 1019 2121 -0.000021 1019 2122 -3.643823 1019 2123 -6.159519 1020 972 -0.001642 1020 1017 -0.001051 1020 1018 1.580587 1020 1019 2.671825 1020 1020 229.839720 1020 1021 -139.621580 1020 1022 -236.016200 1020 1023 -0.015615 1020 1068 -0.001051 1020 1069 3.311547 1020 1070 5.597835 1020 2124 -0.002006 1020 2125 0.409908 1020 2126 0.692907 1021 1019 -0.432837 1021 1021 -43.787669 1021 1022 36.254915 1021 1070 -0.906855 1021 2126 -0.112251 1022 972 -0.000011 1022 973 -1.909338 1022 974 -3.227544 1022 1017 -0.000011 1022 1018 -1.908941 1022 1019 -3.226874 1022 1020 0.000603 1022 1021 11.376364 1022 1022 19.230594 1022 1023 -0.000012 1022 1024 -2.000249 1022 1025 -3.381220 1022 1068 -0.000011 1022 1069 -1.909210 1022 1070 -3.227326 1022 2124 -0.000021 1022 2125 -3.643718 1022 2126 -6.159334 1023 975 -0.001108 1023 1020 -0.001108 1023 1021 3.145284 1023 1022 5.316785 1023 1023 252.766650 1023 1024 -151.330490 1023 1025 -255.809070 1023 2127 -0.001836 1023 2128 0.416823 1023 2129 0.704598 1024 1022 -0.861321 1024 1024 -48.172242 1024 1025 39.248992 1024 2129 -0.114145 1025 975 -0.000012 1025 976 -1.999851 1025 977 -3.380549 1025 1020 -0.000012 1025 1021 -2.000249 1025 1022 -3.381220 1025 1023 0.000634 1025 1024 7.319286 1025 1025 12.372520 1025 2127 -0.000019 1025 2128 -3.313785 1025 2129 -5.601621 1026 1026 1.000000 1027 1027 1.000000 1028 1028 1.000000 1029 1029 1.000000 1030 1030 1.000000 1031 1031 1.000000 1032 1032 1.000000 1033 1033 1.000000 1034 1034 1.000000 1035 1035 1.000000 1036 1036 1.000000 1037 1037 1.000000 1038 1038 1.000000 1039 1039 1.000000 1040 1040 1.000000 1041 1041 1.000000 1042 1042 1.000000 1043 1043 1.000000 1044 1044 1.000000 1045 1045 1.000000 1046 1046 1.000000 1047 1047 1.000000 1048 1048 1.000000 1049 1049 1.000000 1050 1050 1.000000 1051 1051 1.000000 1052 1052 1.000000 1053 1053 1.000000 1054 1054 1.000000 1055 1055 1.000000 1056 1056 1.000000 1057 1057 1.000000 1058 1058 1.000000 1059 1059 1.000000 1060 1060 1.000000 1061 1061 1.000000 1062 1062 1.000000 1063 1063 1.000000 1064 1064 1.000000 1065 1017 -0.015430 1065 1065 229.795530 1065 1066 -134.743170 1065 1067 -227.769850 1065 1068 -0.042360 1065 2169 -0.001989 1065 2170 0.398835 1065 2171 0.674190 1066 1066 -43.777519 1066 1067 34.943889 1066 2171 -0.109219 1067 1017 -0.000011 1067 1018 -1.909520 1067 1019 -3.227853 1067 1065 0.000580 1067 1066 7.466155 1067 1067 12.620788 1067 1068 -0.000011 1067 1069 -1.909093 1067 1070 -3.227130 1067 2169 -0.000021 1067 2170 -3.642639 1067 2171 -6.157516 1068 1020 -0.014084 1068 1065 -0.001043 1068 1066 0.529376 1068 1067 0.894857 1068 1068 229.831970 1068 1069 -135.258580 1068 1070 -228.640960 1068 2172 -0.001991 1068 2173 0.399040 1068 2174 0.674537 1069 1067 -0.144968 1069 1069 -43.782057 1069 1070 35.074011 1069 2174 -0.109276 1070 1020 -0.000011 1070 1021 -1.909210 1070 1022 -3.227326 1070 1065 -0.000011 1070 1066 -1.909093 1070 1067 -3.227130 1070 1068 0.000580 1070 1069 7.466864 1070 1070 12.621981 1070 2172 -0.000021 1070 2173 -3.643656 1070 2174 -6.159233 1071 1071 1.000000 1072 1072 1.000000 1073 1073 1.000000 1074 1074 1.000000 1075 1075 1.000000 1076 1076 1.000000 1077 1077 1.000000 1078 1078 1.000000 1079 1079 1.000000 1080 1080 1.000000 1081 1081 1.000000 1082 1082 1.000000 1083 1083 1.000000 1084 1084 1.000000 1085 1085 1.000000 1086 1086 1.000000 1087 1087 1.000000 1088 1088 1.000000 1089 1089 1.000000 1090 1090 1.000000 1091 1091 1.000000 1092 1092 1.000000 1093 1093 1.000000 1094 1094 1.000000 1095 1095 1.000000 1096 1096 1.000000 1097 1097 1.000000 1098 1098 1.000000 1099 1099 1.000000 1100 1100 1.000000 1101 1101 1.000000 1102 1102 1.000000 1103 1103 1.000000 1104 1104 1.000000 1105 1105 1.000000 1106 1106 1.000000 1107 1107 1.000000 1108 1108 1.000000 1109 1109 1.000000 1110 1110 1.000000 1111 1111 1.000000 1112 1112 1.000000 1113 1113 1.000000 1114 1114 1.000000 1115 1115 1.000000 1116 1116 1.000000 1117 1117 1.000000 1118 1118 1.000000 1119 1119 1.000000 1120 1120 1.000000 1121 1121 1.000000 1122 1122 1.000000 1123 1123 1.000000 1124 1124 1.000000 1125 1125 1.000000 1126 1126 1.000000 1127 1127 1.000000 1128 1128 1.000000 1129 1129 1.000000 1130 1130 1.000000 1131 1131 1.000000 1132 1132 1.000000 1133 1133 1.000000 1134 1134 1.000000 1135 1135 1.000000 1136 1136 1.000000 1137 1137 1.000000 1138 1138 1.000000 1139 1139 1.000000 1140 1140 1.000000 1141 1141 1.000000 1142 1142 1.000000 1143 1143 1.000000 1144 1144 1.000000 1145 1145 1.000000 1146 1146 1.000000 1147 1147 1.000000 1148 1148 1.000000 1149 1149 1.000000 1150 1150 1.000000 1151 1151 1.000000 1152 1152 1.000000 1153 1153 1.000000 1154 1154 1.000000 1155 1155 1.000000 1156 1156 1.000000 1157 1157 1.000000 1158 1158 1.000000 1159 1159 1.000000 1160 1160 1.000000 1161 1161 1.000000 1162 1162 1.000000 1163 1163 1.000000 1164 1164 1.000000 1165 1165 1.000000 1166 1166 1.000000 1167 1167 1.000000 1168 1168 1.000000 1169 1169 1.000000 1170 1170 1.000000 1171 1171 1.000000 1172 1172 1.000000 1173 1173 1.000000 1174 1174 1.000000 1175 1175 1.000000 1176 1176 1.000000 1177 1177 1.000000 1178 1178 1.000000 1179 1179 1.000000 1180 1180 1.000000 1181 1181 1.000000 1182 1182 1.000000 1183 1183 1.000000 1184 1184 1.000000 1185 1185 1.000000 1186 1186 1.000000 1187 1187 1.000000 1188 1188 1.000000 1189 1189 1.000000 1190 1190 1.000000 1191 1191 1.000000 1192 1192 1.000000 1193 1193 1.000000 1194 1194 1.000000 1195 1195 1.000000 1196 1196 1.000000 1197 1197 1.000000 1198 1198 1.000000 1199 1199 1.000000 1200 1200 1.000000 1201 1201 1.000000 1202 1202 1.000000 1203 1203 1.000000 1204 1204 1.000000 1205 1205 1.000000 1206 1206 1.000000 1207 1207 1.000000 1208 1208 1.000000 1209 1209 1.000000 1210 1210 1.000000 1211 1211 1.000000 1212 1212 1.000000 1213 1213 1.000000 1214 1214 1.000000 1215 1215 1.000000 1216 1216 1.000000 1217 1217 1.000000 1218 1218 1.000000 1219 1219 1.000000 1220 1220 1.000000 1221 1221 1.000000 1222 1222 1.000000 1223 1223 1.000000 1224 1224 1.000000 1225 1225 1.000000 1226 1226 1.000000 1227 1227 1.000000 1228 1228 1.000000 1229 1229 1.000000 1230 1230 1.000000 1231 1231 1.000000 1232 1232 1.000000 1233 1233 1.000000 1234 1234 1.000000 1235 1235 1.000000 1236 132 -1.518568 1236 1236 199.839450 1236 1237 -133.706900 1236 1238 -226.018000 1236 1239 -0.502966 1236 1240 1.542181 1236 1241 2.606903 1236 1284 -1.921350 1237 1237 -28.933988 1237 1238 26.839463 1237 1241 -0.309248 1238 132 -0.094695 1238 133 -0.909913 1238 134 -1.538115 1238 1236 0.261037 1238 1237 2.090714 1238 1238 3.534142 1238 1239 -0.030283 1238 1240 -0.636564 1238 1241 -1.076047 1238 1284 -0.056301 1238 1285 -0.541028 1238 1286 -0.914553 1239 135 -1.302073 1239 1236 -0.183076 1239 1239 189.932610 1239 1240 -130.587670 1239 1241 -220.745390 1239 1242 -0.304212 1239 1243 0.768041 1239 1244 1.298295 1239 1287 -1.704141 1239 2343 -2.597142 1239 2344 6.781374 1239 2345 11.463234 1240 1240 -29.175140 1240 1241 28.144064 1240 1244 -0.167928 1240 2345 -1.098958 1241 135 -0.057589 1241 136 -1.210663 1241 137 -2.046506 1241 1236 -0.030283 1241 1237 -0.636564 1241 1238 -1.076047 1241 1239 0.395131 1241 1240 4.075732 1241 1241 6.889617 1241 1242 -0.017632 1241 1243 -0.687517 1241 1244 -1.162178 1241 1287 -0.030139 1241 1288 -0.633645 1241 1289 -1.071114 1241 2343 -0.179884 1241 2344 -0.904106 1241 2345 -1.528301 1242 138 -0.854651 1242 1239 -0.159094 1242 1242 177.378880 1242 1243 -121.691480 1242 1244 -205.707140 1242 1245 -0.217251 1242 1246 0.390354 1242 1247 0.659855 1242 1290 -0.977841 1242 2346 -1.564624 1242 2347 5.734223 1242 2348 9.693123 1243 1243 -28.598581 1243 1244 27.549954 1243 1247 -0.089776 1243 2348 -1.094218 1244 138 -0.037800 1244 139 -1.474060 1244 140 -2.491750 1244 1239 -0.017632 1244 1240 -0.687517 1244 1241 -1.162178 1244 1242 0.257859 1244 1243 4.939112 1244 1244 8.349069 1244 1245 -0.009796 1244 1246 -0.721869 1244 1247 -1.220248 1244 1290 -0.017294 1244 1291 -0.674449 1244 1292 -1.140088 1244 2346 -0.095840 1244 2347 -1.378043 1244 2348 -2.329442 1245 141 -0.812870 1245 1242 -0.109920 1245 1245 165.300780 1245 1246 -113.835670 1245 1247 -192.427820 1245 1293 -0.542845 1245 2349 -0.991099 1245 2350 4.960127 1245 2351 8.384599 1246 1246 -27.734053 1246 1247 26.733771 1246 2351 -1.081235 1247 141 -0.023820 1247 142 -1.755319 1247 143 -2.967192 1247 1242 -0.009796 1247 1243 -0.721869 1247 1244 -1.220248 1247 1245 0.171011 1247 1246 5.044328 1247 1247 8.526932 1247 1293 -0.009601 1247 1294 -0.707545 1247 1295 -1.196033 1247 2349 -0.048389 1247 2350 -1.856517 1247 2351 -3.138256 1248 1248 1.000000 1249 1249 1.000000 1250 1250 1.000000 1251 1251 1.000000 1252 1252 1.000000 1253 1253 1.000000 1254 1254 1.000000 1255 1255 1.000000 1256 1256 1.000000 1257 1257 1.000000 1258 1258 1.000000 1259 1259 1.000000 1260 1260 1.000000 1261 1261 1.000000 1262 1262 1.000000 1263 159 -0.881433 1263 1263 273.726380 1263 1264 -178.212730 1263 1265 -301.250800 1263 1266 -0.155701 1263 1267 0.006683 1263 1268 0.011297 1263 1311 -0.971510 1263 2367 -1.059846 1263 2368 4.320226 1263 2369 7.302910 1264 1264 -46.024490 1264 1265 41.622307 1264 1268 -0.001361 1264 2369 -0.848535 1265 159 -0.015589 1265 160 -1.037506 1265 161 -1.753800 1265 1263 0.186753 1265 1264 4.017098 1265 1265 6.790501 1265 1266 -0.017256 1265 1267 -0.924296 1265 1268 -1.562430 1265 1311 -0.017182 1265 1312 -1.143580 1265 1313 -1.933108 1265 2367 -0.056946 1265 2368 -0.906602 1265 2369 -1.532520 1266 162 -1.277025 1266 1263 -0.310634 1266 1266 274.296680 1266 1267 -176.467570 1266 1268 -298.300620 1266 1269 -0.425286 1266 1270 0.352035 1266 1271 0.595080 1266 1314 -2.324615 1267 1267 -43.113782 1267 1268 38.450812 1267 1271 -0.070253 1268 162 -0.037421 1268 163 -0.836888 1268 164 -1.414675 1268 1263 -0.017256 1268 1264 -0.924296 1268 1265 -1.562430 1268 1266 0.226629 1268 1267 3.545411 1268 1268 5.993160 1268 1269 -0.050896 1268 1270 -0.859932 1268 1271 -1.453628 1268 1314 -0.041112 1268 1315 -0.919507 1268 1316 -1.554333 1269 165 -1.040707 1269 1266 -0.459246 1269 1269 274.999710 1269 1270 -176.699330 1269 1271 -298.692550 1269 1272 -0.435228 1269 1273 0.372769 1269 1274 0.630128 1269 1317 -2.863732 1270 1270 -42.206845 1270 1271 37.696049 1270 1274 -0.074396 1271 165 -0.046029 1271 166 -0.777765 1271 167 -1.314734 1271 1266 -0.050896 1271 1267 -0.859932 1271 1268 -1.453628 1271 1269 0.278453 1271 1270 3.358200 1271 1271 5.676700 1271 1272 -0.050886 1271 1273 -0.859976 1271 1274 -1.453703 1271 1317 -0.050647 1271 1318 -0.855840 1271 1319 -1.446711 1272 168 -1.039792 1272 1269 -0.373159 1272 1272 274.941060 1272 1273 -176.827480 1272 1274 -298.908940 1272 1275 -0.428469 1272 1276 0.531788 1272 1277 0.898934 1272 1320 -1.728679 1273 1273 -42.207454 1273 1274 37.723230 1273 1277 -0.110453 1274 168 -0.045989 1274 169 -0.777278 1274 170 -1.313910 1274 1269 -0.050886 1274 1270 -0.859976 1274 1271 -1.453703 1274 1272 0.265925 1274 1273 3.431556 1274 1274 5.800699 1274 1275 -0.038400 1274 1276 -0.933415 1274 1277 -1.577845 1274 1320 -0.050655 1274 1321 -0.856200 1274 1322 -1.447319 1275 171 -1.219980 1275 1272 -0.281592 1275 1275 268.945470 1275 1276 -174.151710 1275 1277 -294.386050 1275 1278 -0.486751 1275 1279 1.605341 1275 1280 2.713666 1275 1323 -1.305489 1276 1276 -42.499768 1276 1277 38.216679 1276 1280 -0.350201 1277 171 -0.035749 1277 172 -0.869064 1277 173 -1.469066 1277 1272 -0.038400 1277 1273 -0.933415 1277 1274 -1.577845 1277 1275 0.217945 1277 1276 3.724749 1277 1277 6.296315 1277 1278 -0.025633 1277 1279 -0.987525 1277 1280 -1.669312 1277 1323 -0.038255 1277 1324 -0.930025 1277 1325 -1.572114 1278 174 -0.905541 1278 1275 -0.231290 1278 1278 253.453770 1278 1279 -167.083460 1278 1280 -282.437660 1278 1281 -0.328328 1278 1282 0.771007 1278 1283 1.303310 1278 1326 -1.429034 1278 2382 -1.639650 1278 2383 5.050454 1278 2384 8.537282 1279 1279 -41.094302 1279 1280 37.822306 1279 1283 -0.175837 1279 2384 -0.863327 1280 174 -0.026535 1280 175 -1.022372 1280 176 -1.728216 1280 1275 -0.025633 1280 1276 -0.987525 1280 1277 -1.669312 1280 1278 0.277835 1280 1279 4.769201 1280 1280 8.061852 1280 1281 -0.014599 1280 1282 -1.015154 1280 1283 -1.716015 1280 1326 -0.025273 1280 1327 -0.973818 1280 1328 -1.646141 1280 2382 -0.106018 1280 2383 -0.765767 1280 2384 -1.294453 1281 177 -1.012375 1281 1278 -0.163810 1281 1281 230.612260 1281 1282 -152.473580 1281 1283 -257.741340 1281 1284 -0.458826 1281 1329 -0.813619 1281 2385 -0.930514 1281 2386 4.095518 1281 2387 6.923064 1282 1282 -38.737952 1282 1283 35.691370 1282 2387 -0.845216 1283 177 -0.017904 1283 178 -1.245084 1283 179 -2.104691 1283 1278 -0.014599 1283 1279 -1.015154 1283 1280 -1.716015 1283 1281 0.190554 1283 1282 5.396347 1283 1283 9.121984 1283 1284 -0.013445 1283 1285 -0.934927 1283 1286 -1.580400 1283 1329 -0.014389 1283 1330 -1.000716 1283 1331 -1.691610 1283 2385 -0.050588 1283 2386 -1.196163 1283 2387 -2.021995 1284 180 -0.498179 1284 1236 -2.665440 1284 1237 11.613324 1284 1238 19.631152 1284 1281 -0.276841 1284 1282 0.033672 1284 1283 0.056919 1284 1284 215.170230 1284 1285 -137.847310 1284 1286 -233.016940 1284 1287 -0.200946 1284 1288 1.563150 1284 1289 2.642349 1284 1332 -0.579939 1284 2388 -0.847189 1284 2389 4.291387 1284 2390 7.254155 1285 1238 -2.066449 1285 1283 -0.007679 1285 1285 -37.353073 1285 1286 33.533235 1285 1289 -0.383856 1285 2390 -0.956043 1286 180 -0.008811 1286 181 -1.514404 1286 182 -2.559947 1286 1236 -0.056301 1286 1237 -0.541028 1286 1238 -0.914553 1286 1281 -0.013445 1286 1282 -0.934927 1286 1283 -1.580400 1286 1284 0.113976 1286 1285 6.636171 1286 1286 11.217779 1286 1287 -0.002823 1286 1288 -1.048694 1286 1289 -1.772712 1286 1332 -0.006053 1286 1333 -1.040412 1286 1334 -1.758712 1286 2388 -0.025903 1286 2389 -1.552556 1286 2390 -2.624439 1287 183 -0.267653 1287 1239 -2.025736 1287 1240 12.447368 1287 1241 21.041031 1287 1284 -0.096336 1287 1287 197.795590 1287 1288 -127.621790 1287 1289 -215.731870 1287 1290 -0.158970 1287 1291 2.008849 1287 1292 3.395756 1287 1335 -0.266229 1287 2391 -0.447128 1287 2392 1.730214 1287 2393 2.924754 1288 1241 -2.496025 1288 1288 -35.250430 1288 1289 31.772134 1288 1292 -0.507141 1288 2393 -0.413359 1289 183 -0.004734 1289 184 -1.758612 1289 185 -2.972758 1289 1239 -0.030139 1289 1240 -0.633645 1289 1241 -1.071114 1289 1284 -0.002823 1289 1285 -1.048694 1289 1286 -1.772712 1289 1287 0.053736 1289 1288 7.425063 1289 1289 12.551325 1289 1290 -0.001888 1289 1291 -0.991846 1289 1292 -1.676616 1289 1335 -0.002778 1289 1336 -1.032339 1289 1337 -1.745066 1289 2391 -0.010827 1289 2392 -1.956009 1289 2393 -3.306438 1290 186 -0.359639 1290 1242 -1.519096 1290 1243 11.326966 1290 1244 19.147090 1290 1287 -0.106741 1290 1290 180.412580 1290 1291 -116.783760 1290 1292 -197.411110 1290 1293 -0.118922 1290 1294 1.552477 1290 1295 2.624306 1290 1338 -0.177810 1290 2394 -0.293662 1290 2395 1.328996 1290 2396 2.246533 1291 1244 -2.476580 1291 1291 -32.598054 1291 1292 29.396479 1291 1295 -0.397851 1291 2396 -0.334552 1292 186 -0.003753 1292 187 -1.972124 1292 188 -3.333675 1292 1242 -0.017294 1292 1243 -0.674449 1292 1244 -1.140088 1292 1287 -0.001888 1292 1288 -0.991846 1292 1289 -1.676616 1292 1290 0.033488 1292 1291 7.800052 1292 1292 13.185199 1292 1293 -0.001388 1292 1294 -0.934796 1292 1295 -1.580180 1292 1338 -0.001856 1292 1339 -0.975122 1292 1340 -1.648345 1292 2394 -0.006823 1292 2395 -2.248092 1292 2396 -3.800172 1293 189 -0.303637 1293 1245 -1.073606 1293 1246 10.369892 1293 1247 17.529266 1293 1290 -0.078485 1293 1293 168.915090 1293 1294 -108.429970 1293 1295 -183.290030 1293 1341 -0.132410 1293 2397 -0.384613 1293 2398 1.490501 1293 2399 2.519544 1294 1247 -2.384920 1294 1294 -30.770477 1294 1295 27.455917 1294 2399 -0.368471 1295 189 -0.003169 1295 190 -2.134217 1295 191 -3.607681 1295 1245 -0.009601 1295 1246 -0.707545 1295 1247 -1.196033 1295 1290 -0.001388 1295 1291 -0.934796 1295 1292 -1.580180 1295 1293 0.022089 1295 1294 7.151812 1295 1295 12.089422 1295 1341 -0.001382 1295 1342 -0.930779 1295 1343 -1.573388 1295 2397 -0.006101 1295 2398 -2.441055 1295 2399 -4.126359 1296 1296 1.000000 1297 1297 1.000000 1298 1298 1.000000 1299 1299 1.000000 1300 1300 1.000000 1301 1301 1.000000 1302 1302 1.000000 1303 1303 1.000000 1304 1304 1.000000 1305 1305 1.000000 1306 1306 1.000000 1307 1307 1.000000 1308 1308 1.000000 1309 1309 1.000000 1310 1310 1.000000 1311 207 -0.245210 1311 1263 -1.595362 1311 1264 15.256565 1311 1265 25.789698 1311 1311 272.230710 1311 1312 -173.176940 1311 1313 -292.738290 1311 1314 -0.159989 1311 1359 -0.270155 1311 2415 -0.309678 1311 2416 1.783478 1311 2417 3.014791 1312 1265 -3.456469 1312 1312 -49.368972 1312 1313 43.512859 1312 2417 -0.433023 1313 207 -0.002559 1313 208 -1.299896 1313 209 -2.197344 1313 1263 -0.017182 1313 1264 -1.143580 1313 1265 -1.933108 1313 1311 0.032932 1313 1312 6.751195 1313 1313 11.412219 1313 1314 -0.002829 1313 1315 -1.437131 1313 1316 -2.429327 1313 1359 -0.002819 1313 1360 -1.432232 1313 1361 -2.421044 1313 2415 -0.006803 1313 2416 -1.432864 1313 2417 -2.422113 1314 210 -0.276363 1314 1266 -2.344756 1314 1267 14.043798 1314 1268 23.739623 1314 1311 -0.172107 1314 1312 0.491974 1314 1313 0.831633 1314 1314 273.953100 1314 1315 -172.642440 1314 1316 -291.834550 1314 1317 -0.180431 1314 1362 -0.304784 1314 2418 -0.479744 1314 2419 2.827193 1314 2420 4.779083 1315 1268 -2.859892 1315 1313 -0.123910 1315 1315 -49.216982 1315 1316 43.218287 1315 2420 -0.681263 1316 210 -0.002884 1316 211 -1.286574 1316 212 -2.174823 1316 1266 -0.041112 1316 1267 -0.919507 1316 1268 -1.554333 1316 1311 -0.002829 1316 1312 -1.437131 1316 1313 -2.429327 1316 1314 0.063605 1316 1315 7.857381 1316 1316 13.282108 1316 1317 -0.003191 1316 1318 -1.423313 1316 1319 -2.405967 1316 1362 -0.003181 1316 1363 -1.418974 1316 1364 -2.398632 1316 2418 -0.009660 1316 2419 -1.366407 1316 2420 -2.309773 1317 213 -0.336833 1317 1269 -2.699987 1317 1270 13.811176 1317 1271 23.346412 1317 1314 -0.184389 1317 1315 0.162643 1317 1316 0.274931 1317 1317 274.810930 1317 1318 -172.812880 1317 1319 -292.122890 1317 1320 -0.154512 1317 1321 0.241812 1317 1322 0.408759 1317 1365 -0.371797 1317 2421 -0.534400 1317 2422 3.219766 1317 2423 5.442692 1318 1271 -2.756207 1318 1316 -0.040570 1318 1318 -48.921717 1318 1319 42.950807 1318 1322 -0.060805 1318 2423 -0.750848 1319 213 -0.003515 1319 214 -1.261418 1319 215 -2.132301 1319 1269 -0.050647 1319 1270 -0.855840 1319 1271 -1.446711 1319 1314 -0.003191 1319 1315 -1.423313 1319 1316 -2.405967 1319 1317 0.078662 1319 1318 7.643173 1319 1319 12.920016 1319 1320 -0.004269 1319 1321 -1.383385 1319 1322 -2.338473 1319 1365 -0.003880 1319 1366 -1.392436 1319 1367 -2.353775 1319 2421 -0.012396 1319 2422 -1.321339 1319 2423 -2.233592 1320 216 -0.369426 1320 1272 -2.736330 1320 1273 13.998636 1320 1274 23.663276 1320 1317 -0.241388 1320 1320 273.495790 1320 1321 -172.765440 1320 1322 -292.042510 1320 1323 -0.177520 1320 1324 0.750676 1320 1325 1.268943 1320 1368 -0.407783 1320 2424 -0.582376 1320 2425 3.209121 1320 2426 5.424694 1321 1274 -2.793805 1321 1321 -48.774953 1321 1322 42.945063 1321 1325 -0.188799 1321 2426 -0.729756 1322 216 -0.003855 1322 217 -1.249434 1322 218 -2.112042 1322 1272 -0.050655 1322 1273 -0.856200 1322 1274 -1.447319 1322 1317 -0.004269 1322 1318 -1.383385 1322 1319 -2.338473 1322 1320 0.082507 1322 1321 7.545682 1322 1322 12.755213 1322 1323 -0.004257 1322 1324 -1.383562 1322 1325 -2.338773 1322 1368 -0.004256 1322 1369 -1.379243 1322 1370 -2.331471 1322 2424 -0.014443 1322 2425 -1.288434 1322 2426 -2.177967 1323 219 -0.368191 1323 1275 -2.392778 1323 1276 14.529641 1323 1277 24.560905 1323 1320 -0.145264 1323 1323 273.065770 1323 1324 -173.404120 1323 1325 -293.122330 1323 1326 -0.213513 1323 1327 1.121132 1323 1328 1.895160 1323 1371 -0.406750 1323 2427 -0.548701 1323 2428 2.663259 1323 2429 4.501973 1324 1277 -3.017821 1324 1324 -48.777713 1324 1325 43.110071 1324 1328 -0.278730 1324 2429 -0.605644 1325 219 -0.003843 1325 220 -1.249054 1325 221 -2.111401 1325 1275 -0.038255 1325 1276 -0.930025 1325 1277 -1.572114 1325 1320 -0.004257 1325 1321 -1.383562 1325 1322 -2.338773 1325 1323 0.069052 1325 1324 7.625224 1325 1325 12.889677 1325 1326 -0.003247 1325 1327 -1.389334 1325 1328 -2.348528 1325 1371 -0.004245 1325 1372 -1.379939 1325 1373 -2.332650 1325 2427 -0.014434 1325 2428 -1.287886 1325 2429 -2.177042 1326 222 -0.298889 1326 1278 -2.043189 1326 1279 15.172454 1326 1280 25.647495 1326 1323 -0.110804 1326 1326 262.181260 1326 1327 -167.772980 1326 1328 -283.603250 1326 1329 -0.144529 1326 1330 1.629768 1326 1331 2.754961 1326 1374 -0.310381 1326 2430 -0.340951 1326 2431 1.299477 1326 2432 2.196636 1327 1280 -3.309836 1327 1327 -47.196986 1327 1328 41.945986 1327 1331 -0.420138 1327 2432 -0.309574 1328 222 -0.003119 1328 223 -1.334860 1328 224 -2.256445 1328 1278 -0.025273 1328 1279 -0.973818 1328 1280 -1.646141 1328 1323 -0.003247 1328 1324 -1.389334 1328 1325 -2.348528 1328 1326 0.045701 1328 1327 7.918147 1328 1328 13.384829 1328 1329 -0.001805 1328 1330 -1.366247 1328 1331 -2.309504 1328 1374 -0.003239 1328 1375 -1.386267 1328 1376 -2.343345 1328 2430 -0.008297 1328 2431 -1.462372 1328 2432 -2.471992 1329 225 -0.186759 1329 1281 -1.480018 1329 1282 14.324093 1329 1283 24.213447 1329 1326 -0.102066 1329 1329 244.862540 1329 1330 -157.747930 1329 1331 -266.657100 1329 1332 -0.113007 1329 1333 2.083003 1329 1334 3.521106 1329 1377 -0.170847 1329 2433 -0.295049 1329 2434 1.184203 1329 2435 2.001777 1330 1283 -3.266775 1330 1330 -41.064603 1330 1331 46.264109 1330 1334 -0.532151 1330 2435 -0.289675 1331 225 -0.001949 1331 226 -1.475347 1331 227 -2.493926 1331 1281 -0.014389 1331 1282 -1.000716 1331 1283 -1.691610 1331 1326 -0.001805 1331 1327 -1.366247 1331 1328 -2.309504 1331 1329 0.026183 1331 1330 8.150742 1331 1331 13.778014 1331 1332 -0.000955 1331 1333 -1.293603 1331 1334 -2.186705 1331 1377 -0.001783 1331 1378 -1.349733 1331 1379 -2.281588 1331 2433 -0.004654 1331 2434 -1.660118 1331 2435 -2.806263 1332 228 -0.117569 1332 1284 -0.748431 1332 1285 12.460168 1332 1286 21.062655 1332 1329 -0.054021 1332 1332 222.783560 1332 1333 -144.551200 1332 1334 -244.349210 1332 1335 -0.079318 1332 1336 2.550029 1332 1337 4.310569 1332 1380 -0.090344 1332 2436 -0.220194 1332 2437 1.111985 1332 2438 1.879698 1333 1286 -2.959741 1333 1333 -41.118626 1333 1334 36.879671 1333 1337 -0.668743 1333 2438 -0.281781 1334 228 -0.001227 1334 229 -1.661456 1334 230 -2.808524 1334 1284 -0.006053 1334 1285 -1.040412 1334 1286 -1.758712 1334 1329 -0.000955 1334 1330 -1.293603 1334 1331 -2.186705 1334 1332 0.013701 1334 1333 8.386635 1334 1334 14.176761 1334 1335 -0.000557 1334 1336 -1.220782 1334 1337 -2.063611 1334 1380 -0.000943 1334 1381 -1.276815 1334 1382 -2.158327 1334 2436 -0.003396 1334 2437 -1.888992 1334 2438 -3.193149 1335 231 -0.080340 1335 1287 -0.450624 1335 1288 11.194629 1335 1289 18.923400 1335 1332 -0.053377 1335 1335 205.934010 1335 1336 -133.892360 1335 1337 -226.331640 1335 1338 -0.061814 1335 1339 2.885494 1335 1340 4.877635 1335 1383 -0.052630 1335 2439 -0.156347 1335 2440 0.798596 1335 2441 1.349947 1336 1289 -2.749017 1336 1336 -38.434575 1336 1337 34.516930 1336 1340 -0.768328 1336 2441 -0.204220 1337 231 -0.000838 1337 232 -1.837569 1337 233 -3.106227 1337 1287 -0.002778 1337 1288 -1.032339 1337 1289 -1.745066 1337 1332 -0.000557 1337 1333 -1.220782 1337 1334 -2.063611 1337 1335 0.007119 1337 1336 8.568902 1337 1337 14.484871 1337 1338 -0.000338 1337 1339 -1.145250 1337 1340 -1.935929 1337 1383 -0.000549 1337 1384 -1.203840 1337 1385 -2.034972 1337 2439 -0.001547 1337 2440 -2.124845 1337 2441 -3.591837 1338 234 -0.057366 1338 1290 -0.358051 1338 1291 9.668961 1338 1292 16.344398 1338 1335 -0.032430 1338 1338 189.493530 1338 1339 -122.951360 1338 1340 -207.836830 1338 1341 -0.039817 1338 1342 2.849603 1338 1343 4.816969 1338 1386 -0.031941 1338 2442 -0.127706 1338 2443 0.671867 1338 2444 1.135723 1339 1292 -2.440966 1339 1339 -35.577035 1339 1340 31.890305 1339 1343 -0.772932 1339 2444 -0.174866 1340 234 -0.000599 1340 235 -2.025941 1340 236 -3.424648 1340 1290 -0.001856 1340 1291 -0.975122 1340 1292 -1.648345 1340 1335 -0.000338 1340 1336 -1.145250 1340 1337 -1.935929 1340 1338 0.004961 1340 1339 8.714197 1340 1340 14.730469 1340 1341 -0.000113 1340 1342 -1.087564 1340 1343 -1.838419 1340 1386 -0.000333 1340 1387 -1.128097 1340 1388 -1.906933 1340 2442 -0.001262 1340 2443 -2.348264 1340 2444 -3.969503 1341 237 -0.035585 1341 1293 -0.288754 1341 1294 8.056114 1341 1295 13.618055 1341 1338 -0.010791 1341 1341 178.430310 1341 1342 -112.102070 1341 1343 -189.497330 1341 1389 -0.010611 1341 2445 -0.085011 1341 2446 0.629183 1341 2447 1.063571 1342 1295 -2.064527 1342 1342 -33.750151 1342 1343 29.257887 1342 2447 -0.167099 1343 237 -0.000010 1343 238 -2.188966 1343 239 -3.700229 1343 1293 -0.001382 1343 1294 -0.930779 1343 1295 -1.573388 1343 1338 -0.000113 1343 1339 -1.087564 1343 1340 -1.838419 1343 1341 0.002859 1343 1342 7.822530 1343 1343 13.223205 1343 1389 -0.000111 1343 1390 -1.069595 1343 1391 -1.808043 1343 2445 -0.000821 1343 2446 -2.541870 1343 2447 -4.296778 1344 1344 1.000000 1345 1345 1.000000 1346 1346 1.000000 1347 1347 1.000000 1348 1348 1.000000 1349 1349 1.000000 1350 1350 1.000000 1351 1351 1.000000 1352 1352 1.000000 1353 1353 1.000000 1354 1354 1.000000 1355 1355 1.000000 1356 1356 1.000000 1357 1357 1.000000 1358 1358 1.000000 1359 255 -0.019741 1359 1311 -0.532505 1359 1312 14.275476 1359 1313 24.131264 1359 1359 270.466630 1359 1360 -171.895190 1359 1361 -290.571620 1359 1362 -0.033909 1359 1407 -0.033845 1359 2463 -0.098766 1359 2464 0.953137 1359 2465 1.611183 1360 1313 -3.595468 1360 1360 -46.745499 1360 1361 51.757860 1360 2465 -0.247367 1361 255 -0.000008 1361 256 -1.426136 1361 257 -2.410741 1361 1311 -0.002819 1361 1312 -1.432232 1361 1313 -2.421044 1361 1359 0.005115 1361 1360 7.663963 1361 1361 12.955162 1361 1362 -0.000354 1361 1363 -1.582759 1361 1364 -2.675496 1361 1407 -0.000353 1361 1408 -1.579929 1361 1409 -2.670712 1361 2463 -0.000930 1361 2464 -1.637231 1361 2465 -2.767574 1362 258 -0.005120 1362 1314 -0.550277 1362 1315 14.143033 1362 1316 23.907365 1362 1359 -0.037652 1362 1360 0.366243 1362 1361 0.619097 1362 1362 270.604960 1362 1363 -172.285860 1362 1364 -291.231770 1362 1365 -0.049716 1362 1410 -0.049607 1362 2466 -0.117061 1362 2467 1.076642 1362 2468 1.819955 1363 1316 -3.527911 1363 1361 -0.098194 1363 1363 -50.782874 1363 1364 44.566443 1363 2468 -0.276454 1364 258 -0.000008 1364 259 -1.411688 1364 260 -2.386316 1364 1314 -0.003181 1364 1315 -1.418974 1364 1316 -2.398632 1364 1359 -0.000354 1364 1360 -1.582759 1364 1361 -2.675496 1364 1362 0.006347 1364 1363 9.168995 1364 1364 15.499259 1364 1365 -0.000519 1364 1366 -1.566579 1364 1367 -2.648142 1364 1410 -0.000518 1364 1411 -1.563319 1364 1412 -2.642632 1364 2466 -0.001107 1364 2467 -1.620021 1364 2468 -2.738482 1365 261 -0.066178 1365 1317 -0.596990 1365 1318 14.403206 1365 1319 24.347179 1365 1362 -0.054179 1365 1363 0.436546 1365 1364 0.737937 1365 1365 270.888870 1365 1366 -172.675780 1365 1367 -291.891140 1365 1368 -0.073436 1365 1413 -0.073231 1365 2469 -0.120190 1365 2470 1.106324 1365 2471 1.870129 1366 1319 -3.525265 1366 1364 -0.115845 1366 1366 -50.522390 1366 1367 44.401261 1366 2471 -0.288300 1367 261 -0.000691 1367 262 -1.390058 1367 263 -2.349753 1367 1317 -0.003880 1367 1318 -1.392436 1367 1319 -2.353775 1367 1362 -0.000519 1367 1363 -1.566579 1367 1364 -2.648142 1367 1365 0.008925 1367 1366 9.025045 1367 1367 15.255934 1367 1368 -0.000766 1367 1369 -1.542398 1367 1370 -2.607269 1367 1413 -0.000764 1367 1414 -1.538263 1367 1415 -2.600280 1367 2469 -0.001629 1367 2470 -1.589686 1367 2471 -2.687205 1368 264 -0.073306 1368 1320 -0.765819 1368 1321 14.291331 1368 1322 24.158050 1368 1365 -0.075229 1368 1366 0.176036 1368 1367 0.297571 1368 1368 271.020690 1368 1369 -173.093850 1368 1370 -292.597670 1368 1371 -0.093439 1368 1372 0.413684 1368 1373 0.699292 1368 1416 -0.081142 1368 2472 -0.139911 1368 2473 1.053118 1368 2474 1.780189 1369 1322 -3.593630 1369 1367 -0.045989 1369 1369 -50.435532 1369 1370 44.420332 1369 1373 -0.106940 1369 2474 -0.271979 1370 264 -0.000765 1370 265 -1.382738 1370 266 -2.337379 1370 1320 -0.004256 1370 1321 -1.379243 1370 1322 -2.331471 1370 1365 -0.000766 1370 1366 -1.542398 1370 1367 -2.607269 1370 1368 0.010248 1370 1369 8.942069 1370 1370 15.115667 1370 1371 -0.000931 1370 1372 -1.526023 1370 1373 -2.579590 1370 1416 -0.000847 1370 1417 -1.530604 1370 1418 -2.587332 1370 2472 -0.002002 1370 2473 -1.575446 1370 2474 -2.663132 1371 267 -0.080442 1371 1323 -0.781122 1371 1324 14.659879 1371 1325 24.781060 1371 1368 -0.089237 1371 1371 271.071500 1371 1372 -173.851720 1371 1373 -293.878950 1371 1374 -0.075844 1371 1375 1.013710 1371 1376 1.713575 1371 1419 -0.089023 1371 2475 -0.157171 1371 2476 0.910049 1371 2477 1.538348 1372 1325 -3.687047 1372 1372 -50.348460 1372 1373 44.526891 1372 1376 -0.266225 1372 2477 -0.232916 1373 267 -0.000840 1373 268 -1.375697 1373 269 -2.325478 1373 1323 -0.004245 1373 1324 -1.379939 1373 1325 -2.332650 1373 1368 -0.000931 1373 1369 -1.526023 1373 1370 -2.579590 1373 1371 0.010688 1373 1372 8.921560 1373 1373 15.081003 1373 1374 -0.000684 1373 1375 -1.550218 1373 1376 -2.620486 1373 1419 -0.000929 1373 1420 -1.522509 1373 1421 -2.573649 1373 2475 -0.002374 1373 2476 -1.561568 1373 2477 -2.639675 1374 270 -0.059008 1374 1326 -0.577190 1374 1327 15.059125 1374 1328 25.455928 1374 1371 -0.065512 1374 1374 270.771480 1374 1375 -174.288900 1374 1376 -294.617730 1374 1377 -0.058312 1374 1378 1.697512 1374 1379 2.869474 1374 1422 -0.065386 1374 2478 -0.130413 1374 2479 0.744067 1374 2480 1.257770 1375 1328 -3.743923 1375 1375 -50.608681 1375 1376 44.916084 1375 1379 -0.452639 1375 2480 -0.189022 1376 270 -0.000616 1376 271 -1.396409 1376 272 -2.360487 1376 1326 -0.003239 1376 1327 -1.386267 1376 1328 -2.343345 1376 1371 -0.000684 1376 1372 -1.550218 1376 1373 -2.620486 1376 1374 0.007602 1376 1375 9.013271 1376 1376 15.236023 1376 1377 -0.000428 1376 1378 -1.525225 1376 1379 -2.578241 1376 1422 -0.000682 1376 1423 -1.547405 1376 1424 -2.615731 1376 2478 -0.001282 1376 2479 -1.602111 1376 2480 -2.708207 1377 273 -0.013840 1377 1329 -0.472033 1377 1330 14.196280 1377 1331 23.997392 1377 1374 -0.041027 1377 1377 254.255030 1377 1378 -164.917760 1377 1379 -278.776990 1377 1380 -0.034338 1377 1381 2.364468 1377 1382 3.996894 1377 1425 -0.040960 1377 2481 -0.108002 1377 2482 0.697585 1377 2483 1.179198 1378 1331 -3.659658 1378 1378 -47.810756 1378 1379 42.765198 1378 1382 -0.643236 1378 2483 -0.180385 1379 273 -0.000008 1379 274 -1.508930 1379 275 -2.550695 1379 1329 -0.001783 1379 1330 -1.349733 1379 1331 -2.281588 1379 1374 -0.000428 1379 1375 -1.525225 1379 1376 -2.578241 1379 1377 0.004424 1379 1378 9.107025 1379 1379 15.394514 1379 1380 -0.000107 1379 1381 -1.459653 1379 1382 -2.467395 1379 1425 -0.000427 1379 1426 -1.522914 1379 1427 -2.574334 1379 2481 -0.001053 1379 2482 -1.735247 1379 2483 -2.933261 1380 276 -0.045514 1380 1332 -0.226810 1380 1333 13.404257 1380 1334 22.658544 1380 1377 -0.010247 1380 1380 237.829660 1380 1381 -154.804890 1380 1382 -261.682040 1380 1383 -0.044043 1380 1384 3.014811 1380 1385 5.096236 1380 1428 -0.010124 1380 2484 -0.072670 1380 2485 0.609343 1380 2486 1.030032 1381 1334 -3.424427 1381 1381 -45.058371 1381 1382 40.473282 1381 1385 -0.825646 1381 2486 -0.161168 1382 276 -0.000008 1382 277 -1.644991 1382 278 -2.780692 1382 1332 -0.000943 1382 1333 -1.276815 1382 1334 -2.158327 1382 1377 -0.000107 1382 1378 -1.459653 1382 1379 -2.467395 1382 1380 0.002426 1382 1381 9.080460 1382 1382 15.349602 1382 1383 -0.000007 1382 1384 -1.354923 1382 1385 -2.290362 1382 1428 -0.000106 1382 1429 -1.442356 1382 1430 -2.438158 1382 2484 -0.000694 1382 2485 -1.896703 1382 2486 -3.206184 1383 279 -0.058361 1383 1335 -0.163286 1383 1336 12.028529 1383 1337 20.333025 1383 1380 -0.000659 1383 1383 216.127470 1383 1384 -141.902750 1383 1385 -239.872410 1383 1386 -0.058248 1383 1387 3.914268 1383 1388 6.616675 1383 1431 -0.000643 1383 2487 -0.001051 1383 2488 0.499406 1383 2489 0.844195 1384 1337 -3.154471 1384 1384 -41.054366 1384 1385 37.214192 1384 1388 -1.071987 1384 2489 -0.134655 1385 279 -0.000009 1385 280 -1.822437 1385 281 -3.080647 1385 1335 -0.000549 1385 1336 -1.203840 1385 1337 -2.034972 1385 1380 -0.000007 1385 1381 -1.354923 1385 1382 -2.290362 1385 1383 0.001094 1385 1384 9.078728 1385 1385 15.346681 1385 1386 -0.000006 1385 1387 -1.242885 1385 1388 -2.100971 1385 1431 -0.000007 1385 1432 -1.322312 1385 1433 -2.235236 1385 2487 -0.000011 1385 2488 -2.127758 1385 2489 -3.596762 1386 282 -0.059577 1386 1338 -0.109177 1386 1339 10.289212 1386 1340 17.392873 1386 1383 -0.000591 1386 1386 199.967900 1386 1387 -133.854250 1386 1388 -226.267070 1386 1389 -0.093439 1386 1390 6.964126 1386 1391 11.772159 1386 1434 -0.000575 1386 2490 -0.001111 1386 2491 0.380413 1386 2492 0.643049 1387 1340 -2.739737 1387 1387 -37.975522 1387 1388 35.133565 1387 1391 -1.907273 1387 2492 -0.104182 1388 282 -0.000010 1388 283 -1.970592 1388 284 -3.331087 1388 1338 -0.000333 1388 1339 -1.128097 1388 1340 -1.906933 1388 1383 -0.000006 1388 1384 -1.242885 1388 1385 -2.100971 1388 1386 0.000839 1388 1387 9.038509 1388 1388 15.278686 1388 1389 -0.000005 1388 1390 -1.145652 1388 1391 -1.936611 1388 1434 -0.000006 1388 1435 -1.209887 1388 1436 -2.045192 1388 2490 -0.000012 1388 2491 -2.337165 1388 2492 -3.950741 1389 285 -0.059780 1389 1341 -0.023449 1389 1342 5.814167 1389 1343 9.828268 1389 1386 -0.000525 1389 1389 183.697620 1389 1390 -113.148110 1389 1391 -191.265560 1389 2493 -0.001167 1389 2494 0.371386 1389 2495 0.627791 1390 1343 -1.577045 1390 1390 -34.895594 1390 1391 29.589117 1390 2495 -0.101712 1391 285 -0.000010 1391 286 -2.145576 1391 287 -3.626882 1391 1341 -0.000111 1391 1342 -1.069595 1391 1343 -1.808043 1391 1386 -0.000005 1391 1387 -1.145652 1391 1388 -1.936611 1391 1389 0.000568 1391 1390 6.909406 1391 1391 11.679659 1391 2493 -0.000012 1391 2494 -2.544696 1391 2495 -4.301554 1392 1392 1.000000 1393 1393 1.000000 1394 1394 1.000000 1395 1395 1.000000 1396 1396 1.000000 1397 1397 1.000000 1398 1398 1.000000 1399 1399 1.000000 1400 1400 1.000000 1401 1401 1.000000 1402 1402 1.000000 1403 1403 1.000000 1404 1404 1.000000 1405 1405 1.000000 1406 1406 1.000000 1407 303 -0.055206 1407 1359 -0.153775 1407 1360 14.741648 1407 1361 24.919282 1407 1407 270.064660 1407 1408 -172.594160 1407 1409 -291.753170 1407 1410 -0.000833 1407 1455 -0.000830 1407 2511 -0.000891 1407 2512 0.612420 1407 2513 1.035235 1408 1361 -3.952417 1408 1408 -47.092408 1408 1409 52.338123 1408 2513 -0.165668 1409 303 -0.000008 1409 304 -1.458242 1409 305 -2.465013 1409 1359 -0.000353 1409 1360 -1.579929 1409 1361 -2.670712 1409 1407 0.001019 1409 1408 7.981249 1409 1409 13.491503 1409 1410 -0.000009 1409 1411 -1.617043 1409 1412 -2.733450 1409 1455 -0.000009 1409 1456 -1.611960 1409 1457 -2.724858 1409 2511 -0.000009 1409 2512 -1.708351 1409 2513 -2.887796 1410 306 -0.055120 1410 1362 -0.188162 1410 1363 15.021144 1410 1364 25.391720 1410 1407 -0.023272 1410 1408 0.650426 1410 1409 1.099480 1410 1410 270.064620 1410 1411 -173.448240 1410 1412 -293.196720 1410 1413 -0.000838 1410 1458 -0.000835 1410 2514 -0.000897 1410 2515 0.681539 1410 2516 1.152073 1411 1364 -3.986130 1411 1409 -0.178123 1411 1411 -51.330777 1411 1412 45.408629 1411 2516 -0.182495 1412 306 -0.000008 1412 307 -1.458976 1412 308 -2.466251 1412 1362 -0.000518 1412 1363 -1.563319 1412 1364 -2.642632 1412 1407 -0.000009 1412 1408 -1.617043 1412 1409 -2.733450 1412 1410 0.001192 1412 1411 9.565780 1412 1412 16.169985 1412 1413 -0.000009 1412 1414 -1.617072 1412 1415 -2.733497 1412 1458 -0.000009 1412 1459 -1.611772 1412 1460 -2.724537 1412 2514 -0.000009 1412 2515 -1.691876 1412 2516 -2.859945 1413 309 -0.053672 1413 1365 -0.232176 1413 1366 15.619168 1413 1367 26.402642 1413 1410 -0.025816 1413 1411 1.043971 1413 1412 1.764727 1413 1413 270.125960 1413 1414 -174.246250 1413 1415 -294.545860 1413 1416 -0.002311 1413 1461 -0.002303 1413 2517 -0.062840 1413 2518 0.740867 1413 2519 1.252361 1414 1367 -4.080522 1414 1412 -0.285896 1414 1414 -51.313295 1414 1415 45.613128 1414 2519 -0.196347 1415 309 -0.000008 1415 310 -1.458317 1415 311 -2.465140 1415 1365 -0.000764 1415 1366 -1.538263 1415 1367 -2.600280 1415 1410 -0.000009 1415 1411 -1.617072 1415 1412 -2.733497 1415 1413 0.002039 1415 1414 9.520356 1415 1415 16.093208 1415 1416 -0.000024 1415 1417 -1.615606 1415 1418 -2.731020 1415 1461 -0.000024 1415 1462 -1.610040 1415 1463 -2.721612 1415 2517 -0.000578 1415 2518 -1.675338 1415 2519 -2.831991 1416 312 -0.046163 1416 1368 -0.246531 1416 1369 16.251500 1416 1370 27.471520 1416 1413 -0.010518 1416 1414 0.805567 1416 1415 1.361731 1416 1416 270.179490 1416 1417 -174.635750 1416 1418 -295.204080 1416 1419 -0.010217 1416 1464 -0.010180 1416 2520 -0.071349 1416 2521 0.748089 1416 2522 1.264569 1417 1370 -4.223402 1417 1415 -0.220402 1417 1417 -51.226801 1417 1418 45.626707 1417 2522 -0.197234 1418 312 -0.000008 1418 313 -1.450162 1418 314 -2.451353 1418 1368 -0.000847 1418 1369 -1.530604 1418 1370 -2.587332 1418 1413 -0.000024 1418 1414 -1.615606 1418 1415 -2.731020 1418 1416 0.002394 1418 1417 9.477172 1418 1418 16.020203 1418 1419 -0.000107 1418 1420 -1.607488 1418 1421 -2.717295 1418 1464 -0.000106 1418 1465 -1.601910 1418 1466 -2.707867 1418 2520 -0.000666 1418 2521 -1.665693 1418 2522 -2.815685 1419 315 -0.039117 1419 1371 -0.259061 1419 1372 16.708277 1419 1373 28.243671 1419 1416 -0.010675 1419 1417 0.044262 1419 1418 0.074820 1419 1419 270.227190 1419 1420 -175.279660 1419 1421 -296.292740 1419 1422 -0.020434 1419 1423 1.003971 1419 1424 1.697111 1419 1467 -0.018055 1419 2523 -0.079485 1419 2524 0.715693 1419 2525 1.209808 1420 1373 -4.319193 1420 1418 -0.012049 1420 1420 -51.139888 1420 1421 45.709042 1420 1424 -0.273308 1420 2525 -0.187710 1421 315 -0.000008 1421 316 -1.442837 1421 317 -2.438972 1421 1371 -0.000929 1421 1372 -1.522509 1421 1373 -2.573649 1421 1416 -0.000107 1421 1417 -1.607488 1421 1418 -2.717295 1421 1419 0.002734 1421 1420 9.436686 1421 1421 15.951770 1421 1422 -0.000107 1421 1423 -1.607328 1421 1424 -2.717025 1421 1467 -0.000188 1421 1468 -1.593823 1421 1469 -2.694198 1421 2523 -0.000754 1421 2524 -1.657002 1421 2525 -2.800996 1422 318 -0.046988 1422 1374 -0.235601 1422 1375 16.724953 1422 1376 28.271838 1422 1419 -0.010211 1422 1422 270.179700 1422 1423 -176.216070 1422 1424 -297.875450 1422 1425 -0.033836 1422 1426 1.831802 1422 1427 3.096478 1422 1470 -0.010175 1422 2526 -0.070592 1422 2527 0.675206 1422 2528 1.141367 1423 1376 -4.392381 1423 1423 -51.226311 1423 1424 46.058279 1423 1427 -0.501648 1423 2528 -0.178020 1424 318 -0.000008 1424 319 -1.450448 1424 320 -2.451836 1424 1374 -0.000682 1424 1375 -1.547405 1424 1376 -2.615731 1424 1419 -0.000107 1424 1420 -1.607328 1424 1421 -2.717025 1424 1422 0.002214 1424 1423 9.495309 1424 1424 16.050862 1424 1425 -0.000009 1424 1426 -1.616475 1424 1427 -2.732490 1424 1470 -0.000106 1424 1471 -1.601910 1424 1472 -2.707867 1424 2526 -0.000666 1424 2527 -1.666034 1424 2528 -2.816262 1425 321 -0.056476 1425 1377 -0.191271 1425 1378 16.134038 1425 1379 27.272978 1425 1422 -0.000835 1425 1425 270.096680 1425 1426 -176.388040 1425 1427 -298.166340 1425 1428 -0.066564 1425 1429 2.561431 1425 1430 4.329840 1425 1473 -0.000833 1425 2529 -0.000894 1425 2530 0.581693 1425 2531 0.983293 1426 1379 -4.302112 1426 1426 -51.330268 1426 1427 46.214953 1426 1430 -0.701466 1426 2531 -0.155759 1427 321 -0.000008 1427 322 -1.458776 1427 323 -2.465915 1427 1377 -0.000427 1427 1378 -1.522914 1427 1379 -2.574334 1427 1422 -0.000009 1427 1423 -1.616475 1427 1424 -2.732490 1427 1425 0.001102 1427 1426 9.457362 1427 1427 15.986723 1427 1428 -0.000008 1427 1429 -1.549054 1427 1430 -2.618519 1427 1473 -0.000009 1427 1474 -1.612436 1427 1475 -2.725662 1427 2529 -0.000009 1427 2530 -1.691985 1427 2531 -2.860131 1428 324 -0.057097 1428 1380 -0.111799 1428 1381 14.912651 1428 1382 25.208332 1428 1425 -0.000788 1428 1428 248.539260 1428 1429 -162.953950 1428 1430 -275.457190 1428 1431 -0.058069 1428 1432 2.741661 1428 1433 4.634503 1428 1476 -0.000763 1428 2532 -0.000956 1428 2533 0.464518 1428 2534 0.785221 1429 1382 -4.056874 1429 1429 -47.227537 1429 1430 42.694757 1429 1433 -0.750827 1429 2534 -0.127211 1430 324 -0.000008 1430 325 -1.584564 1430 326 -2.678545 1430 1380 -0.000106 1430 1381 -1.442356 1430 1382 -2.438158 1430 1425 -0.000008 1430 1426 -1.549054 1430 1427 -2.618519 1430 1428 0.000729 1430 1429 9.381003 1430 1430 15.857638 1430 1431 -0.000007 1430 1432 -1.419835 1430 1433 -2.400088 1430 1476 -0.000008 1430 1477 -1.500528 1430 1478 -2.536490 1430 2532 -0.000010 1430 2533 -1.879401 1430 2534 -3.176937 1431 327 -0.057996 1431 1383 -0.082149 1431 1384 13.969117 1431 1385 23.613395 1431 1428 -0.000715 1431 1431 226.911150 1431 1432 -149.009340 1431 1433 -251.885390 1431 1434 -0.044447 1431 1435 2.294259 1431 1436 3.878212 1431 1479 -0.000698 1431 2535 -0.001037 1431 2536 0.436219 1431 2537 0.737384 1432 1385 -3.825630 1432 1432 -43.123039 1432 1433 39.038658 1432 1436 -0.628305 1432 2537 -0.119462 1433 327 -0.000009 1433 328 -1.736001 1433 329 -2.934535 1433 1383 -0.000007 1433 1384 -1.322312 1433 1385 -2.235236 1433 1428 -0.000007 1433 1429 -1.419835 1433 1430 -2.400088 1433 1431 0.000578 1433 1432 9.219164 1433 1433 15.584074 1433 1434 -0.000007 1433 1435 -1.290339 1433 1436 -2.181188 1433 1479 -0.000007 1433 1480 -1.387146 1433 1481 -2.344831 1433 2535 -0.000011 1433 2536 -2.058723 1433 2537 -3.480066 1434 330 -0.058561 1434 1386 -0.090194 1434 1387 14.440091 1434 1388 24.409514 1434 1431 -0.000644 1434 1434 205.294530 1434 1435 -134.596750 1434 1436 -227.522180 1434 1482 -0.000628 1434 2538 -0.001136 1434 2539 0.452153 1434 2540 0.764319 1435 1388 -3.954655 1435 1435 -39.017438 1435 1436 35.257103 1435 2540 -0.123826 1436 330 -0.000010 1436 331 -1.918772 1436 332 -3.243489 1436 1386 -0.000006 1436 1387 -1.209887 1436 1388 -2.045192 1436 1431 -0.000007 1436 1432 -1.290339 1436 1433 -2.181188 1436 1434 0.000521 1436 1435 7.955726 1436 1436 13.448350 1436 1482 -0.000007 1436 1483 -1.256884 1436 1484 -2.124636 1436 2538 -0.000012 1436 2539 -2.275492 1436 2540 -3.846489 1437 1437 1.000000 1438 1438 1.000000 1439 1439 1.000000 1440 1440 1.000000 1441 1441 1.000000 1442 1442 1.000000 1443 1443 1.000000 1444 1444 1.000000 1445 1445 1.000000 1446 1446 1.000000 1447 1447 1.000000 1448 1448 1.000000 1449 1449 1.000000 1450 1450 1.000000 1451 1451 1.000000 1452 1452 1.000000 1453 1453 1.000000 1454 1454 1.000000 1455 351 -0.056169 1455 1407 -0.081983 1455 1408 15.723926 1455 1409 26.579724 1455 1455 270.018340 1455 1456 -173.866800 1455 1457 -293.904440 1455 1458 -0.000864 1455 1503 -0.000822 1455 2559 -0.000926 1455 2560 0.530999 1455 2561 0.897600 1456 1409 -4.306080 1456 1456 -47.111932 1456 1457 52.638811 1456 2561 -0.145414 1457 351 -0.000008 1457 352 -1.460362 1457 353 -2.468596 1457 1407 -0.000009 1457 1408 -1.611960 1457 1409 -2.724858 1457 1455 0.000675 1457 1456 7.967980 1457 1457 13.469073 1457 1458 -0.000009 1457 1459 -1.617465 1457 1460 -2.734163 1457 1503 -0.000009 1457 1504 -1.539562 1457 1505 -2.602475 1457 2559 -0.000010 1457 2560 -1.732900 1457 2561 -2.929294 1458 354 -0.055215 1458 1410 -0.078662 1458 1411 16.170540 1458 1412 27.334664 1458 1455 -0.019975 1458 1456 1.100416 1458 1457 1.860143 1458 1458 270.036740 1458 1459 -175.444050 1458 1460 -296.570460 1458 1461 -0.000867 1458 1506 -0.000844 1458 2562 -0.000928 1458 2563 0.572969 1458 2564 0.968546 1459 1412 -4.428374 1459 1457 -0.301349 1459 1459 -51.350908 1459 1460 45.905440 1459 2564 -0.156907 1460 354 -0.000008 1460 355 -1.460166 1460 356 -2.468263 1460 1410 -0.000009 1460 1411 -1.611772 1460 1412 -2.724537 1460 1455 -0.000009 1460 1456 -1.617465 1460 1457 -2.734163 1460 1458 0.000685 1460 1459 9.619876 1460 1460 16.261429 1460 1461 -0.000009 1460 1462 -1.617400 1460 1463 -2.734051 1460 1506 -0.000009 1460 1507 -1.575154 1460 1508 -2.662638 1460 2562 -0.000010 1460 2563 -1.732188 1460 2564 -2.928089 1461 357 -0.053683 1461 1413 -0.084097 1461 1414 17.189845 1461 1415 29.057715 1461 1458 -0.029835 1461 1459 2.069263 1461 1460 3.497881 1461 1461 270.067400 1461 1462 -177.504510 1461 1463 -300.053620 1461 1464 -0.000871 1461 1509 -0.000867 1461 2565 -0.000933 1461 2566 0.652848 1461 2567 1.103574 1462 1415 -4.703119 1462 1460 -0.566666 1462 1462 -51.350998 1462 1463 46.469243 1462 2567 -0.178781 1463 357 -0.000008 1463 358 -1.460094 1463 359 -2.468143 1463 1413 -0.000024 1463 1414 -1.610040 1463 1415 -2.721612 1463 1458 -0.000009 1463 1459 -1.617400 1463 1460 -2.734051 1463 1461 0.000701 1463 1462 9.652102 1463 1463 16.315911 1463 1464 -0.000009 1463 1465 -1.617388 1463 1466 -2.734033 1463 1509 -0.000009 1463 1510 -1.609802 1463 1511 -2.721210 1463 2565 -0.000010 1463 2566 -1.731647 1463 2567 -2.927176 1464 360 -0.052129 1464 1416 -0.119096 1464 1417 18.305960 1464 1418 30.944375 1464 1461 -0.036297 1464 1462 1.926275 1464 1463 3.256175 1464 1464 270.067650 1464 1465 -178.484220 1464 1466 -301.709460 1464 1467 -0.000877 1464 1512 -0.000874 1464 2568 -0.000940 1464 2569 0.757945 1464 2570 1.281230 1465 1418 -4.983360 1465 1463 -0.527508 1465 1465 -51.349972 1465 1466 46.739878 1465 2570 -0.207560 1466 360 -0.000008 1466 361 -1.460875 1466 362 -2.469460 1466 1416 -0.000106 1466 1417 -1.601910 1466 1418 -2.707867 1466 1461 -0.000009 1466 1462 -1.617388 1466 1463 -2.734033 1466 1464 0.000783 1466 1465 9.647286 1466 1466 16.307760 1466 1467 -0.000009 1466 1468 -1.617430 1466 1469 -2.734101 1466 1512 -0.000009 1466 1513 -1.611383 1466 1514 -2.723879 1466 2568 -0.000010 1466 2569 -1.732570 1466 2570 -2.928734 1467 363 -0.051377 1467 1419 -0.141919 1467 1420 19.000849 1467 1421 32.119036 1467 1464 -0.016337 1467 1465 0.741760 1467 1466 1.253870 1467 1467 270.071900 1467 1468 -178.958390 1467 1469 -302.511260 1467 1470 -0.018954 1467 1471 0.999028 1467 1472 1.688756 1467 1515 -0.000877 1467 2571 -0.000943 1467 2572 0.808856 1467 2573 1.367290 1468 1421 -5.146456 1468 1466 -0.203129 1468 1468 -51.349336 1468 1469 46.871070 1468 1472 -0.273582 1468 2573 -0.221501 1469 363 -0.000008 1469 364 -1.460863 1469 365 -2.469443 1469 1419 -0.000188 1469 1420 -1.593823 1469 1421 -2.694198 1469 1464 -0.000009 1469 1465 -1.617430 1469 1466 -2.734101 1469 1467 0.000865 1469 1468 9.639143 1469 1469 16.294003 1469 1470 -0.000009 1469 1471 -1.617368 1469 1472 -2.733998 1469 1515 -0.000009 1469 1516 -1.611376 1469 1517 -2.723869 1469 2571 -0.000010 1469 2572 -1.732554 1469 2573 -2.928709 1470 366 -0.051991 1470 1422 -0.126213 1470 1423 19.005981 1470 1424 32.127690 1470 1467 -0.000876 1470 1470 270.079450 1470 1471 -179.650180 1470 1472 -303.680460 1470 1473 -0.041060 1470 1474 2.394803 1470 1475 4.048174 1470 1518 -0.000873 1470 2574 -0.000939 1470 2575 0.765841 1470 2576 1.294577 1471 1424 -5.173942 1471 1471 -51.349843 1471 1472 47.059527 1471 1475 -0.655814 1471 2576 -0.209723 1472 366 -0.000008 1472 367 -1.460983 1472 368 -2.469644 1472 1422 -0.000106 1472 1423 -1.601910 1472 1424 -2.707867 1472 1467 -0.000009 1472 1468 -1.617368 1472 1469 -2.733998 1472 1470 0.000783 1472 1471 9.647657 1472 1472 16.308390 1472 1473 -0.000009 1472 1474 -1.617121 1472 1475 -2.733582 1472 1518 -0.000009 1472 1519 -1.611847 1472 1520 -2.724664 1472 2574 -0.000010 1472 2575 -1.732697 1472 2576 -2.928949 1473 369 -0.053475 1473 1425 -0.109773 1473 1426 18.456170 1473 1427 31.198310 1473 1470 -0.000870 1473 1473 270.088650 1473 1474 -179.769780 1473 1475 -303.882830 1473 1476 -0.061690 1473 1477 3.020031 1473 1478 5.105058 1473 1521 -0.000867 1473 2577 -0.000931 1473 2578 0.690522 1473 2579 1.167258 1474 1427 -5.054313 1474 1474 -51.350607 1474 1475 47.090596 1474 1478 -0.827036 1474 2579 -0.189098 1475 369 -0.000008 1475 370 -1.460347 1475 371 -2.468570 1475 1425 -0.000009 1475 1426 -1.612436 1475 1427 -2.725662 1475 1470 -0.000009 1475 1471 -1.617121 1475 1472 -2.733582 1475 1473 0.000685 1475 1474 9.606439 1475 1475 16.238723 1475 1476 -0.000009 1475 1477 -1.566770 1475 1478 -2.648466 1475 1521 -0.000009 1475 1522 -1.611892 1475 1523 -2.724742 1475 2577 -0.000010 1475 2578 -1.732143 1475 2579 -2.928014 1476 372 -0.054844 1476 1428 -0.107558 1476 1429 16.763446 1476 1430 28.336913 1476 1473 -0.000835 1476 1476 253.908400 1476 1477 -168.780180 1476 1478 -285.305840 1476 1479 -0.069079 1476 1480 3.228557 1476 1481 5.457553 1476 1524 -0.000825 1476 2580 -0.000982 1476 2581 0.663696 1476 2582 1.121911 1477 1430 -4.590788 1477 1477 -48.271778 1477 1478 44.204439 1477 1481 -0.884145 1477 2582 -0.181753 1478 372 -0.000009 1478 373 -1.552835 1478 374 -2.624910 1478 1428 -0.000008 1478 1429 -1.500528 1478 1430 -2.536490 1478 1473 -0.000009 1478 1474 -1.566770 1478 1475 -2.648466 1478 1476 0.000646 1478 1477 9.483929 1478 1478 16.031624 1478 1479 -0.000008 1478 1480 -1.469819 1478 1481 -2.484581 1478 1524 -0.000009 1478 1525 -1.547082 1478 1526 -2.615185 1478 2580 -0.000010 1478 2581 -1.841508 1478 2582 -3.112884 1479 375 -0.056319 1479 1431 -0.090980 1479 1432 15.127805 1479 1433 25.572042 1479 1476 -0.000776 1479 1479 237.706160 1479 1480 -156.883300 1479 1481 -265.195530 1479 1482 -0.047692 1479 1483 2.505882 1479 1484 4.235940 1479 1527 -0.000766 1479 2583 -0.001038 1479 2584 0.585322 1479 2585 0.989429 1480 1433 -4.142879 1480 1480 -45.193359 1480 1481 41.068716 1480 1484 -0.686243 1480 2585 -0.160292 1481 375 -0.000009 1481 376 -1.657390 1481 377 -2.801652 1481 1431 -0.000007 1481 1432 -1.387146 1481 1433 -2.344831 1481 1476 -0.000008 1481 1477 -1.469819 1481 1478 -2.484581 1481 1479 0.000606 1481 1480 9.290049 1481 1481 15.703897 1481 1482 -0.000007 1481 1483 -1.355413 1481 1484 -2.291188 1481 1527 -0.000008 1481 1528 -1.449741 1481 1529 -2.450642 1481 2583 -0.000011 1481 2584 -1.965496 1481 2585 -3.322474 1482 378 -0.057319 1482 1434 -0.081521 1482 1435 13.617892 1482 1436 23.019668 1482 1479 -0.000710 1482 1482 216.043540 1482 1483 -140.206910 1482 1484 -237.005610 1482 1530 -0.000684 1482 2586 -0.001135 1482 2587 0.546028 1482 2588 0.923005 1483 1436 -3.729391 1483 1483 -41.086240 1483 1484 36.671012 1483 2588 -0.149531 1484 378 -0.000010 1484 379 -1.826358 1484 380 -3.087274 1484 1434 -0.000007 1484 1435 -1.256884 1484 1436 -2.124636 1484 1479 -0.000007 1484 1480 -1.355413 1484 1481 -2.291188 1484 1482 0.000548 1484 1483 7.914309 1484 1484 13.378339 1484 1530 -0.000007 1484 1531 -1.305028 1484 1532 -2.206018 1484 2586 -0.000012 1484 2587 -2.166039 1484 2588 -3.661470 1485 1485 1.000000 1486 1486 1.000000 1487 1487 1.000000 1488 1488 1.000000 1489 1489 1.000000 1490 1490 1.000000 1491 1491 1.000000 1492 1492 1.000000 1493 1493 1.000000 1494 1494 1.000000 1495 1495 1.000000 1496 1496 1.000000 1497 1497 1.000000 1498 1498 1.000000 1499 1499 1.000000 1500 396 -0.057686 1500 1500 237.516000 1500 1501 -144.174440 1500 1502 -243.712300 1500 1503 -0.024458 1500 1504 4.857994 1500 1505 8.211954 1500 1548 -0.071538 1500 2604 -0.001125 1500 2605 0.539926 1500 2606 0.912690 1501 1501 -45.215223 1501 1502 37.533536 1501 1505 -1.330327 1501 2606 -0.147854 1502 396 -0.000010 1502 397 -1.671730 1502 398 -2.825890 1502 1500 0.000593 1502 1501 6.407039 1502 1502 10.830453 1502 1503 -0.000008 1502 1504 -1.455139 1502 1505 -2.459767 1502 1548 -0.000008 1502 1549 -1.289214 1502 1550 -2.179286 1502 2604 -0.000012 1502 2605 -1.985902 1502 2606 -3.356966 1503 399 -0.056046 1503 1455 -0.070526 1503 1456 16.653300 1503 1457 28.150739 1503 1500 -0.000813 1503 1503 248.364500 1503 1504 -162.319430 1503 1505 -274.384770 1503 1506 -0.000849 1503 1551 -0.006209 1503 2607 -0.001059 1503 2608 0.622625 1503 2609 1.052486 1504 1457 -4.560504 1504 1504 -47.264376 1504 1505 42.428957 1504 2609 -0.170502 1505 399 -0.000009 1505 400 -1.595325 1505 401 -2.696737 1505 1455 -0.000009 1505 1456 -1.539562 1505 1457 -2.602475 1505 1500 -0.000008 1505 1501 -1.455139 1505 1502 -2.459767 1505 1503 0.000635 1505 1504 9.380903 1505 1505 15.857478 1505 1506 -0.000009 1505 1507 -1.520008 1505 1508 -2.569421 1505 1551 -0.000008 1505 1552 -1.371211 1505 1553 -2.317896 1505 2607 -0.000011 1505 2608 -1.894376 1505 2609 -3.202254 1506 402 -0.053266 1506 1458 -0.078258 1506 1459 17.168040 1506 1460 29.020837 1506 1503 -0.024688 1506 1504 1.159114 1506 1505 1.959367 1506 1506 259.197590 1506 1507 -170.476200 1506 1508 -288.172790 1506 1509 -0.000889 1506 1554 -0.000826 1506 2610 -0.001016 1506 2611 0.796559 1506 2612 1.346502 1507 1460 -4.701458 1507 1505 -0.317415 1507 1507 -49.318400 1507 1508 44.577014 1507 2612 -0.218132 1508 402 -0.000009 1508 403 -1.527188 1508 404 -2.581557 1508 1458 -0.000009 1508 1459 -1.575154 1508 1460 -2.662638 1508 1503 -0.000009 1508 1504 -1.520008 1508 1505 -2.569421 1508 1506 0.000661 1508 1507 9.498793 1508 1508 16.056750 1508 1509 -0.000009 1508 1510 -1.584763 1508 1511 -2.678882 1508 1554 -0.000009 1508 1555 -1.473536 1508 1556 -2.490863 1508 2610 -0.000011 1508 2611 -1.812633 1508 2612 -3.064073 1509 405 -0.048975 1509 1461 -0.101910 1509 1462 19.220924 1509 1463 32.491049 1509 1506 -0.050848 1509 1507 3.676387 1509 1508 6.214560 1509 1509 270.040090 1509 1510 -181.611810 1509 1511 -306.996610 1509 1512 -0.000915 1509 1557 -0.000880 1509 2613 -0.000983 1509 2614 1.070897 1509 2615 1.810245 1510 1463 -5.263623 1510 1508 -1.006751 1510 1510 -51.373691 1510 1511 47.537372 1510 2615 -0.293256 1511 405 -0.000009 1511 406 -1.463582 1511 407 -2.474039 1511 1461 -0.000009 1511 1462 -1.609802 1511 1463 -2.721210 1511 1506 -0.000009 1511 1507 -1.584763 1511 1508 -2.678882 1511 1509 0.000687 1511 1510 9.574459 1511 1511 16.184664 1511 1512 -0.000010 1511 1513 -1.617810 1511 1514 -2.734746 1511 1557 -0.000009 1511 1558 -1.556120 1511 1559 -2.630466 1511 2613 -0.000010 1511 2614 -1.736640 1511 2615 -2.935616 1512 408 -0.043304 1512 1464 -0.114353 1512 1465 21.227252 1512 1466 35.882516 1512 1509 -0.048726 1512 1510 3.921812 1512 1511 6.629430 1512 1512 270.083090 1512 1513 -184.230160 1512 1514 -311.422500 1512 1515 -0.000924 1512 1560 -0.000918 1512 2616 -0.000989 1512 2617 1.433314 1512 2618 2.422873 1513 1466 -5.813032 1513 1511 -1.073953 1513 1513 -51.374787 1513 1514 48.251452 1513 2618 -0.392499 1514 408 -0.000009 1514 409 -1.460309 1514 410 -2.468505 1514 1464 -0.000009 1514 1465 -1.611383 1514 1466 -2.723879 1514 1509 -0.000010 1514 1510 -1.617810 1514 1511 -2.734746 1514 1512 0.000688 1514 1513 9.652496 1514 1514 16.316571 1514 1515 -0.000010 1514 1516 -1.617811 1514 1517 -2.734747 1514 1560 -0.000010 1514 1561 -1.607538 1514 1562 -2.717380 1514 2616 -0.000010 1514 2617 -1.731904 1514 2618 -2.927608 1515 411 -0.039838 1515 1467 -0.125970 1515 1468 22.368532 1515 1469 37.811766 1515 1512 -0.028042 1515 1513 1.887659 1515 1514 3.190898 1515 1515 270.075210 1515 1516 -184.800230 1515 1517 -312.386300 1515 1518 -0.021591 1515 1519 1.253331 1515 1520 2.118629 1515 1563 -0.000923 1515 2619 -0.000994 1515 2620 1.653146 1515 2621 2.794478 1516 1469 -6.125558 1516 1514 -0.516916 1516 1516 -51.374772 1516 1517 48.407342 1516 1520 -0.343211 1516 2621 -0.452696 1517 411 -0.000009 1517 412 -1.460307 1517 413 -2.468503 1517 1467 -0.000009 1517 1468 -1.611376 1517 1469 -2.723869 1517 1512 -0.000010 1517 1513 -1.617811 1517 1514 -2.734747 1517 1515 0.000689 1517 1516 9.653615 1517 1517 16.318467 1517 1518 -0.000010 1517 1519 -1.617813 1517 1520 -2.734749 1517 1563 -0.000010 1517 1564 -1.608668 1517 1565 -2.719292 1517 2619 -0.000010 1517 2620 -1.731899 1517 2621 -2.927602 1518 414 -0.041964 1518 1470 -0.123424 1518 1471 22.121760 1518 1472 37.394598 1518 1515 -0.000926 1518 1518 270.094100 1518 1519 -184.810190 1518 1520 -312.402960 1518 1521 -0.044702 1518 1522 3.526077 1518 1523 5.960480 1518 1566 -0.000922 1518 2622 -0.000991 1518 2623 1.520675 1518 2624 2.570547 1519 1472 -6.057994 1519 1519 -51.375126 1519 1520 48.409390 1519 1523 -0.965583 1519 2624 -0.416421 1520 414 -0.000009 1520 415 -1.459477 1520 416 -2.467098 1520 1470 -0.000009 1520 1471 -1.611847 1520 1472 -2.724664 1520 1515 -0.000010 1520 1516 -1.617813 1520 1517 -2.734749 1520 1518 0.000688 1520 1519 9.654011 1520 1520 16.319131 1520 1521 -0.000010 1520 1522 -1.617733 1520 1523 -2.734617 1520 1566 -0.000010 1520 1567 -1.610483 1520 1568 -2.722360 1520 2622 -0.000010 1520 2623 -1.730916 1520 2624 -2.925939 1521 417 -0.046530 1521 1473 -0.119844 1521 1474 20.995709 1521 1475 35.491147 1521 1518 -0.000918 1521 1521 270.089650 1521 1522 -184.318440 1521 1523 -311.571890 1521 1524 -0.064393 1521 1525 4.462845 1521 1526 7.543988 1521 1569 -0.000914 1521 2625 -0.000983 1521 2626 1.230218 1521 2627 2.079560 1522 1475 -5.749652 1522 1522 -51.374246 1522 1523 48.277121 1522 1526 -1.222116 1522 2627 -0.336884 1523 417 -0.000009 1523 418 -1.460429 1523 419 -2.468710 1523 1473 -0.000009 1523 1474 -1.611892 1523 1475 -2.724742 1523 1518 -0.000010 1523 1519 -1.617733 1523 1520 -2.734617 1523 1521 0.000688 1523 1522 9.640772 1523 1523 16.296759 1523 1524 -0.000009 1523 1525 -1.601131 1523 1526 -2.706549 1523 1569 -0.000010 1523 1570 -1.611757 1523 1571 -2.724514 1523 2625 -0.000010 1523 2626 -1.732089 1523 2627 -2.927923 1524 420 -0.050663 1524 1476 -0.113740 1524 1477 18.820856 1524 1478 31.814754 1524 1521 -0.000898 1524 1524 264.684630 1524 1525 -179.202480 1524 1526 -302.923650 1524 1527 -0.080444 1524 1528 4.924130 1524 1529 8.323748 1524 1572 -0.000895 1524 2628 -0.000992 1524 2629 0.970469 1524 2630 1.640479 1525 1478 -5.154093 1525 1525 -50.346702 1525 1526 46.920720 1525 1529 -1.348445 1525 2630 -0.265756 1526 420 -0.000009 1526 421 -1.491316 1526 422 -2.520918 1526 1476 -0.000009 1526 1477 -1.547082 1526 1478 -2.615185 1526 1521 -0.000009 1526 1522 -1.601131 1526 1523 -2.706549 1526 1524 0.000674 1526 1525 9.543328 1526 1526 16.132032 1526 1527 -0.000009 1526 1528 -1.534417 1526 1529 -2.593777 1526 1572 -0.000009 1526 1573 -1.595112 1526 1574 -2.696375 1526 2628 -0.000010 1526 2629 -1.768646 1526 2630 -2.989716 1527 423 -0.053707 1527 1479 -0.098725 1527 1480 16.168101 1527 1481 27.330557 1527 1524 -0.000849 1527 1527 248.465840 1527 1528 -166.547880 1527 1529 -281.532540 1527 1530 -0.092298 1527 1531 4.582814 1527 1532 7.746784 1527 1575 -0.000829 1527 2631 -0.001045 1527 2632 0.785464 1527 2633 1.327749 1528 1481 -4.427659 1528 1528 -47.265374 1528 1529 43.584773 1528 1532 -1.254987 1528 2633 -0.215095 1529 423 -0.000009 1529 424 -1.591578 1529 425 -2.690404 1529 1479 -0.000008 1529 1480 -1.449741 1529 1481 -2.450642 1529 1524 -0.000009 1529 1525 -1.534417 1529 1526 -2.593777 1529 1527 0.000634 1529 1528 9.368486 1529 1529 15.836487 1529 1530 -0.000008 1529 1531 -1.401581 1529 1532 -2.369231 1529 1575 -0.000009 1529 1576 -1.497985 1529 1577 -2.532195 1529 2631 -0.000011 1529 2632 -1.887902 1529 2633 -3.191310 1530 426 -0.055373 1530 1482 -0.048856 1530 1483 12.699265 1530 1484 21.466823 1530 1527 -0.000765 1530 1530 221.434500 1530 1531 -142.602980 1530 1532 -241.055940 1530 1578 -0.000739 1530 2634 -0.001155 1530 2635 0.680199 1530 2636 1.149807 1531 1484 -3.477728 1531 1531 -42.130994 1531 1532 37.240289 1531 2636 -0.186270 1532 426 -0.000010 1532 427 -1.783164 1532 428 -3.014258 1532 1482 -0.000007 1532 1483 -1.305028 1532 1484 -2.206018 1532 1527 -0.000008 1532 1528 -1.401581 1532 1529 -2.369231 1532 1530 0.000563 1532 1531 7.962591 1532 1532 13.459956 1532 1578 -0.000008 1532 1579 -1.353165 1532 1580 -2.287390 1532 2634 -0.000012 1532 2635 -2.114944 1532 2636 -3.575099 1533 1533 1.000000 1534 1534 1.000000 1535 1535 1.000000 1536 1536 1.000000 1537 1537 1.000000 1538 1538 1.000000 1539 1539 1.000000 1540 1540 1.000000 1541 1541 1.000000 1542 1542 1.000000 1543 1543 1.000000 1544 1544 1.000000 1545 1545 1.000000 1546 1546 1.000000 1547 1547 1.000000 1548 444 -0.057004 1548 1500 -0.000745 1548 1501 6.788696 1548 1502 11.475603 1548 1548 199.830260 1548 1549 -124.044510 1548 1550 -209.684700 1548 1551 -0.000719 1548 1596 -0.012626 1548 2652 -0.001360 1548 2653 0.597769 1548 2654 1.010468 1549 1502 -1.859022 1549 1549 -38.042021 1549 1550 32.281529 1549 2654 -0.163692 1550 444 -0.000012 1550 445 -1.980295 1550 446 -3.347488 1550 1500 -0.000008 1550 1501 -1.289214 1550 1502 -2.179286 1550 1548 0.000515 1550 1549 7.954609 1550 1550 13.446461 1550 1551 -0.000008 1550 1552 -1.243572 1550 1553 -2.102133 1550 1596 -0.000007 1550 1597 -1.085812 1550 1598 -1.835456 1550 2652 -0.000014 1550 2653 -2.351456 1550 2654 -3.974898 1551 447 -0.054500 1551 1503 -0.000795 1551 1504 12.566956 1551 1505 21.243182 1551 1548 -0.043887 1551 1549 0.697149 1551 1550 1.178460 1551 1551 215.975550 1551 1552 -140.180580 1551 1553 -236.961250 1551 1554 -0.000786 1551 1599 -0.009259 1551 2655 -0.001264 1551 2656 0.769652 1551 2657 1.301020 1552 1505 -3.441372 1552 1550 -0.190905 1552 1552 -41.122058 1552 1553 36.574131 1552 2657 -0.210759 1553 447 -0.000011 1553 448 -1.836874 1553 449 -3.105053 1553 1503 -0.000008 1553 1504 -1.371211 1553 1505 -2.317896 1553 1548 -0.000008 1553 1549 -1.243572 1553 1550 -2.102133 1553 1551 0.000561 1553 1552 9.192765 1553 1553 15.539449 1553 1554 -0.000008 1553 1555 -1.355902 1553 1556 -2.292017 1553 1599 -0.000008 1553 1600 -1.199531 1553 1601 -2.027687 1553 2655 -0.000013 1553 2656 -2.181072 1553 2657 -3.686883 1554 450 -0.048561 1554 1506 -0.038162 1554 1507 16.599150 1554 1508 28.059187 1554 1551 -0.061746 1554 1552 3.880938 1554 1553 6.560338 1554 1554 237.624070 1554 1555 -160.377330 1554 1556 -271.101610 1554 1557 -0.000862 1554 1602 -0.000768 1554 2658 -0.001160 1554 2659 1.153953 1554 2660 1.950640 1555 1508 -4.545551 1555 1553 -1.062745 1555 1555 -45.233550 1555 1556 41.924961 1555 2660 -0.315993 1556 450 -0.000010 1556 451 -1.667175 1556 452 -2.818189 1556 1506 -0.000009 1556 1507 -1.473536 1556 1508 -2.490863 1556 1551 -0.000008 1556 1552 -1.355902 1556 1553 -2.292017 1556 1554 0.000612 1556 1555 9.262179 1556 1556 15.656777 1556 1557 -0.000009 1556 1558 -1.470369 1556 1559 -2.485510 1556 1602 -0.000008 1556 1603 -1.310395 1556 1604 -2.215090 1556 2658 -0.000012 1556 2659 -1.979740 1556 2660 -3.346550 1557 453 -0.037939 1557 1509 -0.091980 1557 1510 20.880731 1557 1511 35.296787 1557 1554 -0.096017 1557 1555 6.576891 1557 1556 11.117568 1557 1557 253.870270 1557 1558 -177.534100 1557 1559 -300.103640 1557 1560 -0.000935 1557 1605 -0.000861 1557 2661 -0.001106 1557 2662 1.853671 1557 2663 3.133446 1558 1511 -5.717999 1558 1556 -1.800985 1558 1558 -48.317530 1558 1559 46.486840 1558 2663 -0.507596 1559 453 -0.000010 1559 454 -1.562151 1559 455 -2.640660 1559 1509 -0.000009 1559 1510 -1.556120 1559 1511 -2.630466 1559 1554 -0.000009 1559 1555 -1.470369 1559 1556 -2.485510 1559 1557 0.000652 1559 1558 9.461390 1559 1559 15.993531 1559 1560 -0.000010 1559 1561 -1.567735 1559 1562 -2.650099 1559 1605 -0.000009 1559 1606 -1.445193 1559 1607 -2.442954 1559 2661 -0.000012 1559 2662 -1.854414 1559 2663 -3.134701 1560 456 -0.023835 1560 1512 -0.160725 1560 1513 24.991137 1560 1514 42.244995 1560 1557 -0.111313 1560 1558 7.135452 1560 1559 12.061768 1560 1560 270.050980 1560 1561 -192.553530 1560 1562 -325.492300 1560 1563 -0.000982 1560 1608 -0.000954 1560 2664 -0.001057 1560 2665 2.734049 1560 2666 4.621634 1561 1514 -6.843558 1561 1559 -1.953918 1561 1561 -51.400549 1561 1562 50.465801 1561 2666 -0.748666 1562 456 -0.000009 1562 457 -1.468842 1562 458 -2.482929 1562 1512 -0.000010 1562 1513 -1.607538 1562 1514 -2.717380 1562 1557 -0.000010 1562 1558 -1.567735 1562 1559 -2.650099 1562 1560 0.000691 1562 1561 9.583857 1562 1562 16.200543 1562 1563 -0.000010 1562 1564 -1.618224 1562 1565 -2.735444 1562 1608 -0.000010 1562 1609 -1.573049 1562 1610 -2.659081 1562 2664 -0.000011 1562 2665 -1.742717 1562 2666 -2.945886 1563 459 -0.011792 1563 1515 -0.182190 1563 1516 27.107692 1563 1517 45.822842 1563 1560 -0.049570 1563 1561 3.999304 1563 1562 6.760419 1563 1563 270.052420 1563 1564 -194.544660 1563 1565 -328.858290 1563 1566 -0.024568 1563 1567 2.318963 1563 1568 3.919973 1563 1611 -0.000985 1563 2667 -0.001065 1563 2668 3.419078 1563 2669 5.779609 1564 1517 -7.423134 1564 1562 -1.095127 1564 1564 -51.401676 1564 1565 51.007865 1564 1568 -0.634999 1564 2669 -0.936243 1565 459 -0.000010 1565 460 -1.467191 1565 461 -2.480140 1565 1515 -0.000010 1565 1516 -1.608668 1565 1517 -2.719292 1565 1560 -0.000010 1565 1561 -1.618224 1565 1562 -2.735444 1565 1563 0.000692 1565 1564 9.667185 1565 1565 16.341406 1565 1566 -0.000010 1565 1567 -1.618159 1565 1568 -2.735334 1565 1611 -0.000010 1565 1612 -1.609145 1565 1613 -2.720099 1565 2667 -0.000011 1565 2668 -1.740045 1565 2669 -2.941372 1566 462 -0.020159 1566 1518 -0.179488 1566 1519 26.077818 1566 1520 44.081918 1566 1563 -0.000986 1566 1566 270.062750 1566 1567 -192.591450 1566 1568 -325.556390 1566 1569 -0.076562 1566 1570 5.876120 1566 1571 9.932994 1566 1614 -0.000979 1566 2670 -0.001058 1566 2671 2.952589 1566 2672 4.991052 1567 1520 -7.141127 1567 1567 -51.400420 1567 1568 50.476322 1567 1571 -1.609065 1567 2672 -0.808507 1568 462 -0.000009 1568 463 -1.464845 1568 464 -2.476172 1568 1518 -0.000010 1568 1519 -1.610483 1568 1520 -2.722360 1568 1563 -0.000010 1568 1564 -1.618159 1568 1565 -2.735334 1568 1566 0.000692 1568 1567 9.662694 1568 1568 16.333809 1568 1569 -0.000010 1568 1570 -1.617970 1568 1571 -2.735016 1568 1614 -0.000010 1568 1615 -1.608216 1568 1616 -2.718527 1568 2670 -0.000011 1568 2671 -1.737268 1568 2672 -2.936676 1569 465 -0.033098 1569 1521 -0.147929 1569 1522 23.757471 1569 1523 40.159629 1569 1566 -0.000972 1569 1569 270.102780 1569 1570 -190.428260 1569 1571 -321.899920 1569 1572 -0.094315 1569 1573 6.845753 1569 1574 11.572054 1569 1617 -0.000966 1569 2673 -0.001041 1569 2674 2.140252 1569 2675 3.617882 1570 1523 -6.505759 1570 1570 -51.399319 1570 1571 49.887176 1570 1574 -1.874598 1570 2675 -0.586069 1571 465 -0.000009 1571 466 -1.461849 1571 467 -2.471110 1571 1521 -0.000010 1571 1522 -1.611757 1571 1523 -2.724514 1571 1566 -0.000010 1571 1567 -1.617970 1571 1568 -2.735016 1571 1569 0.000691 1571 1570 9.656976 1571 1571 16.324150 1571 1572 -0.000010 1571 1573 -1.617381 1571 1574 -2.734019 1571 1617 -0.000010 1571 1618 -1.608543 1571 1619 -2.719082 1571 2673 -0.000011 1571 2674 -1.733724 1571 2675 -2.930687 1572 468 -0.043136 1572 1524 -0.117552 1572 1525 21.205997 1572 1526 35.846591 1572 1569 -0.000956 1572 1572 270.100580 1572 1573 -187.730390 1572 1574 -317.339280 1572 1575 -0.121339 1572 1576 7.370835 1572 1577 12.459659 1572 1620 -0.000951 1572 2676 -0.001026 1572 2677 1.487911 1572 2678 2.515162 1573 1526 -5.807100 1573 1573 -51.398707 1573 1574 49.150588 1573 1577 -2.018406 1573 2678 -0.407441 1574 468 -0.000009 1574 469 -1.462551 1574 470 -2.472294 1574 1524 -0.000009 1574 1525 -1.595112 1574 1526 -2.696375 1574 1569 -0.000010 1574 1570 -1.617381 1574 1571 -2.734019 1574 1572 0.000690 1574 1573 9.591453 1574 1574 16.213383 1574 1575 -0.000009 1574 1576 -1.567258 1574 1577 -2.649292 1574 1620 -0.000010 1574 1621 -1.608533 1574 1622 -2.719063 1574 2676 -0.000011 1574 2677 -1.734867 1574 2678 -2.932617 1575 471 -0.048718 1575 1527 -0.072953 1575 1528 17.675979 1575 1529 29.879475 1575 1572 -0.000909 1575 1575 253.954880 1575 1576 -178.415320 1575 1577 -301.593260 1575 1578 -0.147228 1575 1579 11.432940 1575 1580 19.326230 1575 1623 -0.000887 1575 2679 -0.001070 1575 2680 1.116155 1575 2681 1.886748 1576 1529 -4.840468 1576 1576 -48.316631 1576 1577 46.731329 1576 1580 -3.130818 1576 2681 -0.305645 1577 471 -0.000009 1577 472 -1.554243 1577 473 -2.627293 1577 1527 -0.000009 1577 1528 -1.497985 1577 1529 -2.532195 1577 1572 -0.000009 1577 1573 -1.567258 1577 1574 -2.649292 1577 1575 0.000650 1577 1576 9.450041 1577 1577 15.974347 1577 1578 -0.000009 1577 1579 -1.452992 1577 1580 -2.456137 1577 1623 -0.000009 1577 1624 -1.528770 1577 1625 -2.584233 1577 2679 -0.000011 1577 2680 -1.843384 1577 2681 -3.116056 1578 474 -0.053506 1578 1530 -0.017879 1578 1531 9.743246 1578 1532 16.469973 1578 1575 -0.000817 1578 1578 232.246780 1578 1579 -146.068830 1578 1580 -246.914590 1578 2682 -0.001133 1578 2683 0.802498 1578 2684 1.356542 1579 1532 -2.668153 1579 1579 -44.202421 1579 1580 38.060785 1579 2684 -0.219758 1580 474 -0.000010 1580 475 -1.699738 1580 476 -2.873235 1580 1530 -0.000008 1580 1531 -1.353165 1580 1532 -2.287390 1580 1575 -0.000009 1580 1576 -1.452992 1580 1577 -2.456137 1580 1578 0.000581 1580 1579 6.526519 1580 1580 11.032421 1580 2682 -0.000012 1580 2683 -2.015677 1580 2684 -3.407298 1581 1581 1.000000 1582 1582 1.000000 1583 1583 1.000000 1584 1584 1.000000 1585 1585 1.000000 1586 1586 1.000000 1587 1587 1.000000 1588 1588 1.000000 1589 1589 1.000000 1590 1590 1.000000 1591 1591 1.000000 1592 1592 1.000000 1593 1593 1.000000 1594 1594 1.000000 1595 1595 1.000000 1596 492 -0.056812 1596 1548 -0.000645 1596 1549 7.630599 1596 1550 12.898756 1596 1596 167.375650 1596 1597 -106.036730 1596 1598 -179.244370 1596 1599 -0.000632 1596 1644 -0.004377 1596 2700 -0.001663 1596 2701 0.638554 1596 2702 1.079411 1597 1550 -2.089544 1597 1597 -31.887467 1597 1598 27.588098 1597 2702 -0.174857 1598 492 -0.000015 1598 493 -2.358791 1598 494 -3.987297 1598 1548 -0.000007 1598 1549 -1.085812 1598 1550 -1.835456 1598 1596 0.000443 1598 1597 8.243541 1598 1598 13.934873 1598 1599 -0.000007 1598 1600 -1.064124 1598 1601 -1.798794 1598 1644 -0.000006 1598 1645 -0.931823 1598 1646 -1.575153 1598 2700 -0.000017 1598 2701 -2.799416 1598 2702 -4.732131 1599 495 -0.052066 1599 1551 -0.000720 1599 1552 11.021295 1599 1553 18.630397 1599 1596 -0.041727 1599 1597 2.895174 1599 1598 4.893999 1599 1599 189.021050 1599 1600 -125.235250 1599 1601 -211.697660 1599 1602 -0.000708 1599 1647 -0.000626 1599 2703 -0.001489 1599 2704 0.949573 1599 2705 1.605158 1600 1553 -3.018039 1600 1598 -0.792794 1600 1600 -36.002030 1600 1601 32.657959 1600 2705 -0.260023 1601 495 -0.000013 1601 496 -2.090224 1601 497 -3.533314 1601 1551 -0.000008 1601 1552 -1.199531 1601 1553 -2.027687 1601 1596 -0.000007 1601 1597 -1.064124 1601 1598 -1.798794 1601 1599 0.000499 1601 1600 9.060904 1601 1601 15.316551 1601 1602 -0.000007 1601 1603 -1.179203 1601 1604 -1.993324 1601 1647 -0.000007 1601 1648 -1.042570 1601 1649 -1.762361 1601 2703 -0.000016 1601 2704 -2.481216 1601 2705 -4.194248 1602 498 -0.039166 1602 1554 -0.038034 1602 1555 15.556959 1602 1556 26.297461 1602 1599 -0.095629 1602 1600 6.539285 1602 1601 11.054008 1602 1602 205.248860 1602 1603 -143.760790 1602 1604 -243.013080 1602 1605 -0.000800 1602 1650 -0.000709 1602 2706 -0.001402 1602 2707 1.812566 1602 2708 3.063961 1603 1556 -4.260044 1603 1601 -1.790660 1603 1603 -39.087761 1603 1604 37.590468 1603 2708 -0.496332 1604 498 -0.000012 1604 499 -1.927240 1604 500 -3.257804 1604 1554 -0.000008 1604 1555 -1.310395 1604 1556 -2.215090 1604 1599 -0.000007 1604 1600 -1.179203 1604 1601 -1.993324 1604 1602 0.000538 1604 1603 9.171260 1604 1604 15.503089 1604 1605 -0.000008 1604 1606 -1.305745 1604 1607 -2.207230 1604 1650 -0.000007 1604 1651 -1.156712 1604 1652 -1.955305 1604 2706 -0.000015 1604 2707 -2.287583 1604 2708 -3.866929 1605 501 -0.014348 1605 1557 -0.086572 1605 1558 21.809515 1605 1559 36.866804 1605 1602 -0.125571 1605 1603 10.042669 1605 1604 16.976116 1605 1605 232.330740 1605 1606 -170.832760 1605 1607 -288.775700 1605 1608 -0.000925 1605 1653 -0.000819 1605 2709 -0.001270 1605 2710 3.379837 1605 2711 5.713277 1606 1559 -5.972151 1606 1604 -2.749961 1606 1606 -44.233502 1606 1607 44.762455 1606 2711 -0.925480 1607 501 -0.000011 1607 502 -1.698078 1607 503 -2.870432 1607 1557 -0.000009 1607 1558 -1.445193 1607 1559 -2.442954 1607 1602 -0.000008 1607 1603 -1.305745 1607 1604 -2.207230 1607 1605 0.000603 1607 1606 9.237942 1607 1607 15.615816 1607 1608 -0.000010 1607 1609 -1.468191 1607 1610 -2.481830 1607 1653 -0.000009 1607 1654 -1.300302 1607 1655 -2.198030 1607 2709 -0.000013 1607 2710 -2.015473 1607 2711 -3.406955 1608 504 -0.000990 1608 1560 -0.147647 1608 1561 29.278995 1608 1562 49.493185 1608 1605 -0.154085 1608 1606 11.851465 1608 1607 20.033716 1608 1608 259.338620 1608 1609 -198.141940 1608 1610 -334.938880 1608 1611 -0.001029 1608 1656 -0.000959 1608 2712 -0.005064 1608 2713 5.612831 1608 2714 9.487922 1609 1562 -8.017450 1609 1607 -3.245201 1609 1609 -49.379196 1609 1610 51.999266 1609 2714 -1.536903 1610 504 -0.000010 1610 505 -1.525749 1610 506 -2.579124 1610 1560 -0.000010 1610 1561 -1.573049 1610 1562 -2.659081 1610 1605 -0.000010 1610 1606 -1.468191 1610 1607 -2.481830 1610 1608 0.000669 1610 1609 9.447918 1610 1610 15.970750 1610 1611 -0.000011 1610 1612 -1.585554 1610 1613 -2.680218 1610 1656 -0.000010 1610 1657 -1.479075 1610 1658 -2.500226 1610 2712 -0.000012 1610 2713 -1.810762 1610 2714 -3.060910 1611 507 -0.000965 1611 1563 -0.205907 1611 1564 34.093072 1611 1565 57.630928 1611 1608 -0.102668 1611 1609 7.999219 1611 1610 13.521870 1611 1611 270.219550 1611 1612 -213.050040 1611 1613 -360.139790 1611 1614 -0.043789 1611 1615 5.761893 1611 1616 9.739896 1611 1659 -0.001064 1611 2715 -0.024425 1611 2716 7.504940 1611 2717 12.686351 1612 1565 -9.335633 1612 1610 -2.190326 1612 1612 -51.438365 1612 1613 55.982322 1612 1616 -1.577702 1612 2717 -2.054981 1613 507 -0.000010 1613 508 -1.461315 1613 509 -2.470208 1613 1563 -0.000010 1613 1564 -1.609145 1613 1565 -2.720099 1613 1608 -0.000011 1613 1609 -1.585554 1613 1610 -2.680218 1613 1611 0.000696 1613 1612 9.624833 1613 1613 16.269814 1613 1614 -0.000011 1613 1615 -1.618660 1613 1616 -2.736180 1613 1659 -0.000011 1613 1660 -1.611363 1613 1661 -2.723848 1613 2715 -0.000012 1613 2716 -1.733026 1613 2717 -2.929508 1614 510 -0.000956 1614 1566 -0.186758 1614 1567 30.653316 1614 1568 51.816332 1614 1611 -0.001056 1614 1614 270.091410 1614 1615 -204.581470 1614 1616 -345.824250 1614 1617 -0.098287 1614 1618 10.345519 1614 1619 17.488065 1614 1662 -0.001050 1614 2718 -0.007591 1614 2719 5.863270 1614 2720 9.911268 1615 1568 -8.393759 1615 1615 -51.433248 1615 1616 53.676628 1615 1619 -2.832817 1615 2720 -1.605473 1616 510 -0.000010 1616 511 -1.465199 1616 512 -2.476771 1616 1566 -0.000010 1616 1567 -1.608216 1616 1568 -2.718527 1616 1611 -0.000011 1616 1612 -1.618660 1616 1613 -2.736180 1616 1614 0.000696 1616 1615 9.664438 1616 1616 16.336756 1616 1617 -0.000011 1616 1618 -1.618482 1616 1619 -2.735883 1616 1662 -0.000011 1616 1663 -1.610457 1616 1664 -2.722314 1616 2718 -0.000012 1616 2719 -1.737656 1616 2720 -2.937332 1617 513 -0.008014 1617 1569 -0.165253 1617 1570 26.218808 1617 1571 44.320273 1617 1614 -0.001032 1617 1617 270.038210 1617 1618 -197.231580 1617 1619 -333.400250 1617 1620 -0.121812 1617 1621 9.546213 1617 1622 16.136907 1617 1665 -0.001026 1617 2721 -0.001110 1617 2722 3.745776 1617 2723 6.331860 1618 1571 -7.179526 1618 1618 -51.426699 1618 1619 51.680985 1618 1622 -2.613987 1618 2723 -1.025676 1619 513 -0.000010 1619 514 -1.467869 1619 515 -2.481286 1619 1569 -0.000010 1619 1570 -1.608543 1619 1571 -2.719082 1619 1614 -0.000011 1619 1615 -1.618482 1619 1616 -2.735883 1619 1617 0.000695 1619 1618 9.669033 1619 1619 16.344532 1619 1620 -0.000011 1619 1621 -1.618040 1619 1622 -2.735132 1619 1665 -0.000011 1619 1666 -1.609487 1619 1667 -2.720677 1619 2721 -0.000012 1619 2722 -1.740848 1619 2723 -2.942729 1620 516 -0.030580 1620 1572 -0.137963 1620 1573 23.535825 1620 1574 39.784937 1620 1617 -0.001010 1620 1620 270.033690 1620 1621 -189.826290 1620 1622 -320.882120 1620 1623 -0.100110 1620 1624 6.227434 1620 1625 10.526854 1620 1668 -0.001005 1620 2724 -0.001087 1620 2725 2.339398 1620 2726 3.954516 1621 1574 -6.444904 1621 1621 -51.424648 1621 1622 49.659240 1621 1625 -1.705239 1621 2726 -0.640586 1622 516 -0.000010 1622 517 -1.468165 1622 518 -2.481784 1622 1572 -0.000010 1622 1573 -1.608533 1622 1574 -2.719063 1622 1617 -0.000011 1622 1618 -1.618040 1622 1619 -2.735132 1622 1620 0.000693 1622 1621 9.636586 1622 1622 16.289676 1622 1623 -0.000010 1622 1624 -1.584801 1622 1625 -2.678947 1622 1668 -0.000010 1622 1669 -1.609911 1622 1670 -2.721391 1622 2724 -0.000011 1622 2725 -1.741374 1622 2726 -2.943616 1623 519 -0.039998 1623 1575 -0.152912 1623 1576 23.550095 1623 1577 39.809080 1623 1620 -0.000975 1623 1623 259.203030 1623 1624 -176.664890 1623 1625 -298.634340 1623 1671 -0.000961 1623 2727 -0.001116 1623 2728 1.729024 1623 2729 2.922742 1624 1577 -6.448884 1624 1624 -49.368903 1624 1625 46.145579 1624 2729 -0.473454 1625 519 -0.000010 1625 520 -1.529225 1625 521 -2.585002 1625 1575 -0.000009 1625 1576 -1.528770 1625 1577 -2.584233 1625 1620 -0.000010 1625 1621 -1.584801 1625 1622 -2.678947 1625 1623 0.000657 1625 1624 8.023902 1625 1625 13.563604 1625 1671 -0.000010 1625 1672 -1.562102 1625 1673 -2.640576 1625 2727 -0.000012 1625 2728 -1.813471 1625 2729 -3.065492 1626 1626 1.000000 1627 1627 1.000000 1628 1628 1.000000 1629 1629 1.000000 1630 1630 1.000000 1631 1631 1.000000 1632 1632 1.000000 1633 1633 1.000000 1634 1634 1.000000 1635 1635 1.000000 1636 1636 1.000000 1637 1637 1.000000 1638 1638 1.000000 1639 1639 1.000000 1640 1640 1.000000 1641 1641 1.000000 1642 1642 1.000000 1643 1643 1.000000 1644 540 -0.057152 1644 1596 -0.000567 1644 1597 6.011660 1644 1598 10.162103 1644 1644 145.784670 1644 1645 -91.799685 1644 1646 -155.178110 1644 1647 -0.000560 1644 1692 -0.000500 1644 2748 -0.001949 1644 2749 0.631870 1644 2750 1.068112 1645 1598 -1.646190 1645 1645 -27.783778 1645 1646 23.849486 1645 2750 -0.173024 1646 540 -0.000017 1646 541 -2.699288 1646 542 -4.562874 1646 1596 -0.000006 1646 1597 -0.931823 1646 1598 -1.575153 1646 1644 0.000395 1646 1645 8.578646 1646 1646 14.501334 1646 1647 -0.000006 1646 1648 -0.920194 1646 1649 -1.555496 1646 1692 -0.000005 1646 1693 -0.821943 1646 1694 -1.389411 1646 2748 -0.000020 1646 2749 -3.202279 1646 2750 -5.413128 1647 543 -0.049122 1647 1599 -0.014988 1647 1600 8.714260 1647 1601 14.730585 1647 1644 -0.052525 1647 1645 4.257979 1647 1646 7.197684 1647 1647 162.026220 1647 1648 -108.770240 1647 1649 -183.865220 1647 1650 -0.000638 1647 1695 -0.000569 1647 2751 -0.001786 1647 2752 1.169802 1647 2753 1.977433 1648 1601 -2.386236 1648 1646 -1.165957 1648 1648 -30.872090 1648 1649 28.349994 1648 2753 -0.320322 1649 543 -0.000016 1649 544 -2.431426 1649 545 -4.110083 1649 1599 -0.000007 1649 1600 -1.042570 1649 1601 -1.762361 1649 1644 -0.000006 1649 1645 -0.920194 1649 1646 -1.555496 1649 1647 0.000438 1649 1648 9.232453 1649 1649 15.606538 1649 1650 -0.000007 1649 1651 -1.031303 1649 1652 -1.743314 1649 1695 -0.000006 1649 1696 -0.918639 1649 1697 -1.552867 1649 2751 -0.000019 1649 2752 -2.884855 1649 2753 -4.876560 1650 546 -0.026226 1650 1602 -0.042673 1650 1603 13.170317 1650 1604 22.263089 1650 1647 -0.106835 1650 1648 8.840541 1650 1649 14.944051 1650 1650 183.689700 1650 1651 -131.930410 1650 1652 -223.015010 1650 1653 -0.000741 1650 1698 -0.000658 1650 2754 -0.001630 1650 2755 2.687538 1650 2756 4.543011 1651 1604 -3.606397 1651 1649 -2.420769 1651 1651 -34.991172 1651 1652 34.492949 1651 2756 -0.735904 1652 546 -0.000014 1652 547 -2.150194 1652 548 -3.634685 1652 1602 -0.000007 1652 1603 -1.156712 1652 1604 -1.955305 1652 1647 -0.000007 1652 1648 -1.031303 1652 1649 -1.743314 1652 1650 0.000489 1652 1651 9.085569 1652 1652 15.358235 1652 1653 -0.000008 1652 1654 -1.161215 1652 1655 -1.962916 1652 1698 -0.000007 1652 1699 -1.030072 1652 1700 -1.741232 1652 2754 -0.000017 1652 2755 -2.552144 1652 2756 -4.314142 1653 549 -0.001284 1653 1605 -0.136014 1653 1606 20.530332 1653 1607 34.704472 1653 1650 -0.190266 1653 1651 14.042325 1653 1652 23.737128 1653 1653 205.302170 1653 1654 -160.669370 1653 1655 -271.595500 1653 1656 -0.000879 1653 1701 -0.000795 1653 2757 -0.011397 1653 2758 6.201041 1653 2759 10.482240 1654 1607 -5.621672 1654 1652 -3.845074 1654 1654 -39.109356 1654 1655 42.164769 1654 2759 -1.697934 1655 549 -0.000013 1655 550 -1.927240 1655 551 -3.257807 1655 1605 -0.000009 1655 1606 -1.300302 1655 1607 -2.198030 1655 1650 -0.000008 1655 1651 -1.161215 1655 1652 -1.962916 1655 1653 0.000543 1655 1654 9.192178 1655 1655 15.538456 1655 1656 -0.000009 1655 1657 -1.320021 1655 1658 -2.231364 1655 1701 -0.000008 1655 1702 -1.192726 1655 1703 -2.016184 1655 2757 -0.000016 1655 2758 -2.286282 1655 2759 -3.864731 1656 552 -0.001161 1656 1608 -0.212424 1656 1609 32.370162 1656 1610 54.718480 1656 1653 -0.190020 1656 1654 18.701559 1656 1655 31.613115 1656 1656 237.946100 1656 1657 -201.708990 1656 1658 -340.968640 1656 1659 -0.001058 1656 1704 -0.000957 1656 2760 -0.068802 1656 2761 11.863207 1656 2762 20.053552 1657 1610 -8.863517 1657 1655 -5.120722 1657 1657 -45.295405 1657 1658 53.084456 1657 2762 -3.248234 1658 552 -0.000012 1658 553 -1.662597 1658 554 -2.810452 1658 1608 -0.000010 1658 1609 -1.479075 1658 1610 -2.500226 1658 1653 -0.000009 1658 1654 -1.320021 1658 1655 -2.231364 1658 1656 0.000622 1658 1657 9.325863 1658 1658 15.764430 1658 1659 -0.000011 1658 1660 -1.515041 1658 1661 -2.561024 1658 1704 -0.000010 1658 1705 -1.370786 1658 1706 -2.317174 1658 2760 -0.000014 1658 2761 -1.973253 1658 2762 -3.335585 1659 555 -0.001060 1659 1611 -0.364152 1659 1612 45.035434 1659 1613 76.127896 1659 1656 -0.222899 1659 1657 16.827796 1659 1658 28.445687 1659 1659 270.559670 1659 1660 -252.969390 1659 1661 -427.619450 1659 1662 -0.184469 1659 1663 16.483139 1659 1664 27.863080 1659 1707 -0.001144 1659 2763 -0.119432 1659 2764 16.863026 1659 2765 28.505260 1660 1613 -12.331347 1660 1658 -4.607510 1660 1660 -51.474670 1660 1661 66.818708 1660 1664 -4.513131 1660 2765 -4.617140 1661 555 -0.000011 1661 556 -1.465065 1661 557 -2.476546 1661 1611 -0.000011 1661 1612 -1.611363 1661 1613 -2.723848 1661 1656 -0.000011 1661 1657 -1.515041 1661 1658 -2.561024 1661 1659 0.000701 1661 1660 9.534801 1661 1661 16.117624 1661 1662 -0.000012 1661 1663 -1.619186 1661 1664 -2.737070 1661 1707 -0.000012 1661 1708 -1.580477 1661 1709 -2.671639 1661 2763 -0.000013 1661 2764 -1.737883 1661 2765 -2.937718 1662 558 -0.001025 1662 1614 -0.224082 1662 1615 34.348042 1662 1616 58.061886 1662 1659 -0.001134 1662 1662 270.284620 1662 1663 -221.801810 1662 1664 -374.933540 1662 1665 -0.198380 1662 1666 18.634428 1662 1667 31.499637 1662 1710 -0.001131 1662 2766 -0.060944 1662 2767 11.099187 1662 2768 18.762053 1663 1616 -9.405063 1663 1663 -51.467914 1663 1664 58.303482 1663 1667 -5.102299 1663 2768 -3.039035 1664 558 -0.000011 1664 559 -1.462541 1664 560 -2.472278 1664 1614 -0.000011 1664 1615 -1.610457 1664 1616 -2.722314 1664 1659 -0.000012 1664 1660 -1.619186 1664 1661 -2.737070 1664 1662 0.000700 1664 1663 9.665824 1664 1664 16.339100 1664 1665 -0.000011 1664 1666 -1.618991 1664 1667 -2.736742 1664 1710 -0.000012 1664 1711 -1.614432 1664 1712 -2.729034 1664 2766 -0.000012 1664 2767 -1.734435 1664 2768 -2.931888 1665 561 -0.000986 1665 1617 -0.124469 1665 1618 26.089067 1665 1619 44.100959 1665 1662 -0.001092 1665 1665 270.112030 1665 1666 -203.851590 1665 1667 -344.590730 1665 1668 -0.166756 1665 1669 13.966226 1665 1670 23.608493 1665 1713 -0.001089 1665 2769 -0.009736 1665 2770 6.060412 1665 2771 10.244521 1666 1619 -7.143726 1666 1666 -51.459003 1666 1667 53.412258 1666 1670 -3.824174 1666 2771 -1.659417 1667 561 -0.000010 1667 562 -1.461775 1667 563 -2.470984 1667 1617 -0.000011 1667 1618 -1.609487 1667 1619 -2.720677 1667 1662 -0.000011 1667 1663 -1.618991 1667 1664 -2.736742 1667 1665 0.000698 1667 1666 9.662573 1667 1667 16.333612 1667 1668 -0.000011 1667 1669 -1.618561 1667 1670 -2.736014 1667 1713 -0.000011 1667 1714 -1.614388 1667 1715 -2.728961 1667 2769 -0.000012 1667 2770 -1.733594 1667 2771 -2.930466 1668 564 -0.014068 1668 1620 -0.079817 1668 1621 21.701004 1668 1622 36.683350 1668 1665 -0.001060 1668 1668 270.043890 1668 1669 -191.204140 1668 1670 -323.211260 1668 1671 -0.120389 1668 1672 8.420229 1668 1673 14.233556 1668 1716 -0.001057 1668 2772 -0.001135 1668 2773 3.368183 1668 2774 5.693572 1669 1622 -5.942265 1669 1669 -51.454603 1669 1670 49.961416 1669 1673 -2.305621 1669 2774 -0.922266 1670 564 -0.000010 1670 565 -1.461161 1670 566 -2.469944 1670 1620 -0.000010 1670 1621 -1.609911 1670 1622 -2.721391 1670 1665 -0.000011 1670 1666 -1.618561 1670 1667 -2.736014 1670 1668 0.000697 1670 1669 9.645895 1670 1670 16.305411 1670 1671 -0.000011 1670 1672 -1.602008 1670 1673 -2.708035 1670 1716 -0.000011 1670 1717 -1.615505 1670 1718 -2.730848 1670 2772 -0.000012 1670 2773 -1.732973 1670 2774 -2.929415 1671 567 -0.031166 1671 1623 -0.058725 1671 1624 18.983067 1671 1625 32.088976 1671 1668 -0.001030 1671 1671 264.572260 1671 1672 -175.828060 1671 1673 -297.219750 1671 1719 -0.001028 1671 2775 -0.001136 1671 2776 2.294627 1671 2777 3.878837 1672 1625 -5.198076 1672 1672 -50.425341 1672 1673 45.800144 1672 2777 -0.628315 1673 567 -0.000010 1673 568 -1.490128 1673 569 -2.518913 1673 1623 -0.000010 1673 1624 -1.562102 1673 1625 -2.640576 1673 1668 -0.000011 1673 1669 -1.602008 1673 1670 -2.708035 1673 1671 0.000672 1673 1672 8.026125 1673 1673 13.567363 1673 1719 -0.000011 1673 1720 -1.599065 1673 1721 -2.703060 1673 2775 -0.000012 1673 2776 -1.767162 1673 2777 -2.987210 1674 1674 1.000000 1675 1675 1.000000 1676 1676 1.000000 1677 1677 1.000000 1678 1678 1.000000 1679 1679 1.000000 1680 1680 1.000000 1681 1681 1.000000 1682 1682 1.000000 1683 1683 1.000000 1684 1684 1.000000 1685 1685 1.000000 1686 1686 1.000000 1687 1687 1.000000 1688 1688 1.000000 1689 585 -0.062688 1689 1689 107.974130 1689 1690 -64.387337 1689 1691 -108.840360 1689 1692 -0.000431 1689 1737 -0.022899 1689 1738 0.967739 1689 1739 1.635867 1689 2793 -0.002637 1689 2794 0.308946 1689 2795 0.522243 1690 1690 -18.888764 1690 1691 19.535090 1690 1739 -0.264995 1690 2795 -0.084598 1691 585 -0.000023 1691 586 -3.642522 1691 587 -6.157318 1691 1689 0.000312 1691 1690 9.318648 1691 1691 15.752243 1691 1692 -0.000005 1691 1693 -0.706526 1691 1694 -1.194311 1691 1737 -0.000004 1691 1738 -0.647479 1691 1739 -1.094499 1691 2793 -0.000028 1691 2794 -4.319810 1691 2795 -7.302207 1692 588 -0.058962 1692 1644 -0.001637 1692 1645 2.853943 1692 1646 4.824304 1692 1689 -0.013480 1692 1690 1.882557 1692 1691 3.182274 1692 1692 129.594510 1692 1693 -80.993831 1692 1694 -136.911910 1692 1695 -0.000507 1692 1740 -0.023565 1692 2796 -0.002221 1692 2797 0.534171 1692 2798 0.902962 1693 1646 -0.781492 1693 1691 -0.515497 1693 1693 -24.701508 1693 1694 21.021639 1693 2798 -0.146270 1694 588 -0.000020 1694 589 -3.036994 1694 590 -5.133732 1694 1644 -0.000005 1694 1645 -0.821943 1694 1646 -1.389411 1694 1689 -0.000005 1694 1690 -0.706526 1694 1691 -1.194311 1694 1692 0.000365 1694 1693 9.700159 1694 1694 16.397142 1694 1695 -0.000005 1694 1696 -0.822973 1694 1697 -1.391152 1694 1740 -0.000005 1694 1741 -0.705969 1694 1742 -1.193369 1694 2796 -0.000023 1694 2797 -3.602981 1694 2798 -6.090476 1695 591 -0.048563 1695 1647 -0.012933 1695 1648 5.165937 1695 1649 8.732500 1695 1692 -0.056914 1695 1693 5.578304 1695 1694 9.429561 1695 1695 145.821820 1695 1696 -97.152630 1695 1697 -164.226810 1695 1698 -0.000581 1695 1743 -0.022917 1695 2799 -0.002025 1695 2800 1.229508 1695 2801 2.078360 1696 1649 -1.414567 1696 1694 -1.527488 1696 1696 -27.792393 1696 1697 25.293396 1696 2801 -0.336667 1697 591 -0.000018 1697 592 -2.701541 1697 593 -4.566685 1697 1647 -0.000006 1697 1648 -0.918639 1697 1649 -1.552867 1697 1692 -0.000005 1697 1693 -0.822973 1697 1694 -1.391152 1697 1695 0.000403 1697 1696 9.393580 1697 1697 15.878907 1697 1698 -0.000006 1697 1699 -0.920354 1697 1700 -1.555767 1697 1743 -0.000005 1697 1744 -0.821905 1697 1745 -1.389347 1697 2799 -0.000021 1697 2800 -3.205047 1697 2801 -5.417811 1698 594 -0.014615 1698 1650 -0.030180 1698 1651 8.479527 1698 1652 14.333783 1698 1695 -0.109325 1698 1696 10.289578 1698 1697 17.393503 1698 1698 162.062760 1698 1699 -116.843410 1698 1700 -197.511970 1698 1701 -0.000696 1698 1746 -0.018187 1698 2802 -0.001895 1698 2803 3.429965 1698 2804 5.798008 1699 1652 -2.321867 1699 1697 -2.817515 1699 1699 -30.885659 1699 1700 30.525937 1699 2804 -0.939179 1700 594 -0.000017 1700 595 -2.430966 1700 596 -4.109303 1700 1650 -0.000007 1700 1651 -1.030072 1700 1652 -1.741232 1700 1695 -0.000006 1700 1696 -0.920354 1700 1697 -1.555767 1700 1698 0.000442 1700 1699 9.265686 1700 1700 15.662705 1700 1701 -0.000007 1700 1702 -1.059805 1700 1703 -1.791493 1700 1746 -0.000006 1700 1747 -0.936829 1700 1748 -1.583616 1700 2802 -0.000020 1700 2803 -2.884187 1700 2804 -4.875426 1701 597 -0.001406 1701 1653 -0.057101 1701 1654 14.512037 1701 1655 24.531147 1701 1698 -0.193282 1701 1699 16.984846 1701 1700 28.711166 1701 1701 194.590370 1701 1702 -153.834730 1701 1703 -260.042220 1701 1704 -0.000861 1701 1749 -0.047830 1701 2805 -0.037830 1701 2806 8.772413 1701 2807 14.828886 1702 1655 -3.973579 1702 1700 -4.650707 1702 1702 -37.069915 1702 1703 40.341763 1702 2807 -2.401949 1703 597 -0.000015 1703 598 -2.026727 1703 599 -3.425978 1703 1653 -0.000008 1703 1654 -1.192726 1703 1655 -2.016184 1703 1698 -0.000007 1703 1699 -1.059805 1703 1700 -1.791493 1703 1701 0.000519 1703 1702 9.025244 1703 1703 15.256271 1703 1704 -0.000009 1703 1705 -1.241608 1703 1706 -2.098814 1703 1749 -0.000008 1703 1750 -1.095437 1703 1751 -1.851726 1703 2805 -0.000017 1703 2806 -2.404773 1703 2807 -4.065028 1704 600 -0.001324 1704 1656 -0.195441 1704 1657 27.679249 1704 1658 46.788972 1704 1701 -0.296250 1704 1702 27.552567 1704 1703 46.574860 1704 1704 222.000700 1704 1705 -212.213850 1704 1706 -358.726050 1704 1707 -0.001066 1704 1752 -0.131401 1704 1753 7.247402 1704 1754 12.251000 1704 2808 -0.155675 1704 2809 20.388768 1704 2810 34.465149 1705 1658 -7.578676 1705 1703 -7.544026 1705 1705 -42.232058 1705 1706 56.042433 1705 1754 -1.984297 1705 2810 -5.582379 1706 600 -0.000014 1706 601 -1.780177 1706 602 -3.009209 1706 1656 -0.000010 1706 1657 -1.370786 1706 1658 -2.317174 1706 1701 -0.000009 1706 1702 -1.241608 1706 1703 -2.098814 1706 1704 0.000587 1706 1705 9.199973 1706 1706 15.551625 1706 1707 -0.000011 1706 1708 -1.432539 1706 1709 -2.421562 1706 1752 -0.000010 1706 1753 -1.257786 1706 1754 -2.126160 1706 2808 -0.000016 1706 2809 -2.112323 1706 2810 -3.570668 1707 603 -0.001233 1707 1659 -0.499826 1707 1660 60.983824 1707 1661 103.087060 1707 1704 -0.459480 1707 1705 42.257388 1707 1706 71.431844 1707 1707 261.107860 1707 1708 -371.655010 1707 1709 -628.245610 1707 1710 -0.479119 1707 1711 47.530409 1707 1712 80.345359 1707 1755 -0.422697 1707 1756 35.046687 1707 1757 59.242920 1707 2811 -0.299141 1707 2812 34.530089 1707 2813 58.369661 1708 1661 -16.697151 1708 1706 -11.569677 1708 1708 -49.462685 1708 1709 99.286469 1708 1712 -13.013393 1708 1757 -9.595315 1708 2813 -9.453785 1709 603 -0.000013 1709 604 -1.520875 1709 605 -2.570887 1709 1659 -0.000012 1709 1660 -1.580477 1709 1661 -2.671639 1709 1704 -0.000011 1709 1705 -1.432539 1709 1706 -2.421562 1709 1707 0.000684 1709 1708 9.820564 1709 1709 16.600677 1709 1710 -0.000012 1709 1711 -1.586819 1709 1712 -2.682358 1709 1755 -0.000012 1709 1756 -1.501972 1709 1757 -2.538933 1709 2811 -0.000014 1709 2812 -1.803479 1709 2813 -3.048600 1710 606 -0.001085 1710 1662 -0.206989 1710 1663 30.368874 1710 1664 51.335512 1710 1707 -0.001179 1710 1710 270.516630 1710 1711 -239.664530 1710 1712 -405.128690 1710 1713 -0.291117 1710 1714 28.543428 1710 1715 48.249810 1710 1758 -0.133422 1710 1759 6.008596 1710 1760 10.156924 1710 2814 -0.120910 1710 2815 16.989522 1710 2816 28.719068 1711 1664 -8.315086 1711 1711 -51.497262 1711 1712 63.118938 1711 1715 -7.815253 1711 1760 -1.645113 1711 2816 -4.651683 1712 606 -0.000011 1712 607 -1.459765 1712 608 -2.467585 1712 1662 -0.000012 1712 1663 -1.614432 1712 1664 -2.729034 1712 1707 -0.000012 1712 1708 -1.586819 1712 1709 -2.682358 1712 1710 0.000704 1712 1711 9.634145 1712 1712 16.285550 1712 1713 -0.000012 1712 1714 -1.619510 1712 1715 -2.737619 1712 1758 -0.000012 1712 1759 -1.616786 1712 1760 -2.733014 1712 2814 -0.000013 1712 2815 -1.731037 1712 2816 -2.926143 1713 609 -0.001027 1713 1665 -0.114556 1713 1666 20.494516 1713 1667 34.643930 1713 1710 -0.001139 1713 1713 270.107170 1713 1714 -203.634730 1713 1715 -344.224150 1713 1716 -0.193586 1713 1717 17.385177 1713 1718 29.387887 1713 1761 -0.015265 1713 2817 -0.029539 1713 2818 8.001403 1713 2819 13.525571 1714 1667 -5.611610 1714 1714 -51.482107 1714 1715 53.294295 1714 1718 -4.760219 1714 2819 -2.190825 1715 609 -0.000011 1715 610 -1.460318 1715 611 -2.468522 1715 1665 -0.000011 1715 1666 -1.614388 1715 1667 -2.728961 1715 1710 -0.000012 1715 1711 -1.619510 1715 1712 -2.737619 1715 1713 0.000701 1715 1714 9.667581 1715 1715 16.342077 1715 1716 -0.000011 1715 1717 -1.619173 1715 1718 -2.737049 1715 1761 -0.000012 1715 1762 -1.616562 1715 1763 -2.732636 1715 2817 -0.000013 1715 2818 -1.731841 1715 2819 -2.927504 1716 612 -0.000990 1716 1668 -0.087899 1716 1669 17.101421 1716 1670 28.908223 1716 1713 -0.001099 1716 1716 270.029730 1716 1717 -192.459250 1716 1718 -325.332920 1716 1719 -0.161407 1716 1720 13.440870 1716 1721 22.720447 1716 1764 -0.001097 1716 2820 -0.001175 1716 2821 4.156914 1716 2822 7.026842 1717 1670 -4.682640 1717 1717 -51.474884 1717 1718 50.253828 1717 1721 -3.680304 1717 2822 -1.138207 1718 612 -0.000010 1718 613 -1.459079 1718 614 -2.466425 1718 1668 -0.000011 1718 1669 -1.615505 1718 1670 -2.730848 1718 1713 -0.000011 1718 1714 -1.619173 1718 1715 -2.737049 1718 1716 0.000699 1718 1717 9.665880 1718 1718 16.339196 1718 1719 -0.000011 1718 1720 -1.619003 1718 1721 -2.736763 1718 1764 -0.000011 1718 1765 -1.616916 1718 1766 -2.733233 1718 2820 -0.000012 1718 2821 -1.730419 1718 2822 -2.925098 1719 615 -0.025510 1719 1671 -0.047733 1719 1672 12.055848 1719 1673 20.379205 1719 1716 -0.001068 1719 1719 269.939570 1719 1720 -172.426060 1719 1721 -291.469000 1719 2823 -0.001142 1719 2824 2.660689 1719 2825 4.497629 1720 1673 -3.301123 1720 1720 -51.470763 1720 1721 44.779759 1720 2825 -0.728538 1721 615 -0.000010 1721 616 -1.460268 1721 617 -2.468436 1721 1671 -0.000011 1721 1672 -1.599065 1721 1673 -2.703060 1721 1716 -0.000011 1721 1717 -1.619003 1721 1718 -2.736763 1721 1719 0.000675 1721 1720 6.415786 1721 1721 10.845244 1721 2823 -0.000012 1721 2824 -1.731666 1721 2825 -2.927208 1722 1722 1.000000 1723 1723 1.000000 1724 1724 1.000000 1725 1725 1.000000 1726 1726 1.000000 1727 1727 1.000000 1728 1728 1.000000 1729 1729 1.000000 1730 1730 1.000000 1731 1731 1.000000 1732 1732 1.000000 1733 1733 1.000000 1734 1734 1.000000 1735 1735 1.000000 1736 1736 1.000000 1737 633 -0.063308 1737 1689 -0.000393 1737 1737 107.996450 1737 1738 -66.273133 1737 1739 -112.028100 1737 1740 -0.000393 1737 1785 -0.039251 1737 1786 2.888962 1737 1787 4.883501 1737 2841 -0.002623 1737 2842 0.267289 1737 2843 0.451825 1738 1738 -20.584062 1738 1739 17.184991 1738 1787 -0.791091 1738 2843 -0.073192 1739 633 -0.000023 1739 634 -3.643639 1739 635 -6.159207 1739 1689 -0.000004 1739 1690 -0.647479 1739 1691 -1.094499 1739 1737 0.000315 1739 1738 9.910028 1739 1739 16.751912 1739 1740 -0.000004 1739 1741 -0.647486 1739 1742 -1.094510 1739 1785 -0.000004 1739 1786 -0.647560 1739 1787 -1.094636 1739 2841 -0.000027 1739 2842 -4.321552 1739 2843 -7.305152 1740 636 -0.060974 1740 1692 -0.000436 1740 1693 0.184695 1740 1694 0.312209 1740 1737 -0.013641 1740 1738 2.862296 1740 1739 4.838425 1740 1740 108.031190 1740 1741 -68.419519 1740 1742 -115.656280 1740 1743 -0.000436 1740 1788 -0.034935 1740 1789 1.840359 1740 1790 3.110940 1740 2844 -0.002666 1740 2845 0.430566 1740 2846 0.727828 1741 1694 -0.050574 1741 1739 -0.783780 1741 1741 -20.587619 1741 1742 17.763824 1741 1790 -0.503942 1741 2846 -0.117900 1742 636 -0.000023 1742 637 -3.643757 1742 638 -6.159404 1742 1692 -0.000005 1742 1693 -0.705969 1742 1694 -1.193369 1742 1737 -0.000004 1742 1738 -0.647486 1742 1739 -1.094510 1742 1740 0.000321 1742 1741 10.674876 1742 1742 18.044799 1742 1743 -0.000005 1742 1744 -0.706592 1742 1745 -1.194423 1742 1788 -0.000004 1742 1789 -0.647482 1742 1790 -1.094502 1742 2844 -0.000028 1742 2845 -4.321276 1742 2846 -7.304679 1743 639 -0.052938 1743 1695 -0.000522 1743 1696 1.329998 1743 1697 2.248228 1743 1740 -0.052756 1743 1741 5.747727 1743 1742 9.715952 1743 1743 129.653910 1743 1744 -85.348337 1743 1745 -144.272830 1743 1746 -0.000532 1743 1791 -0.038165 1743 1792 1.590345 1743 1793 2.688319 1743 2847 -0.002289 1743 2848 0.954940 1743 2849 1.614230 1744 1697 -0.364183 1744 1742 -1.573880 1744 1744 -24.709362 1744 1745 22.194201 1744 1793 -0.435472 1744 2849 -0.261483 1745 639 -0.000020 1745 640 -3.036682 1745 641 -5.133207 1745 1695 -0.000005 1745 1696 -0.821905 1745 1697 -1.389347 1745 1740 -0.000005 1745 1741 -0.706592 1745 1742 -1.194423 1745 1743 0.000367 1745 1744 9.714083 1745 1745 16.420685 1745 1746 -0.000006 1745 1747 -0.837098 1745 1748 -1.415030 1745 1791 -0.000005 1745 1792 -0.706259 1745 1793 -1.193860 1745 2847 -0.000024 1745 2848 -3.602770 1745 2849 -6.090122 1746 642 -0.029495 1746 1698 -0.000620 1746 1699 1.708587 1746 1700 2.888193 1746 1743 -0.106537 1746 1744 9.530395 1746 1745 16.110179 1746 1746 151.254130 1746 1747 -104.446810 1746 1748 -176.556780 1746 1749 -0.000640 1746 1794 -0.057494 1746 1795 2.342793 1746 1796 3.960255 1746 2850 -0.002044 1746 2851 2.517673 1746 2852 4.255873 1747 1700 -0.467837 1747 1745 -2.609624 1747 1747 -28.831816 1747 1748 27.216494 1747 1796 -0.641494 1747 2852 -0.689375 1748 642 -0.000018 1748 643 -2.604598 1748 644 -4.402811 1748 1698 -0.000006 1748 1699 -0.936829 1748 1700 -1.583616 1748 1743 -0.000006 1748 1744 -0.837098 1748 1745 -1.415030 1748 1746 0.000417 1748 1747 9.293203 1748 1748 15.709222 1748 1749 -0.000007 1748 1750 -0.967368 1748 1751 -1.635238 1748 1794 -0.000006 1748 1795 -0.853975 1748 1796 -1.443558 1748 2850 -0.000021 1748 2851 -3.090092 1748 2852 -5.223489 1749 645 -0.001582 1749 1701 -0.000760 1749 1702 0.241644 1749 1703 0.408475 1749 1746 -0.152981 1749 1747 13.951809 1749 1748 23.584125 1749 1749 172.906570 1749 1750 -126.993460 1749 1751 -214.669750 1749 1752 -0.000771 1749 1797 -0.097879 1749 1798 5.410514 1749 1799 9.145932 1749 2853 -0.014069 1749 2854 6.412504 1749 2855 10.839696 1750 1703 -0.066163 1750 1748 -3.820199 1750 1750 -32.957137 1750 1751 33.175169 1750 1799 -1.481443 1750 2855 -1.755783 1751 645 -0.000017 1751 646 -2.280049 1751 647 -3.854194 1751 1701 -0.000008 1751 1702 -1.095437 1751 1703 -1.851726 1751 1746 -0.000007 1751 1747 -0.967368 1751 1748 -1.635238 1751 1749 0.000470 1751 1750 9.164349 1751 1751 15.491414 1751 1752 -0.000008 1751 1753 -1.111507 1751 1754 -1.878892 1751 1797 -0.000007 1751 1798 -1.001389 1751 1799 -1.692748 1751 2853 -0.000019 1751 2854 -2.704891 1751 2855 -4.572347 1752 648 -0.001442 1752 1704 -0.000919 1752 1749 -0.197633 1752 1750 18.014880 1752 1751 30.452353 1752 1752 200.077920 1752 1753 -160.547650 1752 1754 -271.389570 1752 1755 -0.000961 1752 1800 -0.174381 1752 1801 12.361556 1752 1802 20.895960 1752 2856 -0.085147 1752 2857 13.430198 1752 2858 22.702394 1753 1751 -4.932559 1753 1753 -38.115097 1753 1754 42.090424 1753 1802 -3.384606 1753 2858 -3.677161 1754 648 -0.000015 1754 649 -1.972400 1754 650 -3.334143 1754 1704 -0.000010 1754 1705 -1.257786 1754 1706 -2.126160 1754 1749 -0.000008 1754 1750 -1.111507 1754 1751 -1.878892 1754 1752 0.000536 1754 1753 9.181600 1754 1754 15.520567 1754 1755 -0.000010 1754 1756 -1.315371 1754 1757 -2.223502 1754 1800 -0.000009 1754 1801 -1.180207 1754 1802 -1.995020 1754 2856 -0.000018 1754 2857 -2.340037 1754 2858 -3.955596 1755 651 -0.001230 1755 1707 -0.001139 1755 1752 -0.189127 1755 1753 15.687094 1755 1754 26.517446 1755 1755 243.503420 1755 1756 -214.636380 1755 1757 -362.821330 1755 1758 -0.158087 1755 1759 15.859809 1755 1760 26.809404 1755 1803 -0.293568 1755 1804 22.350159 1755 1805 37.780708 1755 2859 -0.138715 1755 2860 18.730508 1755 2861 31.662050 1756 1754 -4.295037 1756 1756 -46.361346 1756 1757 56.481337 1756 1760 -4.342308 1756 1805 -6.119398 1756 2861 -5.128279 1757 651 -0.000013 1757 652 -1.622280 1757 653 -2.742302 1757 1707 -0.000012 1757 1708 -1.501972 1757 1709 -2.538933 1757 1752 -0.000010 1757 1753 -1.315371 1757 1754 -2.223502 1757 1755 0.000640 1757 1756 9.341745 1757 1757 15.791282 1757 1758 -0.000012 1757 1759 -1.534571 1757 1760 -2.594038 1757 1803 -0.000011 1757 1804 -1.438376 1757 1805 -2.431431 1757 2859 -0.000015 1757 2860 -1.923952 1757 2861 -3.252249 1758 654 -0.001072 1758 1710 -0.001188 1758 1755 -0.001127 1758 1758 270.144950 1758 1759 -196.578550 1758 1760 -332.296180 1758 1761 -0.172805 1758 1762 16.117870 1758 1763 27.245647 1758 1806 -0.182016 1758 1807 11.574085 1758 1808 19.564815 1758 2862 -0.061196 1758 2863 11.111017 1758 2864 18.782047 1759 1759 -51.503173 1759 1760 51.308508 1759 1763 -4.413067 1759 1808 -3.168960 1759 2864 -3.042167 1760 654 -0.000011 1760 655 -1.459200 1760 656 -2.466631 1760 1710 -0.000012 1760 1711 -1.616786 1760 1712 -2.733014 1760 1755 -0.000012 1760 1756 -1.534571 1760 1757 -2.594038 1760 1758 0.000704 1760 1759 9.583425 1760 1760 16.199811 1760 1761 -0.000012 1760 1762 -1.619717 1760 1763 -2.737969 1760 1806 -0.000012 1760 1807 -1.616875 1760 1808 -2.733163 1760 2862 -0.000013 1760 2863 -1.730476 1760 2864 -2.925195 1761 657 -0.001038 1761 1713 -0.001151 1761 1714 6.396303 1761 1715 10.812310 1761 1758 -0.001153 1761 1761 269.953340 1761 1762 -181.323280 1761 1763 -306.508870 1761 1764 -0.103881 1761 1765 10.114327 1761 1766 17.097245 1761 1809 -0.062403 1761 1810 0.578917 1761 1811 0.978601 1761 2865 -0.013870 1761 2866 6.452095 1761 2867 10.906622 1762 1715 -1.751322 1762 1762 -51.495627 1762 1763 47.151643 1762 1766 -2.769339 1762 1811 -0.158507 1762 2867 -1.766597 1763 657 -0.000011 1763 658 -1.458490 1763 659 -2.465431 1763 1713 -0.000012 1763 1714 -1.616562 1763 1715 -2.732636 1763 1758 -0.000012 1763 1759 -1.619717 1763 1760 -2.737969 1763 1761 0.000703 1763 1762 9.666624 1763 1763 16.340459 1763 1764 -0.000012 1763 1765 -1.619648 1763 1766 -2.737850 1763 1809 -0.000012 1763 1810 -1.616718 1763 1811 -2.732899 1763 2865 -0.000013 1763 2866 -1.729695 1763 2867 -2.923877 1764 660 -0.002126 1764 1716 -0.076600 1764 1717 13.660612 1764 1718 23.091886 1764 1761 -0.001130 1764 1764 269.846290 1764 1765 -175.610320 1764 1766 -296.851470 1764 1812 -0.021406 1764 2868 -0.001208 1764 2869 4.174611 1764 2870 7.056759 1765 1718 -3.740399 1765 1765 -51.490230 1765 1766 45.601587 1765 2870 -1.143030 1766 660 -0.000011 1766 661 -1.458956 1766 662 -2.466217 1766 1716 -0.000011 1766 1717 -1.616916 1766 1718 -2.733233 1766 1761 -0.000012 1766 1762 -1.619648 1766 1763 -2.737850 1766 1764 0.000690 1766 1765 8.048687 1766 1766 13.605490 1766 1812 -0.000012 1766 1813 -1.617100 1766 1814 -2.733544 1766 2868 -0.000013 1766 2869 -1.730274 1766 2870 -2.924854 1767 1767 1.000000 1768 1768 1.000000 1769 1769 1.000000 1770 1770 1.000000 1771 1771 1.000000 1772 1772 1.000000 1773 1773 1.000000 1774 1774 1.000000 1775 1775 1.000000 1776 1776 1.000000 1777 1777 1.000000 1778 1778 1.000000 1779 1779 1.000000 1780 1780 1.000000 1781 1781 1.000000 1782 678 -0.063457 1782 1782 113.372150 1782 1783 -68.660562 1782 1784 -116.063750 1782 1785 -0.000388 1782 1830 -0.015354 1782 1831 2.142985 1782 1832 3.622500 1782 2886 -0.002412 1782 2887 0.239673 1782 2888 0.405144 1783 1783 -21.608517 1783 1784 17.802766 1783 1832 -0.586829 1783 2888 -0.065631 1784 678 -0.000021 1784 679 -3.470235 1784 680 -5.866081 1784 1782 0.000320 1784 1783 8.976971 1784 1784 15.174662 1784 1785 -0.000004 1784 1786 -0.662728 1784 1787 -1.120274 1784 1830 -0.000004 1784 1831 -0.725236 1784 1832 -1.225939 1784 2886 -0.000025 1784 2887 -4.116348 1784 2888 -6.958270 1785 681 -0.063594 1785 1737 -0.000386 1785 1782 -0.011889 1785 1783 3.144552 1785 1784 5.315547 1785 1785 108.018080 1785 1786 -69.213653 1785 1787 -116.998760 1785 1788 -0.000386 1785 1833 -0.036654 1785 1834 2.709470 1785 1835 4.580089 1785 2889 -0.002580 1785 2890 0.246444 1785 2891 0.416589 1786 1784 -0.861089 1786 1786 -20.583738 1786 1787 17.991234 1786 1835 -0.741947 1786 2891 -0.067484 1787 681 -0.000023 1787 682 -3.645772 1787 683 -6.162813 1787 1737 -0.000004 1787 1738 -0.647560 1787 1739 -1.094636 1787 1782 -0.000004 1787 1783 -0.662728 1787 1784 -1.120274 1787 1785 0.000318 1787 1786 10.592832 1787 1787 17.906123 1787 1788 -0.000004 1787 1789 -0.647263 1787 1790 -1.094134 1787 1833 -0.000004 1787 1834 -0.663245 1787 1835 -1.121149 1787 2889 -0.000027 1787 2890 -4.323953 1787 2891 -7.309211 1788 684 -0.062687 1788 1740 -0.000395 1788 1785 -0.017944 1788 1786 3.909041 1788 1787 6.607844 1788 1788 108.038200 1788 1789 -69.988742 1788 1790 -118.308890 1788 1791 -0.000395 1788 1836 -0.036900 1788 1837 2.657672 1788 1838 4.492524 1788 2892 -0.002637 1788 2893 0.309799 1788 2894 0.523684 1789 1787 -1.070421 1789 1789 -20.588667 1789 1790 18.191121 1789 1838 -0.727753 1789 2894 -0.084832 1790 684 -0.000023 1790 685 -3.642601 1790 686 -6.157449 1790 1740 -0.000004 1790 1741 -0.647482 1790 1742 -1.094502 1790 1785 -0.000004 1790 1786 -0.647263 1790 1787 -1.094134 1790 1788 0.000320 1790 1789 10.555334 1790 1790 17.842726 1790 1791 -0.000004 1790 1792 -0.647728 1790 1793 -1.094919 1790 1836 -0.000004 1790 1837 -0.647624 1790 1838 -1.094742 1790 2892 -0.000028 1790 2893 -4.320322 1790 2894 -7.303069 1791 687 -0.058185 1791 1743 -0.000445 1791 1788 -0.048309 1791 1789 5.651199 1791 1790 9.552780 1791 1791 108.067510 1791 1792 -72.373388 1791 1793 -122.339970 1791 1794 -0.000454 1791 1839 -0.043448 1791 1840 2.989205 1791 1841 5.052952 1791 2895 -0.002723 1791 2896 0.626735 1791 2897 1.059432 1792 1790 -1.547458 1792 1792 -20.592885 1792 1793 18.833227 1792 1841 -0.818521 1792 2897 -0.171614 1793 687 -0.000024 1793 688 -3.642810 1793 689 -6.157807 1793 1743 -0.000005 1793 1744 -0.706259 1793 1745 -1.193860 1793 1788 -0.000004 1793 1789 -0.647728 1793 1790 -1.094919 1793 1791 0.000323 1793 1792 10.687176 1793 1793 18.065601 1793 1794 -0.000005 1793 1795 -0.719826 1793 1796 -1.216794 1793 1839 -0.000004 1793 1840 -0.647693 1793 1841 -1.094861 1793 2895 -0.000028 1793 2896 -4.320544 1793 2897 -7.303447 1794 690 -0.045082 1794 1746 -0.000559 1794 1791 -0.082053 1794 1792 7.841056 1794 1793 13.254521 1794 1794 135.076980 1794 1795 -92.422249 1794 1796 -156.230460 1794 1797 -0.000579 1794 1842 -0.079778 1794 1843 4.184264 1794 1844 7.073075 1794 2898 -0.002269 1794 2899 1.499179 1794 2900 2.534211 1795 1793 -2.147059 1795 1795 -25.745523 1795 1796 24.065408 1795 1844 -1.145732 1795 2900 -0.410499 1796 690 -0.000020 1796 691 -2.919621 1796 692 -4.935323 1796 1746 -0.000006 1796 1747 -0.853975 1796 1748 -1.443558 1796 1791 -0.000005 1796 1792 -0.719826 1796 1793 -1.216794 1796 1794 0.000381 1796 1795 9.600882 1796 1796 16.229320 1796 1797 -0.000006 1796 1798 -0.883417 1796 1799 -1.493328 1796 1842 -0.000005 1796 1843 -0.757150 1796 1844 -1.279886 1796 2898 -0.000024 1796 2899 -3.463996 1796 2900 -5.855535 1797 693 -0.015535 1797 1749 -0.000683 1797 1794 -0.112837 1797 1795 10.391003 1797 1796 17.564939 1797 1797 162.087010 1797 1798 -115.265500 1797 1799 -194.844800 1797 1800 -0.000723 1797 1845 -0.108816 1797 1846 6.767584 1797 1847 11.439923 1797 2901 -0.001967 1797 2902 3.437816 1797 2903 5.811284 1798 1796 -2.845220 1798 1798 -30.899754 1798 1799 30.058278 1798 1847 -1.853051 1798 2903 -0.941305 1799 693 -0.000017 1799 694 -2.432178 1799 695 -4.111354 1799 1749 -0.000007 1799 1750 -1.001389 1799 1751 -1.692748 1799 1794 -0.000006 1799 1795 -0.883417 1799 1796 -1.493328 1799 1797 0.000444 1799 1798 9.201385 1799 1799 15.554020 1799 1800 -0.000008 1799 1801 -1.060058 1799 1802 -1.791923 1799 1845 -0.000006 1799 1846 -0.935361 1799 1847 -1.581134 1799 2901 -0.000021 1799 2902 -2.885504 1799 2903 -4.877655 1800 696 -0.001433 1800 1752 -0.000834 1800 1797 -0.135467 1800 1798 11.804877 1800 1799 19.954964 1800 1800 194.517550 1800 1801 -142.593830 1800 1802 -241.040460 1800 1803 -0.000907 1800 1848 -0.157965 1800 1849 10.780072 1800 1850 18.222623 1800 2904 -0.013656 1800 2905 6.391327 1800 2906 10.803892 1801 1799 -3.232272 1801 1801 -37.084526 1801 1802 37.227496 1801 1850 -2.951661 1801 2906 -1.749963 1802 696 -0.000015 1802 697 -2.027004 1802 698 -3.426445 1802 1752 -0.000009 1802 1753 -1.180207 1802 1754 -1.995020 1802 1797 -0.000008 1802 1798 -1.060058 1802 1799 -1.791923 1802 1800 0.000521 1802 1801 9.089951 1802 1802 15.365644 1802 1803 -0.000009 1802 1804 -1.282751 1802 1805 -2.168360 1802 1848 -0.000008 1802 1849 -1.130829 1802 1850 -1.911551 1802 2904 -0.000018 1802 2905 -2.404928 1802 2906 -4.065287 1803 699 -0.001199 1803 1755 -0.001040 1803 1800 -0.112146 1803 1801 8.801389 1803 1802 14.877859 1803 1803 237.716890 1803 1804 -172.510840 1803 1805 -291.612330 1803 1806 -0.017391 1803 1807 2.963568 1803 1808 5.009611 1803 1851 -0.205367 1803 1852 13.685122 1803 1853 23.133330 1803 2907 -0.031731 1803 2908 8.199983 1803 2909 13.861251 1804 1802 -2.409829 1804 1804 -45.327617 1804 1805 45.009350 1804 1808 -0.811419 1804 1853 -3.747027 1804 2909 -2.245149 1805 699 -0.000013 1805 700 -1.659097 1805 701 -2.804538 1805 1755 -0.000011 1805 1756 -1.438376 1805 1757 -2.431431 1805 1800 -0.000009 1805 1801 -1.282751 1805 1802 -2.168360 1805 1803 0.000625 1805 1804 9.259195 1805 1805 15.651739 1805 1806 -0.000011 1805 1807 -1.516409 1805 1808 -2.563335 1805 1851 -0.000010 1805 1852 -1.389323 1805 1853 -2.348513 1805 2907 -0.000015 1805 2908 -1.968134 1805 2909 -3.326934 1806 702 -0.001049 1806 1758 -0.001162 1806 1803 -0.001089 1806 1806 269.947980 1806 1807 -179.105480 1806 1808 -302.759630 1806 1809 -0.052989 1806 1810 5.103267 1806 1811 8.626563 1806 1854 -0.175079 1806 1855 10.116538 1806 1856 17.100984 1806 2910 -0.009941 1806 2911 6.069439 1806 2912 10.259773 1807 1807 -51.505101 1807 1808 46.520833 1807 1811 -1.397274 1807 1856 -2.769927 1807 2912 -1.661813 1808 702 -0.000011 1808 703 -1.459785 1808 704 -2.467619 1808 1758 -0.000012 1808 1759 -1.616875 1808 1760 -2.733163 1808 1803 -0.000011 1808 1804 -1.516409 1808 1805 -2.563335 1808 1806 0.000703 1808 1807 9.566398 1808 1808 16.171028 1808 1809 -0.000012 1808 1810 -1.619787 1808 1811 -2.738089 1808 1854 -0.000012 1808 1855 -1.616506 1808 1856 -2.732539 1808 2910 -0.000013 1808 2911 -1.731237 1808 2912 -2.926480 1809 705 -0.001038 1809 1761 -0.001150 1809 1806 -0.001152 1809 1809 269.845900 1809 1810 -167.811400 1809 1811 -283.668390 1809 1812 -0.062820 1809 1813 5.291959 1809 1814 8.945522 1809 2913 -0.001232 1809 2914 4.741739 1809 2915 8.015435 1810 1810 -51.502392 1810 1811 43.435542 1810 1814 -1.448949 1810 2915 -1.298296 1811 705 -0.000011 1811 706 -1.460471 1811 707 -2.468781 1811 1761 -0.000012 1811 1762 -1.616718 1811 1763 -2.732899 1811 1806 -0.000012 1811 1807 -1.619787 1811 1808 -2.738089 1811 1809 0.000691 1811 1810 8.054580 1811 1811 13.615461 1811 1812 -0.000012 1811 1813 -1.619740 1811 1814 -2.738007 1811 2913 -0.000013 1811 2914 -1.732066 1811 2915 -2.927885 1812 708 -0.011013 1812 1764 -0.001138 1812 1765 4.235712 1812 1766 7.160042 1812 1809 -0.001140 1812 1812 269.818770 1812 1813 -165.664960 1812 1814 -280.039860 1812 2916 -0.001218 1812 2917 3.653898 1812 2918 6.176546 1813 1766 -1.159753 1813 1813 -51.500595 1813 1814 42.852774 1813 2918 -1.000449 1814 708 -0.000011 1814 709 -1.459135 1814 710 -2.466520 1814 1764 -0.000012 1814 1765 -1.617100 1814 1766 -2.733544 1814 1809 -0.000012 1814 1810 -1.619740 1814 1811 -2.738007 1814 1812 0.000679 1814 1813 6.432265 1814 1814 10.873094 1814 2916 -0.000013 1814 2917 -1.730493 1814 2918 -2.925224 1815 1815 1.000000 1816 1816 1.000000 1817 1817 1.000000 1818 1818 1.000000 1819 1819 1.000000 1820 1820 1.000000 1821 1821 1.000000 1822 1822 1.000000 1823 1823 1.000000 1824 1824 1.000000 1825 1825 1.000000 1826 1826 1.000000 1827 1827 1.000000 1828 1828 1.000000 1829 1829 1.000000 1830 726 -0.063023 1830 1782 -0.000420 1830 1830 129.564290 1830 1831 -79.601512 1830 1832 -134.558320 1830 1833 -0.012541 1830 1878 -0.025316 1830 1879 3.604050 1830 1880 6.092282 1830 2934 -0.002091 1830 2935 0.249867 1830 2936 0.422374 1831 1831 -24.693282 1831 1832 20.661564 1831 1880 -0.986933 1831 2936 -0.068423 1832 726 -0.000018 1832 727 -3.041851 1832 728 -5.141942 1832 1782 -0.000004 1832 1783 -0.725236 1832 1784 -1.225939 1832 1830 0.000357 1832 1831 8.925299 1832 1832 15.087315 1832 1833 -0.000004 1832 1834 -0.723883 1832 1835 -1.223651 1832 1878 -0.000005 1832 1879 -0.822290 1832 1880 -1.389997 1832 2934 -0.000022 1832 2935 -3.609268 1832 2936 -6.101103 1833 729 -0.063368 1833 1785 -0.000390 1833 1830 -0.000425 1833 1831 2.616386 1833 1832 4.422737 1833 1833 113.422340 1833 1834 -72.226180 1833 1835 -122.091130 1833 1836 -0.000389 1833 1881 -0.014385 1833 1882 3.094740 1833 1883 5.231349 1833 2937 -0.002420 1833 2938 0.249406 1833 2939 0.421596 1834 1832 -0.716464 1834 1834 -21.612590 1834 1835 18.769138 1834 1883 -0.847456 1834 2939 -0.068296 1835 729 -0.000021 1835 730 -3.473180 1835 731 -5.871063 1835 1785 -0.000004 1835 1786 -0.663245 1835 1787 -1.121149 1835 1830 -0.000004 1835 1831 -0.723883 1835 1832 -1.223651 1835 1833 0.000329 1835 1834 10.370998 1835 1835 17.531134 1835 1836 -0.000004 1835 1837 -0.662971 1835 1838 -1.120686 1835 1881 -0.000004 1835 1882 -0.725017 1835 1883 -1.225569 1835 2937 -0.000025 1835 2938 -4.120276 1835 2939 -6.964914 1836 732 -0.063342 1836 1788 -0.000389 1836 1833 -0.017241 1836 1834 3.991420 1836 1835 6.747097 1836 1836 108.034300 1836 1837 -70.405894 1836 1838 -119.014020 1836 1839 -0.000389 1836 1884 -0.021837 1836 1885 3.046511 1836 1886 5.149820 1836 2940 -0.002597 1836 2941 0.261947 1836 2942 0.442796 1837 1835 -1.092990 1837 1837 -20.588468 1837 1838 18.306083 1837 1886 -0.834238 1837 2942 -0.071729 1838 732 -0.000023 1838 733 -3.643249 1838 734 -6.158543 1838 1788 -0.000004 1838 1789 -0.647624 1838 1790 -1.094742 1838 1833 -0.000004 1838 1834 -0.662971 1838 1835 -1.120686 1838 1836 0.000319 1838 1837 10.572209 1838 1838 17.871250 1838 1839 -0.000004 1838 1840 -0.647431 1838 1841 -1.094416 1838 1884 -0.000004 1838 1885 -0.647531 1838 1886 -1.094585 1838 2940 -0.000027 1838 2941 -4.321090 1838 2942 -7.304366 1839 735 -0.061681 1839 1791 -0.000401 1839 1836 -0.041748 1839 1837 5.317321 1839 1838 8.988392 1839 1839 108.044530 1839 1840 -72.357808 1839 1841 -122.313640 1839 1842 -0.000420 1839 1887 -0.039497 1839 1888 3.536670 1839 1889 5.978387 1839 2943 -0.002678 1839 2944 0.384067 1839 2945 0.649226 1840 1838 -1.456047 1840 1840 -20.592914 1840 1841 18.829160 1840 1889 -0.968443 1840 2945 -0.105167 1841 735 -0.000024 1841 736 -3.644487 1841 737 -6.160641 1841 1791 -0.000004 1841 1792 -0.647693 1841 1793 -1.094861 1841 1836 -0.000004 1841 1837 -0.647431 1841 1838 -1.094416 1841 1839 0.000321 1841 1840 10.590126 1841 1841 17.901548 1841 1842 -0.000004 1841 1843 -0.678411 1841 1844 -1.146785 1841 1887 -0.000004 1841 1888 -0.647745 1841 1889 -1.094948 1841 2943 -0.000028 1841 2944 -4.322044 1841 2945 -7.305982 1842 738 -0.055113 1842 1794 -0.000486 1842 1839 -0.051357 1842 1840 6.771428 1842 1841 11.446421 1842 1842 118.900760 1842 1843 -81.623769 1842 1844 -137.976730 1842 1845 -0.000513 1842 1890 -0.061991 1842 1891 4.614738 1842 1892 7.800747 1842 2946 -0.002523 1842 2947 0.822619 1842 2948 1.390553 1843 1841 -1.854191 1843 1843 -22.658386 1843 1844 21.252222 1843 1892 -1.263624 1843 2948 -0.225249 1844 738 -0.000022 1844 739 -3.312375 1844 740 -5.599235 1844 1794 -0.000005 1844 1795 -0.757150 1844 1796 -1.279886 1844 1839 -0.000004 1844 1840 -0.678411 1844 1841 -1.146785 1844 1842 0.000346 1844 1843 10.173885 1844 1844 17.197926 1844 1845 -0.000005 1844 1846 -0.798127 1844 1847 -1.349153 1844 1890 -0.000005 1844 1891 -0.695944 1844 1892 -1.176423 1844 2946 -0.000026 1844 2947 -3.929329 1844 2948 -6.642133 1845 741 -0.041786 1845 1797 -0.000622 1845 1842 -0.093185 1845 1843 8.023441 1845 1844 13.562817 1845 1845 151.294080 1845 1846 -104.854220 1845 1847 -177.245580 1845 1848 -0.000662 1845 1893 -0.127120 1845 1894 6.741027 1845 1895 11.395032 1845 2949 -0.002062 1845 2950 1.710576 1845 2951 2.891558 1846 1844 -2.196973 1846 1846 -28.841163 1846 1847 27.304935 1846 1895 -1.845813 1846 2951 -0.468378 1847 741 -0.000018 1847 742 -2.612950 1847 743 -4.416930 1847 1797 -0.000006 1847 1798 -0.935361 1847 1799 -1.581134 1847 1842 -0.000005 1847 1843 -0.798127 1847 1844 -1.349153 1847 1845 0.000418 1847 1846 9.316449 1847 1847 15.748525 1847 1848 -0.000007 1847 1849 -0.994792 1847 1850 -1.681596 1847 1893 -0.000006 1847 1894 -0.871649 1847 1895 -1.473435 1847 2949 -0.000022 1847 2950 -3.100324 1847 2951 -5.240788 1848 744 -0.021587 1848 1800 -0.000775 1848 1845 -0.103888 1848 1846 8.792035 1848 1847 14.862056 1848 1848 183.684570 1848 1849 -128.566590 1848 1850 -217.328840 1848 1851 -0.000834 1848 1896 -0.145258 1848 1897 9.471709 1848 1898 16.010965 1848 2952 -0.001745 1848 2953 2.995374 1848 2954 5.063378 1849 1847 -2.407372 1849 1849 -35.024614 1849 1850 33.487759 1849 1898 -2.593473 1849 2954 -0.820157 1850 744 -0.000015 1850 745 -2.146850 1850 746 -3.629033 1850 1800 -0.000008 1850 1801 -1.130829 1850 1802 -1.911551 1850 1845 -0.000007 1850 1846 -0.994792 1850 1847 -1.681596 1850 1848 0.000494 1850 1849 9.137652 1850 1850 15.446279 1850 1851 -0.000009 1850 1852 -1.217376 1850 1853 -2.057852 1850 1896 -0.000008 1850 1897 -1.097359 1850 1898 -1.854974 1850 2952 -0.000018 1850 2953 -2.546503 1850 2954 -4.304606 1851 747 -0.006920 1851 1803 -0.000973 1851 1848 -0.096521 1851 1849 7.966307 1851 1850 13.466238 1851 1851 226.821060 1851 1852 -152.118950 1851 1853 -257.141880 1851 1854 -0.001036 1851 1899 -0.140776 1851 1900 7.754570 1851 1901 13.108325 1851 2955 -0.001444 1851 2956 3.827795 1851 2957 6.470505 1852 1850 -2.181232 1852 1852 -43.268319 1852 1853 39.525830 1852 1901 -2.123253 1852 2957 -1.048066 1853 747 -0.000013 1853 748 -1.738063 1853 749 -2.938022 1853 1803 -0.000010 1853 1804 -1.389323 1853 1805 -2.348513 1853 1848 -0.000009 1853 1849 -1.217376 1853 1850 -2.057852 1853 1851 0.000598 1853 1852 9.231555 1853 1853 15.605019 1853 1854 -0.000011 1853 1855 -1.478956 1853 1856 -2.500026 1853 1899 -0.000010 1853 1900 -1.341189 1853 1901 -2.267146 1853 2955 -0.000015 1853 2956 -2.061775 1853 2957 -3.485225 1854 750 -0.014371 1854 1806 -0.001138 1854 1851 -0.043584 1854 1852 2.422197 1854 1853 4.094481 1854 1854 269.905960 1854 1855 -170.151550 1854 1856 -287.623970 1854 1902 -0.140481 1854 1903 6.545261 1854 1904 11.064105 1854 2958 -0.001219 1854 2959 3.365699 1854 2960 5.689374 1855 1853 -0.663205 1855 1855 -51.508807 1855 1856 44.061014 1855 1904 -1.792122 1855 2960 -0.921539 1856 750 -0.000011 1856 751 -1.459942 1856 752 -2.467883 1856 1806 -0.000012 1856 1807 -1.616506 1856 1808 -2.732539 1856 1851 -0.000011 1856 1852 -1.478956 1856 1853 -2.500026 1856 1854 0.000689 1856 1855 7.893000 1856 1856 13.342320 1856 1902 -0.000012 1856 1903 -1.600177 1856 1904 -2.704938 1856 2958 -0.000013 1856 2959 -1.731620 1856 2960 -2.927129 1857 1857 1.000000 1858 1858 1.000000 1859 1859 1.000000 1860 1860 1.000000 1861 1861 1.000000 1862 1862 1.000000 1863 1863 1.000000 1864 1864 1.000000 1865 1865 1.000000 1866 1866 1.000000 1867 1867 1.000000 1868 1868 1.000000 1869 1869 1.000000 1870 1870 1.000000 1871 1871 1.000000 1872 1872 1.000000 1873 1873 1.000000 1874 1874 1.000000 1875 771 -0.061747 1875 1875 161.937720 1875 1876 -96.325749 1875 1877 -162.829050 1875 1878 -0.007715 1875 1923 -0.000546 1875 1924 1.361134 1875 1925 2.300861 1875 2979 -0.001622 1875 2980 0.285764 1875 2981 0.483056 1876 1876 -30.856113 1876 1877 24.983323 1876 1925 -0.372737 1876 2981 -0.078254 1877 771 -0.000014 1877 772 -2.430530 1877 773 -4.108568 1877 1875 0.000421 1877 1876 7.206681 1877 1877 12.182174 1877 1878 -0.000005 1877 1879 -0.918595 1877 1880 -1.552793 1877 1923 -0.000006 1877 1924 -0.970719 1877 1925 -1.640904 1877 2979 -0.000017 1877 2980 -2.883379 1877 2981 -4.874064 1878 774 -0.062289 1878 1830 -0.000468 1878 1875 -0.000523 1878 1876 2.798144 1878 1877 4.729983 1878 1878 145.776990 1878 1879 -90.858930 1878 1880 -153.587820 1878 1881 -0.005227 1878 1926 -0.000524 1878 1927 2.577854 1878 1928 4.357601 1878 2982 -0.001826 1878 2983 0.273519 1878 2984 0.462356 1879 1877 -0.766249 1879 1879 -27.776287 1879 1880 23.611475 1879 1928 -0.705924 1879 2984 -0.074900 1880 774 -0.000016 1880 775 -2.703527 1880 776 -4.570038 1880 1830 -0.000005 1880 1831 -0.822290 1880 1832 -1.389997 1880 1875 -0.000005 1880 1876 -0.918595 1880 1877 -1.552793 1880 1878 0.000397 1880 1879 9.396292 1880 1880 15.883482 1880 1881 -0.000005 1880 1882 -0.821216 1880 1883 -1.388182 1880 1926 -0.000005 1880 1927 -0.919530 1880 1928 -1.554372 1880 2982 -0.000019 1880 2983 -3.208021 1880 2984 -5.422834 1881 777 -0.062920 1881 1833 -0.000419 1881 1878 -0.000474 1881 1879 3.062025 1881 1880 5.176044 1881 1881 129.573790 1881 1882 -81.877839 1881 1883 -138.406300 1881 1884 -0.000407 1881 1929 -0.012450 1881 1930 2.824628 1881 1931 4.774750 1881 2985 -0.002084 1881 2986 0.253960 1881 2987 0.429293 1882 1880 -0.838505 1882 1882 -24.695931 1882 1883 21.278445 1882 1931 -0.773495 1882 2987 -0.069544 1883 777 -0.000018 1883 778 -3.040207 1883 779 -5.139166 1883 1833 -0.000004 1883 1834 -0.725017 1883 1835 -1.225569 1883 1878 -0.000005 1883 1879 -0.821216 1883 1880 -1.388182 1883 1881 0.000361 1883 1882 9.694401 1883 1883 16.387415 1883 1884 -0.000004 1883 1885 -0.705302 1883 1886 -1.192243 1883 1929 -0.000005 1883 1930 -0.792577 1883 1931 -1.339772 1883 2985 -0.000022 1883 2986 -3.607311 1883 2987 -6.097798 1884 780 -0.063524 1884 1836 -0.000382 1884 1881 -0.008552 1884 1882 3.938488 1884 1883 6.657621 1884 1884 108.004790 1884 1885 -70.290947 1884 1886 -118.819740 1884 1887 -0.000382 1884 1932 -0.016713 1884 1933 2.982391 1884 1934 5.041431 1884 2988 -0.002555 1884 2989 0.251268 1884 2990 0.424744 1885 1883 -1.078506 1885 1885 -20.585626 1885 1886 18.281811 1885 1934 -0.816688 1885 2990 -0.068806 1886 780 -0.000022 1886 781 -3.648100 1886 782 -6.166745 1886 1836 -0.000004 1886 1837 -0.647531 1886 1838 -1.094585 1886 1881 -0.000004 1886 1882 -0.705302 1886 1883 -1.192243 1886 1884 0.000318 1886 1885 10.639977 1886 1886 17.985806 1886 1887 -0.000004 1886 1888 -0.646639 1886 1889 -1.093077 1886 1932 -0.000004 1886 1933 -0.663057 1886 1934 -1.120832 1886 2988 -0.000027 1886 2989 -4.327036 1886 2990 -7.314416 1887 783 -0.063099 1887 1839 -0.000393 1887 1884 -0.024076 1887 1885 4.822416 1887 1886 8.151808 1887 1887 108.023360 1887 1888 -71.838586 1887 1889 -121.435950 1887 1890 -0.000402 1887 1935 -0.027603 1887 1936 3.613855 1887 1937 6.108861 1887 2991 -0.002628 1887 2992 0.288037 1887 2993 0.486898 1888 1886 -1.320541 1888 1888 -20.591437 1888 1889 18.690919 1888 1937 -0.989592 1888 2993 -0.078873 1889 783 -0.000023 1889 784 -3.649262 1889 785 -6.168712 1889 1839 -0.000004 1889 1840 -0.647745 1889 1841 -1.094948 1889 1884 -0.000004 1889 1885 -0.646639 1889 1886 -1.093077 1889 1887 0.000319 1889 1888 10.583862 1889 1889 17.890960 1889 1890 -0.000004 1889 1891 -0.662652 1889 1892 -1.120147 1889 1935 -0.000004 1889 1936 -0.647431 1889 1937 -1.094416 1889 2991 -0.000027 1889 2992 -4.327819 1889 2993 -7.315746 1890 786 -0.060195 1890 1842 -0.000436 1890 1887 -0.031542 1890 1888 5.837954 1890 1889 9.868478 1890 1890 113.444730 1890 1891 -77.174379 1890 1892 -130.455480 1890 1893 -0.000472 1890 1938 -0.040319 1890 1939 4.582750 1890 1940 7.746674 1890 2994 -0.002583 1890 2995 0.480051 1890 2996 0.811478 1891 1889 -1.598602 1891 1891 -21.627893 1891 1892 20.085606 1891 1940 -1.254884 1891 2996 -0.131449 1892 786 -0.000023 1892 787 -3.473617 1892 788 -5.871797 1892 1842 -0.000005 1892 1843 -0.695944 1892 1844 -1.176423 1892 1887 -0.000004 1892 1888 -0.662652 1892 1889 -1.120147 1892 1890 0.000333 1892 1891 10.384961 1892 1892 17.554727 1892 1893 -0.000005 1892 1894 -0.751850 1892 1895 -1.270926 1892 1938 -0.000004 1892 1939 -0.680119 1892 1940 -1.149671 1892 2994 -0.000027 1892 2995 -4.118346 1892 2996 -6.961649 1893 789 -0.053321 1893 1845 -0.000564 1893 1890 -0.045096 1893 1891 6.728683 1893 1892 11.374157 1893 1893 140.536610 1893 1894 -96.260607 1893 1895 -162.718930 1893 1896 -0.000618 1893 1941 -0.067528 1893 1942 6.595857 1893 1943 11.149637 1893 2997 -0.002154 1893 2998 0.910645 1893 2999 1.539354 1894 1892 -1.842471 1894 1894 -26.784777 1894 1895 25.043815 1894 1943 -1.806096 1894 2999 -0.249351 1895 789 -0.000019 1895 790 -2.804180 1895 791 -4.740185 1895 1845 -0.000006 1895 1846 -0.871649 1895 1847 -1.473435 1895 1890 -0.000005 1895 1891 -0.751850 1895 1892 -1.270926 1895 1893 0.000393 1895 1894 9.553912 1895 1895 16.149932 1895 1896 -0.000006 1895 1897 -0.954015 1895 1898 -1.612666 1895 1941 -0.000006 1895 1942 -0.841525 1895 1943 -1.422513 1895 2997 -0.000022 1895 2998 -3.327678 1895 2999 -5.625107 1896 792 -0.044529 1896 1848 -0.000731 1896 1893 -0.112470 1896 1894 7.574903 1896 1895 12.804616 1896 1896 183.718260 1896 1897 -128.363210 1896 1898 -216.985030 1896 1899 -0.000802 1896 1944 -0.202821 1896 1945 11.971675 1896 1946 20.236903 1896 3000 -0.001701 1896 3001 1.482458 1896 3002 2.505946 1897 1895 -2.074143 1897 1897 -35.025750 1897 1898 33.430196 1897 1946 -3.278081 1897 3002 -0.405916 1898 792 -0.000015 1898 793 -2.154605 1898 794 -3.642142 1898 1848 -0.000008 1898 1849 -1.097359 1898 1850 -1.854974 1898 1893 -0.000006 1898 1894 -0.954015 1898 1895 -1.612666 1898 1896 0.000492 1898 1897 9.067110 1898 1898 15.327034 1898 1899 -0.000008 1898 1900 -1.204310 1898 1901 -2.035764 1898 1944 -0.000007 1898 1945 -1.097232 1898 1946 -1.854760 1898 3000 -0.000018 1898 3001 -2.555645 1898 3002 -4.320061 1899 795 -0.033230 1899 1851 -0.000921 1899 1896 -0.128483 1899 1897 11.312072 1899 1898 19.121914 1899 1899 221.398250 1899 1900 -142.892820 1899 1901 -241.546020 1899 1902 -0.000994 1899 3003 -0.001452 1899 3004 2.189857 1899 3005 3.701734 1900 1898 -3.097388 1900 1900 -42.241754 1900 1901 37.042029 1900 3005 -0.599599 1901 795 -0.000013 1901 796 -1.781394 1901 797 -3.011268 1901 1851 -0.000010 1901 1852 -1.341189 1901 1853 -2.267146 1901 1896 -0.000008 1901 1897 -1.204310 1901 1898 -2.035764 1901 1899 0.000574 1901 1900 7.891224 1901 1901 13.339323 1901 1902 -0.000010 1901 1903 -1.446352 1901 1904 -2.444914 1901 3003 -0.000015 1901 3004 -2.113221 1901 3005 -3.572189 1902 798 -0.032800 1902 1854 -0.001112 1902 1899 -0.067449 1902 1900 4.815265 1902 1901 8.139723 1902 1902 264.482010 1902 1903 -161.661860 1902 1904 -273.273110 1902 3006 -0.001228 1902 3007 2.192554 1902 3008 3.706292 1903 1901 -1.318452 1903 1903 -50.484398 1903 1904 41.773412 1903 3008 -0.600333 1904 798 -0.000011 1904 799 -1.489850 1904 800 -2.518442 1904 1854 -0.000012 1904 1855 -1.600177 1904 1856 -2.704938 1904 1899 -0.000010 1904 1900 -1.446352 1904 1901 -2.444914 1904 1902 0.000664 1904 1903 6.309392 1904 1904 10.665392 1904 3006 -0.000013 1904 3007 -1.767325 1904 3008 -2.987485 1905 1905 1.000000 1906 1906 1.000000 1907 1907 1.000000 1908 1908 1.000000 1909 1909 1.000000 1910 1910 1.000000 1911 1911 1.000000 1912 1912 1.000000 1913 1913 1.000000 1914 1914 1.000000 1915 1915 1.000000 1916 1916 1.000000 1917 1917 1.000000 1918 1918 1.000000 1919 1919 1.000000 1920 1920 1.000000 1921 1921 1.000000 1922 1922 1.000000 1923 819 -0.061603 1923 1875 -0.005704 1923 1923 161.944700 1923 1924 -96.497379 1923 1925 -163.119170 1923 1926 -0.008047 1923 1971 -0.000543 1923 1972 1.519041 1923 1973 2.567787 1923 3027 -0.001612 1923 3028 0.291487 1923 3029 0.492729 1924 1924 -30.852941 1924 1925 25.038158 1924 1973 -0.415980 1924 3029 -0.079821 1925 819 -0.000014 1925 820 -2.429223 1925 821 -4.106358 1925 1875 -0.000006 1925 1876 -0.970719 1925 1877 -1.640904 1925 1923 0.000427 1925 1924 8.224674 1925 1925 13.902989 1925 1926 -0.000006 1925 1927 -0.969386 1925 1928 -1.638650 1925 1971 -0.000006 1925 1972 -0.970748 1925 1973 -1.640953 1925 3027 -0.000017 1925 3028 -2.881140 1925 3029 -4.870280 1926 822 -0.062083 1926 1878 -0.005493 1926 1923 -0.000546 1926 1924 1.594496 1926 1925 2.695336 1926 1926 161.940530 1926 1927 -98.694245 1926 1928 -166.832640 1926 1929 -0.023695 1926 1974 -0.008086 1926 1975 2.143620 1926 1976 3.623573 1926 3030 -0.001626 1926 3031 0.270891 1926 3032 0.457914 1927 1925 -0.436641 1927 1927 -30.856855 1927 1928 25.630146 1927 1976 -0.587015 1927 3032 -0.074181 1928 822 -0.000014 1928 823 -2.433610 1928 824 -4.113771 1928 1878 -0.000005 1928 1879 -0.919530 1928 1880 -1.554372 1928 1923 -0.000006 1928 1924 -0.969386 1928 1925 -1.638650 1928 1926 0.000432 1928 1927 9.065615 1928 1928 15.324507 1928 1929 -0.000005 1928 1930 -0.880782 1928 1931 -1.488873 1928 1974 -0.000006 1928 1975 -0.970848 1928 1976 -1.641121 1928 3030 -0.000017 1928 3031 -2.888000 1928 3032 -4.881872 1929 825 -0.062648 1929 1881 -0.000451 1929 1926 -0.000502 1929 1927 2.614306 1929 1928 4.419220 1929 1929 134.982910 1929 1930 -84.221274 1929 1931 -142.367640 1929 1932 -0.000420 1929 1977 -0.005546 1929 1978 2.447535 1929 1979 4.137312 1929 3033 -0.001973 1929 3034 0.262622 1929 3035 0.443935 1930 1928 -0.715906 1930 1930 -25.721199 1930 1931 21.881898 1930 1979 -0.670237 1930 3035 -0.071916 1931 825 -0.000017 1931 826 -2.918994 1931 827 -4.934267 1931 1881 -0.000005 1931 1882 -0.792577 1931 1883 -1.339772 1931 1926 -0.000005 1931 1927 -0.880782 1931 1928 -1.488873 1931 1929 0.000373 1931 1930 9.605163 1931 1931 16.236566 1931 1932 -0.000004 1931 1933 -0.737613 1931 1934 -1.246861 1931 1977 -0.000005 1931 1978 -0.808984 1931 1979 -1.367506 1931 3033 -0.000021 1931 3034 -3.463328 1931 3035 -5.854410 1932 828 -0.063486 1932 1884 -0.000385 1932 1929 -0.001938 1932 1930 3.429859 1932 1931 5.797834 1932 1932 113.387440 1932 1933 -72.722891 1932 1934 -122.930710 1932 1935 -0.000384 1932 1980 -0.008675 1932 1981 2.777829 1932 1982 4.695639 1932 3036 -0.002393 1932 3037 0.245664 1932 3038 0.415270 1933 1931 -0.939232 1933 1933 -21.611440 1933 1934 18.908185 1933 1982 -0.760679 1933 3038 -0.067272 1934 828 -0.000021 1934 829 -3.477420 1934 830 -5.878228 1934 1884 -0.000004 1934 1885 -0.663057 1934 1886 -1.120832 1934 1929 -0.000004 1934 1930 -0.737613 1934 1931 -1.246861 1934 1932 0.000328 1934 1933 10.346880 1934 1934 17.490356 1934 1935 -0.000004 1934 1936 -0.662028 1934 1937 -1.119092 1934 1980 -0.000004 1934 1981 -0.679535 1934 1982 -1.148685 1934 3036 -0.000025 1934 3037 -4.124800 1934 3038 -6.972558 1935 831 -0.063616 1935 1887 -0.000385 1935 1932 -0.013111 1935 1933 4.219542 1935 1934 7.132710 1935 1935 108.004160 1935 1936 -71.102064 1935 1937 -120.190930 1935 1938 -0.000394 1935 1983 -0.017027 1935 1984 3.507731 1935 1985 5.929468 1935 3039 -0.002576 1935 3040 0.253442 1935 3041 0.428418 1936 1934 -1.155466 1936 1936 -20.588297 1936 1937 18.497248 1936 1985 -0.960544 1936 3041 -0.069401 1937 831 -0.000023 1937 832 -3.653182 1937 833 -6.175339 1937 1887 -0.000004 1937 1888 -0.647431 1937 1889 -1.094416 1937 1932 -0.000004 1937 1933 -0.662028 1937 1934 -1.119092 1937 1935 0.000318 1937 1936 10.606735 1937 1937 17.929624 1937 1938 -0.000004 1937 1939 -0.662199 1937 1940 -1.119382 1937 1983 -0.000004 1937 1984 -0.647157 1937 1985 -1.093954 1937 3039 -0.000027 1937 3040 -4.332423 1937 3041 -7.323529 1938 834 -0.062280 1938 1890 -0.000416 1938 1935 -0.020496 1938 1936 5.068111 1938 1937 8.567135 1938 1938 113.412290 1938 1939 -76.112701 1938 1940 -128.660810 1938 1941 -0.000460 1938 1986 -0.032182 1938 1987 4.435406 1938 1988 7.497605 1938 3042 -0.002523 1938 3043 0.335842 1938 3044 0.567707 1939 1937 -1.387815 1939 1939 -21.624608 1939 1940 19.803364 1939 1988 -1.214556 1939 3044 -0.091963 1940 834 -0.000022 1940 835 -3.477370 1940 836 -5.878142 1940 1890 -0.000004 1940 1891 -0.680119 1940 1892 -1.149671 1940 1935 -0.000004 1940 1936 -0.662199 1940 1937 -1.119382 1940 1938 0.000331 1940 1939 10.374867 1940 1940 17.537663 1940 1941 -0.000005 1940 1942 -0.751356 1940 1943 -1.270091 1940 1986 -0.000004 1940 1987 -0.679026 1940 1988 -1.147825 1940 3042 -0.000026 1940 3043 -4.122364 1940 3044 -6.968440 1941 837 -0.059223 1941 1893 -0.000530 1941 1938 -0.029312 1941 1939 5.897699 1941 1940 9.969463 1941 1941 140.385140 1941 1942 -92.621167 1941 1943 -156.566820 1941 1944 -0.000600 1941 1989 -0.005705 1941 1990 4.155929 1941 1991 7.025182 1941 3045 -0.002099 1941 3046 0.511721 1941 3047 0.865014 1942 1940 -1.614953 1942 1942 -26.781272 1942 1943 24.056464 1942 1991 -1.138001 1942 3047 -0.140121 1943 837 -0.000019 1943 838 -2.813264 1943 839 -4.755541 1943 1893 -0.000006 1943 1894 -0.841525 1943 1895 -1.422513 1943 1938 -0.000005 1943 1939 -0.751356 1943 1940 -1.270091 1943 1941 0.000391 1943 1942 9.537883 1943 1943 16.122836 1943 1944 -0.000006 1943 1945 -0.953417 1943 1946 -1.611656 1943 1989 -0.000005 1943 1990 -0.841068 1943 1991 -1.421741 1943 3045 -0.000022 1943 3046 -3.334240 1943 3047 -5.636199 1944 840 -0.056386 1944 1896 -0.000703 1944 1941 -0.012654 1944 1942 4.640189 1944 1943 7.843776 1944 1944 183.651590 1944 1945 -118.357430 1944 1946 -200.071250 1944 1992 -0.008260 1944 1993 5.798895 1944 1994 9.802444 1944 3048 -0.001633 1944 3049 0.657020 1944 3050 1.110625 1945 1943 -1.270590 1945 1945 -35.029675 1945 1946 30.681916 1945 1994 -1.587871 1945 3050 -0.179905 1946 840 -0.000014 1946 841 -2.149620 1946 842 -3.633714 1946 1896 -0.000007 1946 1897 -1.097232 1946 1898 -1.854760 1946 1941 -0.000006 1946 1942 -0.953417 1946 1943 -1.611656 1946 1944 0.000481 1946 1945 7.837005 1946 1946 13.247663 1946 1992 -0.000007 1946 1993 -1.082569 1946 1994 -1.829974 1946 3048 -0.000017 1946 3049 -2.550221 1946 3050 -4.310890 1947 1947 1.000000 1948 1948 1.000000 1949 1949 1.000000 1950 1950 1.000000 1951 1951 1.000000 1952 1952 1.000000 1953 1953 1.000000 1954 1954 1.000000 1955 1955 1.000000 1956 1956 1.000000 1957 1957 1.000000 1958 1958 1.000000 1959 1959 1.000000 1960 1960 1.000000 1961 1961 1.000000 1962 1962 1.000000 1963 1963 1.000000 1964 1964 1.000000 1965 1965 1.000000 1966 1966 1.000000 1967 1967 1.000000 1968 1968 1.000000 1969 1969 1.000000 1970 1970 1.000000 1971 867 -0.061593 1971 1923 -0.008844 1971 1971 161.943980 1971 1972 -96.038303 1971 1973 -162.343150 1971 1974 -0.023870 1971 2019 -0.000540 1971 2020 1.059080 1971 2021 1.790269 1971 3075 -0.001602 1971 3076 0.292351 1971 3077 0.494191 1972 1972 -30.849071 1972 1973 24.921984 1972 2021 -0.290023 1972 3077 -0.080059 1973 867 -0.000014 1973 868 -2.429554 1973 869 -4.106918 1973 1923 -0.000006 1973 1924 -0.970748 1973 1925 -1.640953 1973 1971 0.000427 1973 1972 8.225719 1973 1973 13.904756 1973 1974 -0.000006 1973 1975 -0.969537 1973 1976 -1.638906 1973 2019 -0.000006 1973 2020 -0.970892 1973 2021 -1.641196 1973 3075 -0.000017 1973 3076 -2.881532 1973 3077 -4.870942 1974 870 -0.061994 1974 1926 -0.000542 1974 1971 -0.000541 1974 1972 0.971131 1974 1973 1.641600 1974 1974 161.972440 1974 1975 -97.548639 1974 1976 -164.896130 1974 1977 -0.022404 1974 2022 -0.000533 1974 2023 1.621599 1974 2024 2.741148 1974 3078 -0.001610 1974 3079 0.272826 1974 3080 0.461184 1975 1973 -0.265938 1975 1975 -30.853874 1975 1976 25.323854 1975 2024 -0.444065 1975 3080 -0.074711 1976 870 -0.000014 1976 871 -2.432101 1976 872 -4.111220 1976 1926 -0.000006 1976 1927 -0.970848 1976 1928 -1.641121 1976 1971 -0.000006 1976 1972 -0.969537 1976 1973 -1.638906 1976 1974 0.000432 1976 1975 9.097437 1976 1976 15.378299 1976 1977 -0.000005 1976 1978 -0.881342 1976 1979 -1.489819 1976 2022 -0.000006 1976 2023 -0.954392 1976 2024 -1.613303 1976 3078 -0.000017 1976 3079 -2.885760 1976 3080 -4.878084 1977 873 -0.062597 1977 1929 -0.000455 1977 1974 -0.000496 1977 1975 1.895418 1977 1976 3.204013 1977 1977 134.977250 1977 1978 -83.065857 1977 1979 -140.414520 1977 1980 -0.003258 1977 2025 -0.002751 1977 2026 2.015803 1977 2027 3.407513 1977 3081 -0.001948 1977 3082 0.262586 1977 3083 0.443875 1978 1976 -0.519047 1978 1978 -25.717348 1978 1979 21.575094 1978 2027 -0.552014 1978 3083 -0.071907 1979 873 -0.000017 1979 874 -2.917556 1979 875 -4.931837 1979 1929 -0.000005 1979 1930 -0.808984 1979 1931 -1.367506 1979 1974 -0.000005 1979 1975 -0.881342 1979 1976 -1.489819 1979 1977 0.000372 1979 1978 9.602247 1979 1979 16.231637 1979 1980 -0.000004 1979 1981 -0.737694 1979 1982 -1.246998 1979 2025 -0.000005 1979 2026 -0.792487 1979 2027 -1.339620 1979 3081 -0.000020 1979 3082 -3.461300 1979 3083 -5.850982 1980 876 -0.063482 1980 1932 -0.000388 1980 1977 -0.000421 1980 1978 2.646479 1980 1979 4.473608 1980 1980 113.377560 1980 1981 -71.634305 1980 1982 -121.090540 1980 1983 -0.000378 1980 2028 -0.010229 1980 2029 2.466187 1980 2030 4.168840 1980 3084 -0.002354 1980 3085 0.242048 1980 3086 0.409158 1981 1979 -0.724716 1981 1981 -21.607397 1981 1982 18.620214 1981 2030 -0.675345 1981 3086 -0.066282 1982 876 -0.000021 1982 877 -3.476062 1982 878 -5.875930 1982 1932 -0.000004 1982 1933 -0.679535 1982 1934 -1.148685 1982 1977 -0.000004 1982 1978 -0.737694 1982 1979 -1.246998 1982 1980 0.000327 1982 1981 10.343291 1982 1982 17.484288 1982 1983 -0.000004 1982 1984 -0.661601 1982 1985 -1.118369 1982 2028 -0.000004 1982 2029 -0.662996 1982 2030 -1.120728 1982 3084 -0.000025 1982 3085 -4.122979 1982 3086 -6.969480 1983 879 -0.063837 1983 1935 -0.000377 1983 1980 -0.004142 1983 1981 3.335276 1983 1982 5.637947 1983 1983 107.984370 1983 1984 -70.246557 1983 1985 -118.744780 1983 1986 -0.000386 1983 2031 -0.017480 1983 2032 3.552218 1983 2033 6.004669 1983 3087 -0.002525 1983 3088 0.239723 1983 3089 0.405227 1984 1982 -0.913330 1984 1984 -20.583992 1984 1985 18.273817 1984 2033 -0.972738 1984 3089 -0.065645 1985 879 -0.000022 1985 880 -3.656789 1985 881 -6.181435 1985 1935 -0.000004 1985 1936 -0.647157 1985 1937 -1.093954 1985 1980 -0.000004 1985 1981 -0.661601 1985 1982 -1.118369 1985 1983 0.000317 1985 1984 10.613731 1985 1985 17.941450 1985 1986 -0.000004 1985 1987 -0.662277 1985 1988 -1.119512 1985 2031 -0.000004 1985 2032 -0.646987 1985 2033 -1.093667 1985 3087 -0.000026 1985 3088 -4.336609 1985 3089 -7.330604 1986 882 -0.063020 1986 1938 -0.000405 1986 1983 -0.006533 1986 1984 4.332274 1986 1985 7.323277 1986 1986 113.439620 1986 1987 -77.100192 1986 1988 -130.330070 1986 1989 -0.000449 1986 2034 -0.025133 1986 2035 6.215425 1986 2036 10.506548 1986 3090 -0.002464 1986 3091 0.284331 1986 3092 0.480633 1987 1985 -1.186333 1987 1987 -21.620543 1987 1988 20.084135 1987 2036 -1.702018 1987 3092 -0.077859 1988 882 -0.000022 1988 883 -3.480307 1988 884 -5.883107 1988 1938 -0.000004 1988 1939 -0.679026 1988 1940 -1.147825 1988 1983 -0.000004 1988 1984 -0.662277 1988 1985 -1.119512 1988 1986 0.000330 1988 1987 10.397991 1988 1988 17.576753 1988 1989 -0.000005 1988 1990 -0.752022 1988 1991 -1.271217 1988 2034 -0.000004 1988 2035 -0.694510 1988 2036 -1.173998 1988 3090 -0.000026 1988 3091 -4.127419 1988 3092 -6.976984 1989 885 -0.060966 1989 1941 -0.000520 1989 1986 -0.059886 1989 1987 7.099303 1989 1988 12.000653 1989 1989 140.330510 1989 1990 -89.553894 1989 1991 -151.381900 1989 1992 -0.000582 1989 3093 -0.002060 1989 3094 0.380663 1989 3095 0.643473 1990 1988 -1.944016 1990 1990 -26.774330 1990 1991 23.233965 1990 3095 -0.104236 1991 885 -0.000018 1991 886 -2.808630 1991 887 -4.747708 1991 1941 -0.000005 1991 1942 -0.841068 1991 1943 -1.421741 1991 1986 -0.000005 1991 1987 -0.752022 1991 1988 -1.271217 1991 1989 0.000384 1991 1990 8.674964 1991 1991 14.664157 1991 1992 -0.000006 1991 1993 -0.940982 1991 1994 -1.590636 1991 3093 -0.000021 1991 3094 -3.329250 1991 3095 -5.627765 1992 888 -0.059611 1992 1944 -0.000680 1992 1989 -0.011693 1992 1990 4.188870 1992 1991 7.080866 1992 1992 178.074790 1992 1993 -108.790480 1992 1994 -183.899280 1992 3096 -0.001651 1992 3097 0.439028 1992 3098 0.742132 1993 1991 -1.147021 1993 1993 -33.989894 1993 1994 28.136886 1993 3098 -0.120216 1994 888 -0.000015 1994 889 -2.216528 1994 890 -3.746815 1994 1944 -0.000007 1994 1945 -1.082569 1994 1946 -1.829974 1994 1989 -0.000006 1994 1990 -0.940982 1994 1991 -1.590636 1994 1992 0.000462 1994 1993 6.870994 1994 1994 11.614721 1994 3096 -0.000017 1994 3097 -2.627090 1994 3098 -4.440830 1995 1995 1.000000 1996 1996 1.000000 1997 1997 1.000000 1998 1998 1.000000 1999 1999 1.000000 2000 2000 1.000000 2001 2001 1.000000 2002 2002 1.000000 2003 2003 1.000000 2004 2004 1.000000 2005 2005 1.000000 2006 2006 1.000000 2007 2007 1.000000 2008 2008 1.000000 2009 2009 1.000000 2010 2010 1.000000 2011 2011 1.000000 2012 2012 1.000000 2013 2013 1.000000 2014 2014 1.000000 2015 2015 1.000000 2016 2016 1.000000 2017 2017 1.000000 2018 2018 1.000000 2019 915 -0.061606 2019 1971 -0.004020 2019 2019 161.942500 2019 2020 -94.979557 2019 2021 -160.553440 2019 2022 -0.021480 2019 3123 -0.001594 2019 3124 0.288919 2019 3125 0.488389 2020 2020 -30.846670 2020 2021 24.637981 2020 3125 -0.079119 2021 915 -0.000014 2021 916 -2.428066 2021 917 -4.104402 2021 1971 -0.000006 2021 1972 -0.970892 2021 1973 -1.641196 2021 2019 0.000421 2021 2020 7.235636 2021 2021 12.231119 2021 2022 -0.000006 2021 2023 -0.953300 2021 2024 -1.611457 2021 3123 -0.000017 2021 3124 -2.879925 2021 3125 -4.868225 2022 918 -0.062109 2022 1974 -0.005943 2022 2019 -0.000528 2022 2020 0.374978 2022 2021 0.633863 2022 2022 156.564940 2022 2023 -93.134441 2022 2024 -157.434340 2022 2025 -0.028856 2022 2070 -0.001318 2022 2071 0.964984 2022 2072 1.631208 2022 3126 -0.001653 2022 3127 0.268406 2022 3128 0.453714 2023 2021 -0.102686 2023 2023 -29.821783 2023 2024 24.170331 2023 2072 -0.264256 2023 3128 -0.073501 2024 918 -0.000015 2024 919 -2.514767 2024 920 -4.250958 2024 1974 -0.000006 2024 1975 -0.954392 2024 1976 -1.613303 2024 2019 -0.000006 2024 2020 -0.953300 2024 2021 -1.611457 2024 2022 0.000419 2024 2023 9.145346 2024 2024 15.459282 2024 2025 -0.000005 2024 2026 -0.848694 2024 2027 -1.434632 2024 2070 -0.000005 2024 2071 -0.887083 2024 2072 -1.499525 2024 3126 -0.000017 2024 3127 -2.983769 2024 3128 -5.043760 2025 921 -0.062807 2025 1977 -0.000441 2025 2022 -0.000473 2025 2023 1.108379 2025 2024 1.873602 2025 2025 129.588830 2025 2026 -78.577491 2025 2027 -132.827390 2025 2028 -0.011540 2025 2073 -0.000916 2025 2074 1.470365 2025 2075 2.485505 2025 3129 -0.002008 2025 3130 0.254955 2025 3131 0.430975 2026 2024 -0.303523 2026 2026 -24.685307 2026 2027 20.401186 2026 2075 -0.402652 2026 3131 -0.069818 2027 921 -0.000018 2027 922 -3.038776 2027 923 -5.136748 2027 1977 -0.000005 2027 1978 -0.792487 2027 1979 -1.339620 2027 2022 -0.000005 2027 2023 -0.848694 2027 2024 -1.434632 2027 2025 0.000360 2027 2026 9.717688 2027 2027 16.426779 2027 2028 -0.000004 2027 2029 -0.705276 2027 2030 -1.192198 2027 2073 -0.000004 2027 2074 -0.724895 2027 2075 -1.225362 2027 3129 -0.000021 2027 3130 -3.604792 2027 3131 -6.093541 2028 924 -0.063624 2028 1980 -0.000373 2028 2025 -0.000397 2028 2026 1.700641 2028 2027 2.874763 2028 2028 107.991650 2028 2029 -66.997482 2028 2030 -113.252470 2028 2031 -0.004181 2028 2076 -0.004298 2028 2077 1.944635 2028 2078 3.287208 2028 3132 -0.002434 2028 3133 0.237593 2028 3134 0.401627 2029 2027 -0.465709 2029 2029 -20.575274 2029 2030 17.405884 2029 2078 -0.532526 2029 3134 -0.065063 2030 924 -0.000021 2030 925 -3.647962 2030 926 -6.166510 2030 1980 -0.000004 2030 1981 -0.662996 2030 1982 -1.120728 2030 2025 -0.000004 2030 2026 -0.705276 2030 2027 -1.192198 2030 2028 0.000315 2030 2029 10.639110 2030 2030 17.984341 2030 2031 -0.000004 2030 2032 -0.646747 2030 2033 -1.093260 2030 2076 -0.000004 2030 2077 -0.647143 2030 2078 -1.093929 2030 3132 -0.000025 2030 3133 -4.326679 2030 3134 -7.313814 2031 927 -0.063795 2031 1983 -0.000369 2031 2028 -0.000369 2031 2029 2.115171 2031 2030 3.575483 2031 2031 107.987120 2031 2032 -68.038213 2031 2033 -115.011800 2031 2034 -0.000386 2031 2079 -0.004367 2031 2080 2.573304 2031 2081 4.349913 2031 3135 -0.002466 2031 3136 0.229615 2031 3137 0.388141 2032 2030 -0.579222 2032 2032 -20.579659 2032 2033 17.679983 2032 2081 -0.704679 2032 3137 -0.062878 2033 927 -0.000022 2033 928 -3.648922 2033 929 -6.168137 2033 1983 -0.000004 2033 1984 -0.646987 2033 1985 -1.093667 2033 2028 -0.000004 2033 2029 -0.646747 2033 2030 -1.093260 2033 2031 0.000315 2033 2032 10.596529 2033 2033 17.912372 2033 2034 -0.000004 2033 2035 -0.677482 2033 2036 -1.145215 2033 2079 -0.000004 2033 2080 -0.646870 2033 2081 -1.093470 2033 3135 -0.000026 2033 3136 -4.327212 2033 3137 -7.314718 2034 930 -0.063493 2034 1986 -0.000401 2034 2031 -0.000464 2034 2032 2.088239 2034 2033 3.529959 2034 2034 118.776760 2034 2035 -74.824506 2034 2036 -126.483280 2034 2082 -0.009178 2034 2083 3.072266 2034 2084 5.193354 2034 3138 -0.002271 2034 3139 0.237356 2034 3140 0.401227 2035 2033 -0.571843 2035 2035 -22.641647 2035 2036 19.433192 2035 2084 -0.841311 2035 3140 -0.064997 2036 930 -0.000020 2036 931 -3.320339 2036 932 -5.612698 2036 1986 -0.000004 2036 1987 -0.694510 2036 1988 -1.173998 2036 2031 -0.000004 2036 2032 -0.677482 2036 2033 -1.145215 2036 2034 0.000334 2036 2035 9.359233 2036 2036 15.820839 2036 2082 -0.000004 2036 2083 -0.727555 2036 2084 -1.229859 2036 3138 -0.000024 2036 3139 -3.936805 2036 3140 -6.654771 2037 2037 1.000000 2038 2038 1.000000 2039 2039 1.000000 2040 2040 1.000000 2041 2041 1.000000 2042 2042 1.000000 2043 2043 1.000000 2044 2044 1.000000 2045 2045 1.000000 2046 2046 1.000000 2047 2047 1.000000 2048 2048 1.000000 2049 2049 1.000000 2050 2050 1.000000 2051 2051 1.000000 2052 2052 1.000000 2053 2053 1.000000 2054 2054 1.000000 2055 2055 1.000000 2056 2056 1.000000 2057 2057 1.000000 2058 2058 1.000000 2059 2059 1.000000 2060 2060 1.000000 2061 2061 1.000000 2062 2062 1.000000 2063 2063 1.000000 2064 2064 1.000000 2065 2065 1.000000 2066 2066 1.000000 2067 2067 1.000000 2068 2068 1.000000 2069 2069 1.000000 2070 966 -0.062498 2070 2022 -0.000489 2070 2070 140.357330 2070 2071 -82.325452 2070 2072 -139.162850 2070 2073 -0.025370 2070 3174 -0.001836 2070 3175 0.261047 2070 3176 0.441274 2071 2071 -26.735187 2071 2072 21.352282 2071 3176 -0.071486 2072 966 -0.000016 2072 967 -2.805286 2072 968 -4.742052 2072 2022 -0.000005 2072 2023 -0.887083 2072 2024 -1.499525 2072 2070 0.000373 2072 2071 7.774021 2072 2072 13.141196 2072 2073 -0.000004 2072 2074 -0.751144 2072 2075 -1.269733 2072 3174 -0.000019 2072 3175 -3.327513 2072 3176 -5.624825 2073 969 -0.063249 2073 2025 -0.000400 2073 2070 -0.000415 2073 2071 0.274430 2073 2072 0.463896 2073 2073 113.398910 2073 2074 -67.964341 2073 2075 -114.886920 2073 2076 -0.014399 2073 2121 -0.000366 2073 2122 1.171810 2073 2123 1.980828 2073 3177 -0.002275 2073 3178 0.247127 2073 3179 0.417743 2074 2072 -0.075151 2074 2074 -21.597166 2074 2075 17.640585 2074 2123 -0.320895 2074 3179 -0.067674 2075 969 -0.000020 2075 970 -3.471673 2075 971 -5.868516 2075 2025 -0.000004 2075 2026 -0.724895 2075 2027 -1.225362 2075 2070 -0.000004 2075 2071 -0.751144 2075 2072 -1.269733 2075 2073 0.000325 2075 2074 10.393410 2075 2075 17.569019 2075 2076 -0.000004 2075 2077 -0.662557 2075 2078 -1.119986 2075 2121 -0.000004 2075 2122 -0.662992 2075 2123 -1.120722 2075 3177 -0.000024 2075 3178 -4.117729 2075 3179 -6.960609 2076 972 -0.063744 2076 2028 -0.000360 2076 2073 -0.000368 2076 2074 0.950555 2076 2075 1.606818 2076 2076 107.992110 2076 2077 -65.831628 2076 2078 -111.281710 2076 2079 -0.004244 2076 2124 -0.000360 2076 2125 1.536007 2076 2126 2.596464 2076 3180 -0.002402 2076 3181 0.225549 2076 3182 0.381267 2077 2075 -0.260304 2077 2077 -20.572200 2077 2078 17.094281 2077 2126 -0.420628 2077 3182 -0.061765 2078 972 -0.000021 2078 973 -3.645145 2078 974 -6.161749 2078 2028 -0.000004 2078 2029 -0.647143 2078 2030 -1.093929 2078 2073 -0.000004 2078 2074 -0.662557 2078 2075 -1.119986 2078 2076 0.000314 2078 2077 10.574418 2078 2078 17.874985 2078 2079 -0.000004 2078 2080 -0.646832 2078 2081 -1.093405 2078 2124 -0.000004 2078 2125 -0.647096 2078 2126 -1.093851 2078 3180 -0.000025 2078 3181 -4.323339 2078 3182 -7.308167 2079 975 -0.063758 2079 2031 -0.000363 2079 2076 -0.000363 2079 2077 1.485970 2079 2078 2.511882 2079 2079 107.979000 2079 2080 -66.940390 2079 2081 -113.156040 2079 2082 -0.004367 2079 2127 -0.000380 2079 2128 2.108747 2079 2129 3.564626 2079 3183 -0.002427 2079 3184 0.229192 2079 3185 0.387426 2080 2078 -0.406923 2080 2080 -20.575438 2080 2081 17.389873 2080 2129 -0.577468 2080 3185 -0.062762 2081 975 -0.000021 2081 976 -3.648793 2081 977 -6.167920 2081 2031 -0.000004 2081 2032 -0.646870 2081 2033 -1.093470 2081 2076 -0.000004 2081 2077 -0.646832 2081 2078 -1.093405 2081 2079 0.000315 2081 2080 10.641571 2081 2081 17.988511 2081 2082 -0.000004 2081 2083 -0.691878 2081 2084 -1.169550 2081 2127 -0.000004 2081 2128 -0.677665 2081 2129 -1.145525 2081 3183 -0.000025 2081 3184 -4.327224 2081 3185 -7.314740 2082 978 -0.063402 2082 2034 -0.000413 2082 2079 -0.000392 2082 2080 1.963315 2082 2081 3.318788 2082 2082 124.164440 2082 2083 -74.777714 2082 2084 -126.404160 2082 3186 -0.002134 2082 3187 0.229163 2082 3188 0.387377 2083 2081 -0.537639 2083 2083 -23.666192 2083 2084 19.383922 2083 3188 -0.062754 2084 978 -0.000019 2084 979 -3.173069 2084 980 -5.363752 2084 2034 -0.000004 2084 2035 -0.727555 2084 2036 -1.229859 2084 2079 -0.000004 2084 2080 -0.691878 2084 2081 -1.169550 2084 2082 0.000340 2084 2083 8.357926 2084 2084 14.128229 2084 3186 -0.000022 2084 3187 -3.762768 2084 3188 -6.360580 2085 2085 1.000000 2086 2086 1.000000 2087 2087 1.000000 2088 2088 1.000000 2089 2089 1.000000 2090 2090 1.000000 2091 2091 1.000000 2092 2092 1.000000 2093 2093 1.000000 2094 2094 1.000000 2095 2095 1.000000 2096 2096 1.000000 2097 2097 1.000000 2098 2098 1.000000 2099 2099 1.000000 2100 2100 1.000000 2101 2101 1.000000 2102 2102 1.000000 2103 2103 1.000000 2104 2104 1.000000 2105 2105 1.000000 2106 2106 1.000000 2107 2107 1.000000 2108 2108 1.000000 2109 2109 1.000000 2110 2110 1.000000 2111 2111 1.000000 2112 2112 1.000000 2113 2113 1.000000 2114 2114 1.000000 2115 2115 1.000000 2116 2116 1.000000 2117 2117 1.000000 2118 2118 1.000000 2119 2119 1.000000 2120 2120 1.000000 2121 1017 -0.063775 2121 2073 -0.000421 2121 2121 107.984440 2121 2122 -64.108336 2121 2123 -108.368730 2121 2124 -0.013898 2121 2169 -0.000355 2121 2170 0.763957 2121 2171 1.291392 2121 3225 -0.002371 2121 3226 0.220269 2121 3227 0.372344 2122 2122 -20.566613 2122 2123 16.636125 2122 2171 -0.209207 2122 3227 -0.060320 2123 1017 -0.000021 2123 1018 -3.643823 2123 1019 -6.159519 2123 2073 -0.000004 2123 2074 -0.662992 2123 2075 -1.120722 2123 2121 0.000309 2123 2122 9.925047 2123 2123 16.777299 2123 2124 -0.000004 2123 2125 -0.647000 2123 2126 -1.093689 2123 2169 -0.000004 2123 2170 -0.647158 2123 2171 -1.093956 2123 3225 -0.000025 2123 3226 -4.321770 2123 3227 -7.305520 2124 1020 -0.063794 2124 2076 -0.000572 2124 2121 -0.000356 2124 2122 0.535967 2124 2123 0.905999 2124 2124 107.995000 2124 2125 -64.988562 2124 2126 -109.856560 2124 2127 -0.004156 2124 2172 -0.000356 2124 2173 1.120414 2124 2174 1.893947 2124 3228 -0.002378 2124 3229 0.218914 2124 3230 0.370051 2125 2123 -0.146772 2125 2125 -20.569350 2125 2126 16.870519 2125 2174 -0.306821 2125 3230 -0.059948 2126 1020 -0.000021 2126 1021 -3.643718 2126 1022 -6.159334 2126 2076 -0.000004 2126 2077 -0.647096 2126 2078 -1.093851 2126 2121 -0.000004 2126 2122 -0.647000 2126 2123 -1.093689 2126 2124 0.000313 2126 2125 10.586380 2126 2126 17.895203 2126 2127 -0.000004 2126 2128 -0.677986 2126 2129 -1.146067 2126 2172 -0.000004 2126 2173 -0.647053 2126 2174 -1.093777 2126 3228 -0.000025 2126 3229 -4.321222 2126 3230 -7.304589 2127 1023 -0.063581 2127 2079 -0.000890 2127 2124 -0.000376 2127 2125 1.057110 2127 2126 1.786937 2127 2127 118.769100 2127 2128 -70.706098 2127 2129 -119.521590 2127 3231 -0.002177 2127 3232 0.218447 2127 3233 0.369263 2128 2126 -0.289484 2128 2128 -22.628834 2128 2129 18.337250 2128 3233 -0.059820 2129 1023 -0.000019 2129 1024 -3.313785 2129 1025 -5.601621 2129 2079 -0.000004 2129 2080 -0.677665 2129 2081 -1.145525 2129 2124 -0.000004 2129 2125 -0.677986 2129 2126 -1.146067 2129 2127 0.000328 2129 2128 8.602428 2129 2129 14.541544 2129 3231 -0.000023 2129 3232 -3.930456 2129 3233 -6.644043 2130 2130 1.000000 2131 2131 1.000000 2132 2132 1.000000 2133 2133 1.000000 2134 2134 1.000000 2135 2135 1.000000 2136 2136 1.000000 2137 2137 1.000000 2138 2138 1.000000 2139 2139 1.000000 2140 2140 1.000000 2141 2141 1.000000 2142 2142 1.000000 2143 2143 1.000000 2144 2144 1.000000 2145 2145 1.000000 2146 2146 1.000000 2147 2147 1.000000 2148 2148 1.000000 2149 2149 1.000000 2150 2150 1.000000 2151 2151 1.000000 2152 2152 1.000000 2153 2153 1.000000 2154 2154 1.000000 2155 2155 1.000000 2156 2156 1.000000 2157 2157 1.000000 2158 2158 1.000000 2159 2159 1.000000 2160 2160 1.000000 2161 2161 1.000000 2162 2162 1.000000 2163 2163 1.000000 2164 2164 1.000000 2165 2165 1.000000 2166 2166 1.000000 2167 2167 1.000000 2168 2168 1.000000 2169 1065 -0.063871 2169 2121 -0.005251 2169 2169 107.981400 2169 2170 -63.334227 2169 2171 -107.060180 2169 2172 -0.014356 2169 3273 -0.002358 2169 3274 0.212070 2169 3275 0.358484 2170 2170 -20.564573 2170 2171 16.429162 2170 3275 -0.058075 2171 1065 -0.000021 2171 1066 -3.642639 2171 1067 -6.157516 2171 2121 -0.000004 2171 2122 -0.647158 2171 2123 -1.093956 2171 2169 0.000305 2171 2170 9.259477 2171 2171 15.652221 2171 2172 -0.000004 2171 2173 -0.647013 2171 2174 -1.093711 2171 3273 -0.000025 2171 3274 -4.320365 2171 3275 -7.303145 2172 1068 -0.063889 2172 2124 -0.004792 2172 2169 -0.000354 2172 2170 0.179397 2172 2171 0.303252 2172 2172 107.993130 2172 2173 -63.508591 2172 2174 -107.354860 2172 3276 -0.002361 2172 3277 0.212058 2172 3278 0.358463 2173 2171 -0.049127 2173 2173 -20.566709 2173 2174 16.471721 2173 3278 -0.058071 2174 1068 -0.000021 2174 1069 -3.643656 2174 1070 -6.159233 2174 2124 -0.000004 2174 2125 -0.647053 2174 2126 -1.093777 2174 2169 -0.000004 2174 2170 -0.647013 2174 2171 -1.093711 2174 2172 0.000305 2174 2173 9.261599 2174 2174 15.655799 2174 3276 -0.000025 2174 3277 -4.321573 2174 3278 -7.305183 2175 2175 1.000000 2176 2176 1.000000 2177 2177 1.000000 2178 2178 1.000000 2179 2179 1.000000 2180 2180 1.000000 2181 2181 1.000000 2182 2182 1.000000 2183 2183 1.000000 2184 2184 1.000000 2185 2185 1.000000 2186 2186 1.000000 2187 2187 1.000000 2188 2188 1.000000 2189 2189 1.000000 2190 2190 1.000000 2191 2191 1.000000 2192 2192 1.000000 2193 2193 1.000000 2194 2194 1.000000 2195 2195 1.000000 2196 2196 1.000000 2197 2197 1.000000 2198 2198 1.000000 2199 2199 1.000000 2200 2200 1.000000 2201 2201 1.000000 2202 2202 1.000000 2203 2203 1.000000 2204 2204 1.000000 2205 2205 1.000000 2206 2206 1.000000 2207 2207 1.000000 2208 2208 1.000000 2209 2209 1.000000 2210 2210 1.000000 2211 2211 1.000000 2212 2212 1.000000 2213 2213 1.000000 2214 2214 1.000000 2215 2215 1.000000 2216 2216 1.000000 2217 2217 1.000000 2218 2218 1.000000 2219 2219 1.000000 2220 2220 1.000000 2221 2221 1.000000 2222 2222 1.000000 2223 2223 1.000000 2224 2224 1.000000 2225 2225 1.000000 2226 2226 1.000000 2227 2227 1.000000 2228 2228 1.000000 2229 2229 1.000000 2230 2230 1.000000 2231 2231 1.000000 2232 2232 1.000000 2233 2233 1.000000 2234 2234 1.000000 2235 2235 1.000000 2236 2236 1.000000 2237 2237 1.000000 2238 2238 1.000000 2239 2239 1.000000 2240 2240 1.000000 2241 2241 1.000000 2242 2242 1.000000 2243 2243 1.000000 2244 2244 1.000000 2245 2245 1.000000 2246 2246 1.000000 2247 2247 1.000000 2248 2248 1.000000 2249 2249 1.000000 2250 2250 1.000000 2251 2251 1.000000 2252 2252 1.000000 2253 2253 1.000000 2254 2254 1.000000 2255 2255 1.000000 2256 2256 1.000000 2257 2257 1.000000 2258 2258 1.000000 2259 2259 1.000000 2260 2260 1.000000 2261 2261 1.000000 2262 2262 1.000000 2263 2263 1.000000 2264 2264 1.000000 2265 2265 1.000000 2266 2266 1.000000 2267 2267 1.000000 2268 2268 1.000000 2269 2269 1.000000 2270 2270 1.000000 2271 2271 1.000000 2272 2272 1.000000 2273 2273 1.000000 2274 2274 1.000000 2275 2275 1.000000 2276 2276 1.000000 2277 2277 1.000000 2278 2278 1.000000 2279 2279 1.000000 2280 2280 1.000000 2281 2281 1.000000 2282 2282 1.000000 2283 2283 1.000000 2284 2284 1.000000 2285 2285 1.000000 2286 2286 1.000000 2287 2287 1.000000 2288 2288 1.000000 2289 2289 1.000000 2290 2290 1.000000 2291 2291 1.000000 2292 2292 1.000000 2293 2293 1.000000 2294 2294 1.000000 2295 2295 1.000000 2296 2296 1.000000 2297 2297 1.000000 2298 2298 1.000000 2299 2299 1.000000 2300 2300 1.000000 2301 2301 1.000000 2302 2302 1.000000 2303 2303 1.000000 2304 2304 1.000000 2305 2305 1.000000 2306 2306 1.000000 2307 2307 1.000000 2308 2308 1.000000 2309 2309 1.000000 2310 2310 1.000000 2311 2311 1.000000 2312 2312 1.000000 2313 2313 1.000000 2314 2314 1.000000 2315 2315 1.000000 2316 2316 1.000000 2317 2317 1.000000 2318 2318 1.000000 2319 2319 1.000000 2320 2320 1.000000 2321 2321 1.000000 2322 2322 1.000000 2323 2323 1.000000 2324 2324 1.000000 2325 2325 1.000000 2326 2326 1.000000 2327 2327 1.000000 2328 2328 1.000000 2329 2329 1.000000 2330 2330 1.000000 2331 2331 1.000000 2332 2332 1.000000 2333 2333 1.000000 2334 2334 1.000000 2335 2335 1.000000 2336 2336 1.000000 2337 2337 1.000000 2338 2338 1.000000 2339 2339 1.000000 2340 2340 1.000000 2341 2341 1.000000 2342 2342 1.000000 2343 1239 -1.623128 2343 2343 206.087320 2343 2344 -134.756290 2343 2345 -227.792040 2343 2346 -0.597370 2343 2391 -2.935558 2344 2344 -27.720556 2344 2345 25.292823 2345 1239 -0.179884 2345 1240 -0.904106 2345 1241 -1.528301 2345 2343 0.427251 2345 2344 1.748997 2345 2345 2.956504 2345 2346 -0.081461 2345 2347 -0.409416 2345 2348 -0.692077 2345 2391 -0.086021 2345 2392 -0.432400 2345 2393 -0.730930 2346 1242 -1.075363 2346 2343 -0.437446 2346 2344 0.447709 2346 2345 0.756808 2346 2346 192.135300 2346 2347 -126.627090 2346 2348 -214.050270 2346 2349 -0.430306 2346 2394 -1.366976 2347 2345 -0.072554 2347 2347 -28.872728 2347 2348 26.519672 2348 1242 -0.095840 2348 1243 -1.378043 2348 1244 -2.329442 2348 2343 -0.081461 2348 2344 -0.409416 2348 2345 -0.692077 2348 2346 0.335376 2348 2347 2.918107 2348 2348 4.932764 2348 2349 -0.038350 2348 2350 -0.551416 2348 2351 -0.932112 2348 2394 -0.040056 2348 2395 -0.576030 2348 2396 -0.973720 2349 1245 -0.775988 2349 2346 -0.290225 2349 2347 0.252147 2349 2348 0.426230 2349 2349 178.503430 2349 2350 -117.763870 2349 2351 -199.068040 2349 2397 -1.007434 2350 2348 -0.048115 2350 2350 -29.017221 2350 2351 26.676978 2351 1245 -0.048389 2351 1246 -1.856517 2351 1247 -3.138256 2351 2346 -0.038350 2351 2347 -0.551416 2351 2348 -0.932112 2351 2349 0.184065 2351 2350 3.094806 2351 2351 5.231460 2351 2397 -0.017817 2351 2398 -0.683654 2351 2399 -1.155649 2352 2352 1.000000 2353 2353 1.000000 2354 2354 1.000000 2355 2355 1.000000 2356 2356 1.000000 2357 2357 1.000000 2358 2358 1.000000 2359 2359 1.000000 2360 2360 1.000000 2361 2361 1.000000 2362 2362 1.000000 2363 2363 1.000000 2364 2364 1.000000 2365 2365 1.000000 2366 2366 1.000000 2367 1263 -0.913209 2367 2367 296.811240 2367 2368 -189.425000 2367 2369 -320.204020 2367 2415 -1.956371 2368 2368 -45.507683 2368 2369 40.208884 2369 1263 -0.056946 2369 1264 -0.906602 2369 1265 -1.532520 2369 2367 0.194376 2369 2368 1.824409 2369 2369 3.083981 2369 2415 -0.057328 2369 2416 -0.912754 2369 2417 -1.542919 2370 2370 1.000000 2371 2371 1.000000 2372 2372 1.000000 2373 2373 1.000000 2374 2374 1.000000 2375 2375 1.000000 2376 2376 1.000000 2377 2377 1.000000 2378 2378 1.000000 2379 2379 1.000000 2380 2380 1.000000 2381 2381 1.000000 2382 1278 -1.189563 2382 2382 275.742470 2382 2383 -177.448060 2382 2384 -299.958030 2382 2385 -0.780969 2382 2430 -3.148418 2383 2383 -38.965438 2383 2384 34.751750 2384 1278 -0.106018 2384 1279 -0.765767 2384 1280 -1.294453 2384 2382 0.364993 2384 2383 2.061685 2384 2384 3.485070 2384 2385 -0.086551 2384 2386 -0.625142 2384 2387 -1.056740 2384 2430 -0.092258 2384 2431 -0.666450 2384 2432 -1.126566 2385 1281 -0.811244 2385 2382 -0.615078 2385 2383 0.905369 2385 2384 1.530435 2385 2385 250.317890 2385 2386 -161.868230 2385 2387 -273.622060 2385 2388 -0.556554 2385 2433 -2.100783 2386 2384 -0.154764 2386 2386 -39.385424 2386 2387 35.440174 2387 1281 -0.050588 2387 1282 -1.196163 2387 1283 -2.021995 2387 2382 -0.086551 2387 2383 -0.625142 2387 2384 -1.056740 2387 2385 0.288836 2387 2386 3.524898 2387 2387 5.958487 2387 2388 -0.034706 2387 2389 -0.820614 2387 2390 -1.387166 2387 2433 -0.037154 2387 2434 -0.878605 2387 2435 -1.485194 2388 1284 -0.883968 2388 2385 -0.325797 2388 2386 0.393734 2388 2387 0.665567 2388 2388 231.336530 2388 2389 -150.058770 2388 2390 -253.659180 2388 2391 -0.521479 2388 2436 -0.919275 2389 2387 -0.081257 2389 2389 -38.687284 2389 2390 34.830996 2390 1284 -0.025903 2390 1285 -1.552556 2390 1286 -2.624439 2390 2385 -0.034706 2390 2386 -0.820614 2390 2387 -1.387166 2390 2388 0.171797 2390 2389 4.267915 2390 2390 7.214480 2390 2391 -0.015281 2390 2392 -0.915891 2390 2393 -1.548222 2390 2436 -0.016258 2390 2437 -0.974557 2390 2438 -1.647390 2391 1287 -0.612172 2391 2343 -4.155703 2391 2344 13.190091 2391 2345 22.296530 2391 2388 -0.299916 2391 2389 0.157910 2391 2390 0.266930 2391 2391 215.313260 2391 2392 -134.961580 2391 2393 -228.139060 2391 2394 -0.186619 2391 2395 1.841597 2391 2396 3.113033 2391 2439 -0.556354 2392 2345 -2.137526 2392 2390 -0.035179 2392 2392 -37.418826 2392 2393 32.922321 2392 2396 -0.463591 2393 1287 -0.010827 2393 1288 -1.956009 2393 1289 -3.306438 2393 2343 -0.086021 2393 2344 -0.432400 2393 2345 -0.730930 2393 2388 -0.015281 2393 2389 -0.915891 2393 2390 -1.548222 2393 2391 0.121706 2393 2392 5.390503 2393 2393 9.112105 2393 2394 -0.003135 2393 2395 -1.032926 2393 2396 -1.746056 2393 2439 -0.005806 2393 2440 -1.049120 2393 2441 -1.773432 2394 1290 -0.385795 2394 2346 -2.488500 2394 2347 13.032447 2394 2348 22.030033 2394 2391 -0.106988 2394 2394 195.511800 2394 2395 -124.514620 2394 2396 -210.479390 2394 2397 -0.181521 2394 2398 1.690200 2394 2399 2.857115 2394 2442 -0.295344 2395 2348 -2.486881 2395 2395 -34.875408 2395 2396 30.994421 2395 2399 -0.417839 2396 1290 -0.006823 2396 1291 -2.248092 2396 1292 -3.800172 2396 2346 -0.040056 2396 2347 -0.576030 2396 2348 -0.973720 2396 2391 -0.003135 2396 2392 -1.032926 2396 2393 -1.746056 2396 2394 0.056090 2396 2395 5.853460 2396 2396 9.894684 2396 2397 -0.002441 2396 2398 -0.976845 2396 2399 -1.651260 2396 2442 -0.003082 2396 2443 -1.015693 2396 2444 -1.716926 2397 1293 -0.344959 2397 2349 -1.589981 2397 2350 11.924609 2397 2351 20.157360 2397 2394 -0.083317 2397 2397 183.272000 2397 2398 -116.463740 2397 2399 -196.870310 2397 2445 -0.232932 2398 2351 -2.599390 2398 2398 -32.951383 2398 2399 29.082529 2399 1293 -0.006101 2399 1294 -2.441055 2399 1295 -4.126359 2399 2349 -0.017817 2399 2350 -0.683654 2399 2351 -1.155649 2399 2394 -0.002441 2399 2395 -0.976845 2399 2396 -1.651260 2399 2397 0.029298 2399 2398 5.078005 2399 2399 8.583860 2399 2445 -0.002431 2399 2446 -0.972790 2399 2447 -1.644404 2400 2400 1.000000 2401 2401 1.000000 2402 2402 1.000000 2403 2403 1.000000 2404 2404 1.000000 2405 2405 1.000000 2406 2406 1.000000 2407 2407 1.000000 2408 2408 1.000000 2409 2409 1.000000 2410 2410 1.000000 2411 2411 1.000000 2412 2412 1.000000 2413 2413 1.000000 2414 2414 1.000000 2415 1311 -0.384679 2415 2367 -3.279794 2415 2368 16.991600 2415 2369 28.722601 2415 2415 295.962690 2415 2416 -185.669440 2415 2417 -313.855620 2415 2418 -0.348094 2415 2419 0.631146 2415 2420 1.066888 2415 2463 -0.655968 2416 2369 -3.337316 2416 2416 -52.249143 2416 2417 45.541410 2416 2420 -0.152086 2417 1311 -0.006803 2417 1312 -1.432864 2417 1313 -2.422113 2417 2367 -0.057328 2417 2368 -0.912754 2417 2369 -1.542919 2417 2415 0.081608 2417 2416 5.174138 2417 2417 8.746362 2417 2418 -0.009761 2417 2419 -1.380717 2417 2420 -2.333962 2417 2463 -0.006846 2417 2464 -1.441995 2417 2465 -2.437548 2418 1314 -0.546198 2418 2415 -0.333118 2418 2418 294.817100 2418 2419 -187.614800 2418 2420 -317.143830 2418 2421 -0.220702 2418 2422 0.235822 2418 2423 0.398633 2418 2466 -0.932334 2419 2419 -51.494702 2419 2420 45.386677 2419 2423 -0.054994 2420 1314 -0.009660 2420 1315 -1.366407 2420 1316 -2.309773 2420 2415 -0.009761 2420 2416 -1.380717 2420 2417 -2.333962 2420 2418 0.118679 2420 2419 5.465519 2420 2420 9.238908 2420 2421 -0.009761 2420 2422 -1.336179 2420 2423 -2.258677 2420 2466 -0.009730 2420 2467 -1.376491 2420 2468 -2.326819 2421 1317 -0.700884 2421 2418 -0.237236 2421 2421 294.911180 2421 2422 -188.213360 2421 2423 -318.155860 2421 2424 -0.345123 2421 2425 0.241201 2421 2426 0.407726 2421 2469 -0.706610 2422 2422 -50.966088 2422 2423 44.963881 2422 2426 -0.054849 2423 1317 -0.012396 2423 1318 -1.321339 2423 1319 -2.233592 2423 2418 -0.009761 2423 2419 -1.336179 2423 2420 -2.258677 2423 2421 0.129056 2423 2422 5.298425 2423 2423 8.956455 2423 2424 -0.014607 2423 2425 -1.302995 2423 2426 -2.202580 2423 2469 -0.012497 2423 2470 -1.332246 2423 2471 -2.252029 2424 1320 -0.492875 2424 2421 -0.330249 2424 2424 295.159830 2424 2425 -188.670340 2424 2426 -318.928050 2424 2427 -0.344523 2424 2428 0.231088 2424 2429 0.390632 2424 2472 -0.823328 2425 2425 -50.571975 2425 2426 44.643506 2425 2429 -0.052551 2426 1320 -0.014443 2426 1321 -1.288434 2426 1322 -2.177967 2426 2421 -0.014607 2426 2422 -1.302995 2426 2423 -2.202580 2426 2424 0.138031 2426 2425 5.199069 2426 2426 8.788499 2426 2427 -0.014603 2426 2428 -1.302916 2426 2429 -2.202449 2426 2472 -0.014561 2426 2473 -1.299103 2426 2474 -2.196001 2427 1323 -0.492578 2427 2424 -0.330172 2427 2427 295.190420 2427 2428 -188.409100 2427 2429 -318.486750 2427 2430 -0.488073 2427 2475 -0.823460 2428 2428 -50.572276 2428 2429 44.584784 2429 1323 -0.014434 2429 1324 -1.287886 2429 1325 -2.177042 2429 2424 -0.014603 2429 2425 -1.302916 2429 2426 -2.202449 2429 2427 0.137721 2429 2428 5.172030 2429 2429 8.742800 2429 2430 -0.014302 2429 2431 -1.276073 2429 2432 -2.157074 2429 2475 -0.014563 2429 2476 -1.299535 2429 2477 -2.196733 2430 1326 -0.469139 2430 2382 -4.408557 2430 2383 16.821468 2430 2384 28.434994 2430 2427 -0.396557 2430 2428 0.325126 2430 2429 0.549592 2430 2430 285.836750 2430 2431 -178.932720 2430 2432 -302.467730 2430 2433 -0.263041 2430 2434 1.551843 2430 2435 2.623236 2430 2478 -0.754214 2431 2384 -2.875469 2431 2429 -0.073936 2431 2431 -49.860319 2431 2432 43.576472 2431 2435 -0.379606 2432 1326 -0.008297 2432 1327 -1.462372 2432 1328 -2.471992 2432 2382 -0.092258 2432 2383 -0.666450 2432 2384 -1.126566 2432 2427 -0.014302 2432 2428 -1.276073 2432 2429 -2.157074 2432 2430 0.127517 2432 2431 6.202164 2432 2432 10.484134 2432 2433 -0.003937 2432 2434 -1.404263 2432 2435 -2.373766 2432 2478 -0.007871 2432 2479 -1.387462 2432 2480 -2.345365 2433 1329 -0.263160 2433 2385 -2.604048 2433 2386 16.163394 2433 2387 27.322602 2433 2430 -0.134357 2433 2433 266.626370 2433 2434 -169.785360 2433 2435 -287.005170 2433 2436 -0.189533 2433 2437 2.046968 2433 2438 3.460192 2433 2481 -0.372709 2434 2387 -3.335735 2434 2434 -47.687417 2434 2435 42.190864 2434 2438 -0.518710 2435 1329 -0.004654 2435 1330 -1.660118 2435 1331 -2.806263 2435 2385 -0.037154 2435 2386 -0.878605 2435 2387 -1.485194 2435 2430 -0.003937 2435 2431 -1.404263 2435 2432 -2.373766 2435 2433 0.052795 2435 2434 6.679445 2435 2435 11.290933 2435 2436 -0.002415 2435 2437 -1.343578 2435 2438 -2.271183 2435 2481 -0.003890 2435 2482 -1.387579 2435 2483 -2.345563 2436 1332 -0.325360 2436 2388 -1.508888 2436 2389 14.485912 2436 2390 24.486970 2436 2433 -0.136569 2436 2436 241.692610 2436 2437 -155.354030 2436 2438 -262.610280 2436 2439 -0.115570 2436 2440 2.494726 2436 2441 4.217085 2436 2484 -0.228451 2437 2390 -3.227197 2437 2437 -43.939068 2437 2438 39.136646 2437 2441 -0.637960 2438 1332 -0.003396 2438 1333 -1.888992 2438 1334 -3.193149 2438 2388 -0.016258 2438 2389 -0.974557 2438 2390 -1.647390 2438 2433 -0.002415 2438 2434 -1.343578 2438 2435 -2.271183 2438 2436 0.026043 2438 2437 6.827924 2438 2438 11.541916 2438 2439 -0.000939 2438 2440 -1.289442 2438 2441 -2.179673 2438 2484 -0.002384 2438 2485 -1.326469 2438 2486 -2.242262 2439 1335 -0.148188 2439 2391 -0.730654 2439 2392 12.199921 2439 2393 20.622746 2439 2436 -0.053069 2439 2439 223.363930 2439 2440 -144.219590 2439 2441 -243.788790 2439 2442 -0.093204 2439 2443 3.024884 2439 2444 5.113261 2439 2487 -0.088688 2440 2393 -2.914640 2440 2440 -41.297090 2440 2441 36.812861 2440 2444 -0.787282 2441 1335 -0.001547 2441 1336 -2.124845 2441 1337 -3.591837 2441 2391 -0.005806 2441 2392 -1.049120 2441 2393 -1.773432 2441 2436 -0.000939 2441 2437 -1.289442 2441 2438 -2.179673 2441 2439 0.010441 2441 2440 6.952380 2441 2441 11.752301 2441 2442 -0.000652 2441 2443 -1.212590 2441 2444 -2.049761 2441 2487 -0.000926 2441 2488 -1.271790 2441 2489 -2.149833 2442 1338 -0.120893 2442 2394 -0.558837 2442 2395 10.400277 2442 2396 17.580618 2442 2439 -0.062429 2442 2442 205.430030 2442 2443 -132.627050 2442 2444 -224.192610 2442 2445 -0.066744 2442 2446 3.048959 2442 2447 5.153961 2442 2490 -0.061495 2443 2396 -2.618094 2443 2443 -38.253343 2443 2444 34.089825 2443 2447 -0.809744 2444 1338 -0.001262 2444 1339 -2.348264 2444 1340 -3.969503 2444 2394 -0.003082 2444 2395 -1.015693 2444 2396 -1.716926 2444 2439 -0.000652 2444 2440 -1.212590 2444 2441 -2.049761 2444 2442 0.006525 2444 2443 6.928897 2444 2444 11.712602 2444 2445 -0.000372 2444 2446 -1.153498 2444 2447 -1.949873 2444 2490 -0.000642 2444 2491 -1.194597 2444 2492 -2.019346 2445 1341 -0.078631 2445 2397 -0.374706 2445 2398 9.063607 2445 2399 15.321121 2445 2442 -0.035684 2445 2445 193.463720 2445 2446 -121.008720 2445 2447 -204.553130 2445 2493 -0.035095 2446 2399 -2.240641 2446 2446 -36.306218 2446 2447 31.328710 2447 1341 -0.000821 2447 1342 -2.541870 2447 1343 -4.296778 2447 2397 -0.002431 2447 2398 -0.972790 2447 2399 -1.644404 2447 2442 -0.000372 2447 2443 -1.153498 2447 2444 -1.949873 2447 2445 0.004462 2447 2446 5.806760 2447 2447 9.815746 2447 2493 -0.000366 2447 2494 -1.134562 2447 2495 -1.917864 2448 2448 1.000000 2449 2449 1.000000 2450 2450 1.000000 2451 2451 1.000000 2452 2452 1.000000 2453 2453 1.000000 2454 2454 1.000000 2455 2455 1.000000 2456 2456 1.000000 2457 2457 1.000000 2458 2458 1.000000 2459 2459 1.000000 2460 2460 1.000000 2461 2461 1.000000 2462 2462 1.000000 2463 1359 -0.089063 2463 2415 -0.919829 2463 2416 15.807417 2463 2417 26.720858 2463 2463 293.520010 2463 2464 -185.583810 2463 2465 -313.710870 2463 2466 -0.090287 2463 2511 -0.090116 2464 2417 -3.837993 2464 2464 -50.099419 2464 2465 55.228420 2465 1359 -0.000930 2465 1360 -1.637231 2465 1361 -2.767574 2465 2415 -0.006846 2465 2416 -1.441995 2465 2417 -2.437548 2465 2463 0.010397 2465 2464 6.401628 2465 2465 10.821312 2465 2466 -0.000942 2465 2467 -1.659643 2465 2468 -2.805461 2465 2511 -0.000940 2465 2512 -1.656679 2465 2513 -2.800450 2466 1362 -0.106034 2466 2418 -1.306802 2466 2419 16.075890 2466 2420 27.174665 2466 2463 -0.093001 2466 2464 0.271675 2466 2465 0.459239 2466 2466 293.946980 2466 2467 -186.200800 2466 2468 -314.753650 2466 2469 -0.063426 2466 2514 -0.107246 2467 2420 -3.873777 2467 2465 -0.070508 2467 2467 -54.424641 2467 2468 47.565742 2468 1362 -0.001107 2468 1363 -1.620021 2468 1364 -2.738482 2468 2418 -0.009730 2468 2419 -1.376491 2468 2420 -2.326819 2468 2463 -0.000942 2468 2464 -1.659643 2468 2465 -2.805461 2468 2466 0.014769 2468 2467 7.942892 2468 2468 13.426657 2468 2469 -0.001122 2468 2470 -1.642046 2468 2471 -2.775713 2468 2514 -0.001119 2468 2515 -1.638632 2468 2516 -2.769941 2469 1365 -0.156132 2469 2421 -1.378051 2469 2422 16.674148 2469 2423 28.185979 2469 2466 -0.112062 2469 2467 0.404449 2469 2468 0.683680 2469 2469 293.942260 2469 2470 -186.147850 2469 2471 -314.664330 2469 2472 -0.093381 2469 2517 -0.157803 2470 2423 -3.888405 2470 2468 -0.103852 2470 2470 -54.087451 2470 2471 47.365100 2471 1365 -0.001629 2471 1366 -1.589686 2471 1367 -2.687205 2471 2421 -0.012497 2471 2422 -1.332246 2471 2423 -2.252029 2471 2466 -0.001122 2471 2467 -1.642046 2471 2468 -2.775713 2471 2469 0.019314 2471 2470 7.787909 2471 2471 13.164680 2471 2472 -0.001652 2471 2473 -1.611114 2471 2474 -2.723427 2471 2517 -0.001647 2471 2518 -1.606797 2471 2519 -2.716130 2472 1368 -0.191837 2472 2424 -1.453178 2472 2425 17.134703 2472 2426 28.964476 2472 2469 -0.099581 2472 2470 0.238269 2472 2471 0.402771 2472 2472 294.183070 2472 2473 -186.458720 2472 2474 -315.189560 2472 2475 -0.143507 2472 2476 0.288059 2472 2477 0.486935 2472 2520 -0.193946 2473 2426 -3.896443 2473 2471 -0.062091 2473 2473 -53.928425 2473 2474 47.280929 2473 2477 -0.073725 2474 1368 -0.002002 2474 1369 -1.575446 2474 1370 -2.663132 2474 2424 -0.014561 2474 2425 -1.299103 2474 2426 -2.196001 2474 2469 -0.001652 2474 2470 -1.611114 2474 2471 -2.723427 2474 2472 0.023420 2474 2473 7.666691 2474 2474 12.959767 2474 2475 -0.002405 2474 2476 -1.582161 2474 2477 -2.674485 2474 2520 -0.002024 2474 2521 -1.592864 2474 2522 -2.692575 2475 1371 -0.227454 2475 2427 -1.451385 2475 2428 17.104165 2475 2429 28.912880 2475 2472 -0.135997 2475 2475 294.220330 2475 2476 -186.970540 2475 2477 -316.055000 2475 2478 -0.134074 2475 2479 0.898813 2475 2480 1.519352 2475 2523 -0.229907 2476 2429 -3.889605 2476 2476 -53.769714 2476 2477 47.247887 2476 2480 -0.228334 2477 1371 -0.002374 2477 1372 -1.561568 2477 1373 -2.639675 2477 2427 -0.014563 2477 2428 -1.299535 2477 2429 -2.196733 2477 2472 -0.002405 2477 2473 -1.582161 2477 2474 -2.674485 2477 2475 0.023827 2477 2476 7.652109 2477 2477 12.935123 2477 2478 -0.001300 2477 2479 -1.624342 2477 2480 -2.745786 2477 2523 -0.002399 2477 2524 -1.578519 2477 2525 -2.668329 2478 1374 -0.122822 2478 2430 -0.977141 2478 2431 16.275427 2478 2432 27.511970 2478 2475 -0.073488 2478 2478 293.842260 2478 2479 -187.882110 2478 2480 -317.595700 2478 2481 -0.110990 2478 2482 1.751877 2478 2483 2.961372 2478 2526 -0.124297 2479 2432 -3.877283 2479 2479 -54.236743 2479 2480 47.803050 2479 2483 -0.453008 2480 1374 -0.001282 2480 1375 -1.602111 2480 1376 -2.708207 2480 2430 -0.007871 2480 2431 -1.387462 2480 2432 -2.345365 2480 2475 -0.001300 2480 2476 -1.624342 2480 2477 -2.745786 2480 2478 0.013482 2480 2479 7.843541 2480 2480 13.258715 2480 2481 -0.000973 2480 2482 -1.602149 2480 2483 -2.708272 2480 2526 -0.001297 2480 2527 -1.621439 2480 2528 -2.740879 2481 1377 -0.100928 2481 2433 -0.633412 2481 2434 15.780879 2481 2435 26.675998 2481 2478 -0.093191 2481 2481 275.790340 2481 2482 -177.965950 2481 2483 -300.833640 2481 2484 -0.078870 2481 2485 2.450933 2481 2486 4.143055 2481 2529 -0.093052 2482 2435 -3.860260 2482 2482 -51.274641 2482 2483 45.592825 2482 2486 -0.648258 2483 1377 -0.001053 2483 1378 -1.735247 2483 1379 -2.933261 2483 2433 -0.003890 2483 2434 -1.387579 2483 2435 -2.345563 2483 2478 -0.000973 2483 2479 -1.602149 2483 2480 -2.708272 2483 2481 0.008147 2483 2482 7.867811 2483 2483 13.299746 2483 2484 -0.000563 2483 2485 -1.537203 2483 2486 -2.598486 2483 2529 -0.000971 2483 2530 -1.599926 2483 2531 -2.704515 2484 1380 -0.066503 2484 2436 -0.510771 2484 2437 14.375670 2484 2438 24.300617 2484 2481 -0.053901 2484 2484 257.936380 2484 2485 -167.192940 2484 2486 -282.622760 2484 2487 -0.054919 2484 2488 3.149518 2484 2489 5.323946 2484 2532 -0.053264 2485 2438 -3.642851 2485 2485 -48.357234 2485 2486 43.219585 2485 2489 -0.849205 2486 1380 -0.000694 2486 1381 -1.896703 2486 1382 -3.206184 2486 2436 -0.002384 2486 2437 -1.326469 2486 2438 -2.242262 2486 2481 -0.000563 2486 2482 -1.537203 2486 2483 -2.598486 2486 2484 0.005068 2486 2485 7.729943 2486 2486 13.066689 2486 2487 -0.000238 2486 2488 -1.444966 2486 2489 -2.442570 2486 2532 -0.000556 2486 2533 -1.519219 2486 2534 -2.568086 2487 1383 -0.016242 2487 2439 -0.223040 2487 2440 13.195320 2487 2441 22.305368 2487 2484 -0.022848 2487 2487 234.209590 2487 2488 -153.242610 2487 2489 -259.041310 2487 2490 -0.044341 2487 2491 4.148118 2487 2492 7.011973 2487 2535 -0.022299 2488 2441 -3.374355 2488 2488 -44.241303 2488 2489 39.933058 2488 2492 -1.136025 2489 1383 -0.000011 2489 1384 -2.127758 2489 1385 -3.596762 2489 2439 -0.000926 2489 2440 -1.271790 2489 2441 -2.149833 2489 2484 -0.000238 2489 2485 -1.444966 2489 2486 -2.442570 2489 2487 0.001974 2489 2488 7.606176 2489 2489 12.857479 2489 2490 -0.000007 2489 2491 -1.346297 2489 2492 -2.275779 2489 2535 -0.000233 2489 2536 -1.410440 2489 2537 -2.384208 2490 1386 -0.050112 2490 2442 -0.175000 2490 2443 11.284571 2490 2444 19.075426 2490 2487 -0.000646 2490 2490 216.590330 2490 2491 -144.474550 2490 2492 -244.219590 2490 2493 -0.103282 2490 2494 7.522888 2490 2495 12.716689 2490 2538 -0.000629 2491 2444 -2.937019 2491 2491 -41.136159 2491 2492 37.924460 2491 2495 -2.060299 2492 1386 -0.000012 2492 1387 -2.337165 2492 1388 -3.950741 2492 2442 -0.000642 2492 2443 -1.194597 2492 2444 -2.019346 2492 2487 -0.000007 2492 2488 -1.346297 2492 2489 -2.275779 2492 2490 0.001179 2492 2491 7.434362 2492 2492 12.567038 2492 2493 -0.000006 2492 2494 -1.240973 2492 2495 -2.097741 2492 2538 -0.000007 2492 2539 -1.310749 2492 2540 -2.215688 2493 1389 -0.050293 2493 2445 -0.074440 2493 2446 6.409008 2493 2447 10.833787 2493 2490 -0.000571 2493 2493 198.980500 2493 2494 -122.161760 2493 2495 -206.502240 2494 2447 -1.702107 2494 2494 -37.800226 2494 2495 31.949098 2495 1389 -0.000012 2495 1390 -2.544696 2495 1391 -4.301554 2495 2445 -0.000366 2495 2446 -1.134562 2495 2447 -1.917864 2495 2490 -0.000006 2495 2491 -1.240973 2495 2492 -2.097741 2495 2493 0.000849 2495 2494 4.924440 2495 2495 8.324274 2496 2496 1.000000 2497 2497 1.000000 2498 2498 1.000000 2499 2499 1.000000 2500 2500 1.000000 2501 2501 1.000000 2502 2502 1.000000 2503 2503 1.000000 2504 2504 1.000000 2505 2505 1.000000 2506 2506 1.000000 2507 2507 1.000000 2508 2508 1.000000 2509 2509 1.000000 2510 2510 1.000000 2511 1407 -0.026951 2511 2463 -0.256205 2511 2464 16.314945 2511 2465 27.578783 2511 2511 292.647490 2511 2512 -186.381730 2511 2513 -315.059670 2511 2514 -0.021757 2511 2559 -0.021683 2512 2465 -4.234204 2512 2512 -50.801262 2512 2513 56.283224 2513 1407 -0.000009 2513 1408 -1.708351 2513 1409 -2.887796 2513 2463 -0.000940 2513 2464 -1.656679 2513 2465 -2.800450 2513 2511 0.002100 2513 2512 6.826079 2513 2513 11.538803 2513 2514 -0.000227 2513 2515 -1.730294 2513 2516 -2.924890 2513 2559 -0.000226 2513 2560 -1.724583 2513 2561 -2.915236 2514 1410 -0.009360 2514 2466 -0.277051 2514 2467 16.672940 2514 2468 28.183922 2514 2511 -0.028239 2514 2512 0.634952 2514 2513 1.073322 2514 2514 292.740630 2514 2515 -187.401710 2514 2516 -316.783640 2514 2517 -0.038882 2514 2562 -0.038747 2515 2468 -4.281179 2515 2513 -0.171763 2515 2515 -55.188260 2515 2516 48.630497 2516 1410 -0.000009 2516 1411 -1.691876 2516 1412 -2.859945 2516 2466 -0.001119 2516 2467 -1.638632 2516 2468 -2.769941 2516 2511 -0.000227 2516 2512 -1.730294 2516 2513 -2.924890 2516 2514 0.002873 2516 2515 8.486762 2516 2516 14.346016 2516 2517 -0.000406 2516 2518 -1.712777 2516 2519 -2.895276 2516 2562 -0.000404 2516 2563 -1.707034 2516 2564 -2.885569 2517 1413 -0.055354 2517 2469 -0.530944 2517 2470 16.752403 2517 2471 28.318262 2517 2514 -0.049799 2517 2515 1.071238 2517 2516 1.810820 2517 2517 292.923680 2517 2518 -188.341130 2517 2519 -318.371840 2517 2520 -0.056015 2517 2565 -0.055815 2518 2471 -4.365549 2518 2516 -0.286844 2518 2518 -55.000471 2518 2519 48.683506 2519 1413 -0.000578 2519 1414 -1.675338 2519 1415 -2.831991 2519 2469 -0.001647 2519 2470 -1.606797 2519 2471 -2.716130 2519 2514 -0.000406 2519 2515 -1.712777 2519 2516 -2.895276 2519 2517 0.004515 2519 2518 8.385723 2519 2519 14.175224 2519 2520 -0.000585 2519 2521 -1.695261 2519 2522 -2.865670 2519 2565 -0.000583 2519 2566 -1.689422 2519 2567 -2.855799 2520 1416 -0.063786 2520 2472 -0.568066 2520 2473 17.353461 2520 2474 29.334266 2520 2517 -0.064823 2520 2518 0.864923 2520 2519 1.462065 2520 2520 293.023510 2520 2521 -188.676260 2520 2522 -318.938140 2520 2523 -0.064584 2520 2568 -0.064351 2521 2474 -4.481716 2521 2519 -0.229225 2521 2521 -54.906725 2521 2522 48.672218 2522 1416 -0.000666 2522 1417 -1.665693 2522 1418 -2.815685 2522 2472 -0.002024 2522 2473 -1.592864 2522 2474 -2.692575 2522 2517 -0.000585 2522 2518 -1.695261 2522 2519 -2.865670 2522 2520 0.005343 2522 2521 8.327012 2522 2522 14.075973 2522 2523 -0.000674 2522 2524 -1.686464 2522 2525 -2.850797 2522 2568 -0.000672 2522 2569 -1.680612 2522 2570 -2.840905 2523 1419 -0.072246 2523 2475 -0.598829 2523 2476 17.718613 2523 2477 29.951544 2523 2520 -0.065410 2523 2521 0.080747 2523 2522 0.136495 2523 2523 293.100450 2523 2524 -189.233310 2523 2525 -319.879980 2523 2526 -0.075201 2523 2527 1.046473 2523 2528 1.768957 2523 2571 -0.072887 2524 2477 -4.534861 2524 2522 -0.021289 2524 2524 -54.812579 2524 2525 48.719147 2524 2528 -0.275906 2525 1419 -0.000754 2525 1420 -1.657002 2525 1421 -2.800996 2525 2475 -0.002399 2525 2476 -1.578519 2525 2477 -2.668329 2525 2520 -0.000674 2525 2521 -1.686464 2525 2522 -2.850797 2525 2523 0.005990 2525 2524 8.286247 2525 2525 14.007069 2525 2526 -0.000674 2525 2527 -1.686308 2525 2528 -2.850534 2525 2571 -0.000761 2525 2572 -1.671847 2525 2573 -2.826091 2526 1422 -0.063781 2526 2478 -0.309500 2526 2479 18.189066 2526 2480 30.746777 2526 2523 -0.064560 2526 2526 292.953220 2526 2527 -190.246610 2526 2528 -321.592690 2526 2529 -0.058123 2526 2530 1.889668 2526 2531 3.194295 2526 2574 -0.064335 2527 2480 -4.620734 2527 2527 -54.906377 2527 2528 49.087749 2527 2531 -0.505995 2528 1422 -0.000666 2528 1423 -1.666034 2528 1424 -2.816262 2528 2478 -0.001297 2528 2479 -1.621439 2528 2480 -2.740879 2528 2523 -0.000674 2528 2524 -1.686308 2528 2525 -2.850534 2528 2526 0.004436 2528 2527 8.372563 2528 2528 14.152973 2528 2529 -0.000406 2528 2530 -1.712040 2528 2531 -2.894032 2528 2574 -0.000671 2528 2575 -1.680624 2528 2576 -2.840925 2529 1425 -0.010377 2529 2481 -0.271710 2529 2482 17.552672 2529 2483 29.671036 2529 2526 -0.038861 2529 2529 292.745990 2529 2530 -190.378960 2529 2531 -321.816600 2529 2532 -0.038333 2529 2533 2.625185 2529 2534 4.437608 2529 2577 -0.038761 2530 2483 -4.538847 2530 2530 -55.187799 2530 2531 49.428946 2530 2534 -0.718922 2531 1425 -0.000009 2531 1426 -1.691985 2531 1427 -2.860131 2531 2481 -0.000971 2531 2482 -1.599926 2531 2483 -2.704515 2531 2526 -0.000406 2531 2527 -1.712040 2531 2528 -2.894032 2531 2529 0.002507 2531 2530 8.395800 2531 2531 14.192258 2531 2532 -0.000009 2531 2533 -1.677831 2531 2534 -2.836203 2531 2577 -0.000405 2531 2578 -1.707869 2531 2579 -2.886982 2532 1428 -0.049090 2532 2484 -0.208653 2532 2485 16.255375 2532 2486 27.478068 2532 2529 -0.000862 2532 2532 269.211870 2532 2533 -175.642640 2532 2534 -296.906070 2532 2535 -0.066110 2532 2536 2.915540 2532 2537 4.928429 2532 2580 -0.000835 2533 2486 -4.299454 2533 2533 -51.156974 2533 2534 46.023370 2533 2537 -0.798444 2534 1428 -0.000010 2534 1429 -1.879401 2534 1430 -3.176937 2534 2484 -0.000556 2534 2485 -1.519219 2534 2486 -2.568086 2534 2529 -0.000009 2534 2530 -1.677831 2534 2531 -2.836203 2534 2532 0.001221 2534 2533 8.245674 2534 2534 13.938478 2534 2535 -0.000008 2534 2536 -1.537921 2534 2537 -2.599702 2534 2580 -0.000009 2534 2581 -1.625600 2534 2582 -2.747912 2535 1431 -0.049472 2535 2487 -0.134248 2535 2488 15.161974 2535 2489 25.629800 2535 2532 -0.000777 2535 2535 245.797600 2535 2536 -160.742890 2535 2537 -271.719790 2535 2538 -0.051375 2535 2539 2.466770 2535 2540 4.169826 2535 2583 -0.000759 2536 2489 -4.088125 2536 2536 -46.711518 2536 2537 42.116819 2536 2540 -0.675549 2537 1431 -0.000011 2537 1432 -2.058723 2537 1433 -3.480066 2537 2487 -0.000233 2537 2488 -1.410440 2537 2489 -2.384208 2537 2532 -0.000008 2537 2533 -1.537921 2537 2534 -2.599702 2537 2535 0.000841 2537 2536 7.912791 2537 2537 13.375780 2537 2538 -0.000007 2537 2539 -1.397682 2537 2540 -2.362640 2537 2583 -0.000008 2537 2584 -1.502818 2537 2585 -2.540363 2538 1434 -0.049415 2538 2490 -0.098060 2538 2491 15.597252 2538 2492 26.365575 2538 2535 -0.000697 2538 2538 222.357500 2538 2539 -145.286990 2538 2540 -245.592950 2538 2586 -0.000679 2539 2492 -4.271543 2539 2539 -42.264729 2539 2540 38.061162 2540 1434 -0.000012 2540 1435 -2.275492 2540 1436 -3.846489 2540 2490 -0.000007 2540 2491 -1.310749 2540 2492 -2.215688 2540 2535 -0.000007 2540 2536 -1.397682 2540 2537 -2.362640 2540 2538 0.000553 2540 2539 6.350315 2540 2540 10.734565 2540 2586 -0.000007 2540 2587 -1.361680 2540 2588 -2.301782 2541 2541 1.000000 2542 2542 1.000000 2543 2543 1.000000 2544 2544 1.000000 2545 2545 1.000000 2546 2546 1.000000 2547 2547 1.000000 2548 2548 1.000000 2549 2549 1.000000 2550 2550 1.000000 2551 2551 1.000000 2552 2552 1.000000 2553 2553 1.000000 2554 2554 1.000000 2555 2555 1.000000 2556 2556 1.000000 2557 2557 1.000000 2558 2558 1.000000 2559 1455 -0.048509 2559 2511 -0.131228 2559 2512 17.114212 2559 2513 28.929865 2559 2559 292.490890 2559 2560 -187.666960 2559 2561 -317.232240 2559 2562 -0.000937 2559 2607 -0.000892 2560 2513 -4.629615 2560 2560 -51.030416 2560 2561 56.854685 2561 1455 -0.000010 2561 1456 -1.732900 2561 1457 -2.929294 2561 2511 -0.000226 2561 2512 -1.724583 2561 2513 -2.915236 2561 2559 0.000939 2561 2560 6.882697 2561 2561 11.634511 2561 2562 -0.000010 2561 2563 -1.752131 2561 2564 -2.961802 2561 2607 -0.000009 2561 2608 -1.666878 2561 2609 -2.817690 2562 1458 -0.048061 2562 2514 -0.162026 2562 2515 17.626293 2562 2516 29.795467 2562 2559 -0.021204 2562 2560 1.149406 2562 2561 1.942956 2562 2562 292.528510 2562 2563 -189.134010 2562 2564 -319.711920 2562 2565 -0.000943 2562 2610 -0.000918 2563 2516 -4.719768 2563 2561 -0.314764 2563 2563 -55.622843 2563 2564 49.493657 2564 1458 -0.000010 2564 1459 -1.732188 2564 1460 -2.928089 2564 2514 -0.000404 2564 2515 -1.707034 2564 2516 -2.885569 2564 2559 -0.000010 2564 2560 -1.752131 2564 2561 -2.961802 2564 2562 0.001127 2564 2563 8.655407 2564 2564 14.631092 2564 2565 -0.000010 2564 2566 -1.752057 2564 2567 -2.961675 2564 2610 -0.000010 2564 2611 -1.705791 2564 2612 -2.883468 2565 1461 -0.047233 2565 2517 -0.198658 2565 2518 18.710595 2565 2519 31.628390 2565 2562 -0.031498 2565 2563 2.160631 2565 2564 3.652328 2565 2565 292.577630 2565 2566 -191.027790 2565 2567 -322.913380 2565 2568 -0.000951 2565 2613 -0.000946 2566 2519 -4.958742 2566 2564 -0.591686 2566 2566 -55.622856 2566 2567 50.011819 2567 1461 -0.000010 2567 1462 -1.731647 2567 1463 -2.927176 2567 2517 -0.000583 2567 2518 -1.689422 2567 2519 -2.855799 2567 2562 -0.000010 2567 2563 -1.752057 2567 2564 -2.961675 2567 2565 0.001306 2567 2566 8.674944 2567 2567 14.664123 2567 2568 -0.000010 2567 2569 -1.752040 2567 2570 -2.961648 2567 2613 -0.000010 2567 2614 -1.743573 2567 2615 -2.947335 2568 1464 -0.046196 2568 2520 -0.235581 2568 2521 19.821857 2568 2522 33.506847 2568 2565 -0.038249 2568 2566 1.980808 2568 2567 3.348357 2568 2568 292.576990 2568 2569 -191.818840 2568 2570 -324.250360 2568 2571 -0.000959 2568 2616 -0.000955 2569 2522 -5.226034 2569 2567 -0.542439 2569 2569 -55.621662 2569 2570 50.231084 2570 1464 -0.000010 2570 1465 -1.732570 2570 1466 -2.928734 2570 2520 -0.000672 2570 2521 -1.680612 2570 2522 -2.840905 2570 2565 -0.000010 2570 2566 -1.752040 2570 2567 -2.961648 2570 2568 0.001395 2570 2569 8.669038 2570 2570 14.654135 2570 2571 -0.000010 2570 2572 -1.752082 2570 2573 -2.961718 2570 2616 -0.000010 2570 2617 -1.745529 2570 2618 -2.950641 2571 1467 -0.045679 2571 2523 -0.259459 2571 2524 20.490641 2571 2525 34.637380 2571 2568 -0.017181 2571 2569 0.752061 2571 2570 1.271282 2571 2571 292.581000 2571 2572 -192.184640 2571 2573 -324.868920 2571 2574 -0.020099 2571 2575 1.038688 2571 2576 1.755797 2571 2619 -0.000960 2572 2525 -5.374228 2572 2570 -0.205949 2572 2572 -55.620927 2572 2573 50.332785 2572 2576 -0.284441 2573 1467 -0.000010 2573 1468 -1.732554 2573 1469 -2.928709 2573 2523 -0.000761 2573 2524 -1.671847 2573 2525 -2.826091 2573 2568 -0.000010 2573 2569 -1.752082 2573 2570 -2.961718 2573 2571 0.001485 2573 2572 8.660221 2573 2573 14.639234 2573 2574 -0.000010 2573 2575 -1.752015 2573 2576 -2.961604 2573 2619 -0.000010 2573 2620 -1.745518 2573 2621 -2.950624 2574 1470 -0.046118 2574 2526 -0.242437 2574 2527 20.498619 2574 2528 34.650845 2574 2571 -0.000959 2574 2574 292.589090 2574 2575 -193.001350 2574 2576 -326.249260 2574 2577 -0.043708 2574 2578 2.518277 2574 2579 4.256896 2574 2622 -0.000956 2575 2528 -5.404518 2575 2575 -55.621503 2575 2576 50.555316 2575 2579 -0.689626 2576 1470 -0.000010 2576 1471 -1.732697 2576 1472 -2.928949 2576 2526 -0.000671 2576 2527 -1.680624 2576 2528 -2.840925 2576 2571 -0.000010 2576 2572 -1.752015 2576 2573 -2.961604 2576 2574 0.001395 2576 2575 8.669263 2576 2576 14.654513 2576 2577 -0.000010 2576 2578 -1.751691 2576 2579 -2.961058 2576 2622 -0.000010 2576 2623 -1.746031 2576 2624 -2.951488 2577 1473 -0.046865 2577 2529 -0.193536 2577 2530 19.884307 2577 2531 33.612433 2577 2574 -0.000947 2577 2577 292.584640 2577 2578 -193.402880 2577 2579 -326.928220 2577 2580 -0.069271 2577 2581 3.206450 2577 2582 5.420180 2577 2625 -0.000944 2578 2531 -5.324409 2578 2578 -55.622434 2578 2579 50.663406 2578 2582 -0.878087 2579 1473 -0.000010 2579 1474 -1.732143 2579 1475 -2.928014 2579 2529 -0.000405 2579 2530 -1.707869 2579 2531 -2.886982 2579 2574 -0.000010 2579 2575 -1.751691 2579 2576 -2.961058 2579 2577 0.001127 2579 2578 8.641078 2579 2579 14.606876 2579 2580 -0.000009 2579 2581 -1.697084 2579 2582 -2.868749 2579 2625 -0.000010 2579 2626 -1.746086 2579 2627 -2.951584 2580 1476 -0.047160 2580 2532 -0.115680 2580 2533 17.977306 2580 2534 30.388813 2580 2577 -0.000904 2580 2580 275.024510 2580 2581 -181.855580 2580 2582 -307.408470 2580 2583 -0.076734 2580 2584 3.397539 2580 2585 5.743200 2580 2628 -0.000892 2581 2534 -4.923187 2581 2581 -52.287970 2581 2582 47.632801 2581 2585 -0.930422 2582 1476 -0.000010 2582 1477 -1.841508 2582 1478 -3.112884 2582 2532 -0.000009 2582 2533 -1.625600 2582 2534 -2.747912 2582 2577 -0.000009 2582 2578 -1.697084 2582 2579 -2.868749 2582 2580 0.000689 2582 2581 8.438159 2582 2582 14.263855 2582 2583 -0.000009 2582 2584 -1.592071 2582 2585 -2.691237 2582 2628 -0.000009 2582 2629 -1.676061 2582 2630 -2.833212 2583 1479 -0.047971 2583 2535 -0.099113 2583 2536 16.260700 2583 2537 27.487088 2583 2580 -0.000840 2583 2583 257.471000 2583 2584 -169.140370 2583 2585 -285.914880 2583 2586 -0.054570 2583 2587 2.647312 2583 2588 4.475014 2583 2631 -0.000829 2584 2537 -4.453124 2584 2584 -48.953851 2584 2585 44.281127 2584 2588 -0.724974 2585 1479 -0.000011 2585 1480 -1.965496 2585 1481 -3.322474 2585 2535 -0.000008 2585 2536 -1.502818 2585 2537 -2.540363 2585 2580 -0.000009 2585 2581 -1.592071 2585 2582 -2.691237 2585 2583 0.000646 2585 2584 8.104624 2585 2585 13.700055 2585 2586 -0.000008 2585 2587 -1.468164 2585 2588 -2.481783 2585 2631 -0.000009 2585 2632 -1.570612 2585 2633 -2.654962 2586 1482 -0.048565 2586 2538 -0.089255 2586 2539 14.681026 2586 2540 24.816788 2586 2583 -0.000769 2586 2586 234.002320 2586 2587 -151.239020 2586 2588 -255.654270 2586 2634 -0.000740 2587 2540 -4.020542 2587 2587 -44.505464 2587 2588 39.559654 2588 1482 -0.000012 2588 1483 -2.166039 2588 1484 -3.661470 2588 2538 -0.000007 2588 2539 -1.361680 2588 2540 -2.301782 2588 2583 -0.000008 2588 2584 -1.468164 2588 2585 -2.481783 2588 2586 0.000582 2588 2587 6.414709 2588 2588 10.843417 2588 2634 -0.000008 2588 2635 -1.413859 2588 2636 -2.389985 2589 2589 1.000000 2590 2590 1.000000 2591 2591 1.000000 2592 2592 1.000000 2593 2593 1.000000 2594 2594 1.000000 2595 2595 1.000000 2596 2596 1.000000 2597 2597 1.000000 2598 2598 1.000000 2599 2599 1.000000 2600 2600 1.000000 2601 2601 1.000000 2602 2602 1.000000 2603 2603 1.000000 2604 1500 -0.049071 2604 2604 257.261830 2604 2605 -155.707360 2604 2606 -263.207500 2604 2607 -0.025480 2604 2608 5.352012 2604 2609 9.047040 2604 2652 -0.083154 2605 2605 -48.977572 2605 2606 40.543038 2605 2609 -1.465612 2606 1500 -0.000012 2606 1501 -1.985902 2606 1502 -3.356966 2606 2604 0.000631 2606 2605 4.963156 2606 2606 8.389713 2606 2607 -0.000009 2606 2608 -1.576253 2606 2609 -2.664498 2606 2652 -0.000008 2606 2653 -1.395527 2606 2654 -2.358996 2607 1503 -0.048017 2607 2559 -0.071925 2607 2560 17.993985 2607 2561 30.417032 2607 2604 -0.000880 2607 2607 269.015240 2607 2608 -175.138160 2607 2609 -296.053550 2607 2610 -0.000919 2607 2655 -0.012520 2608 2561 -4.927647 2608 2608 -51.196925 2608 2609 45.785790 2609 1503 -0.000011 2609 1504 -1.894376 2609 1505 -3.202254 2609 2559 -0.000009 2609 2560 -1.666878 2609 2561 -2.817690 2609 2604 -0.000009 2609 2605 -1.576253 2609 2606 -2.664498 2609 2607 0.000677 2609 2608 8.274180 2609 2609 13.986673 2609 2610 -0.000010 2609 2611 -1.646536 2609 2612 -2.783304 2609 2655 -0.000009 2609 2656 -1.484417 2609 2657 -2.509259 2610 1506 -0.046124 2610 2562 -0.080804 2610 2563 18.407184 2610 2564 31.115484 2610 2607 -0.026902 2610 2608 1.073246 2610 2609 1.814215 2610 2610 280.747370 2610 2611 -183.459410 2610 2612 -310.119550 2610 2613 -0.000961 2610 2658 -0.000893 2611 2564 -5.040786 2611 2609 -0.293901 2611 2611 -53.421482 2611 2612 47.973334 2612 1506 -0.000011 2612 1507 -1.812633 2612 1508 -3.064073 2612 2562 -0.000010 2612 2563 -1.705791 2612 2564 -2.883468 2612 2607 -0.000010 2612 2608 -1.646536 2612 2609 -2.783304 2612 2610 0.000706 2612 2611 8.482956 2612 2612 14.339579 2612 2613 -0.000010 2612 2614 -1.716692 2612 2615 -2.901894 2612 2658 -0.000009 2612 2659 -1.595336 2612 2660 -2.696754 2613 1509 -0.043192 2613 2565 -0.106166 2613 2566 20.401092 2613 2567 34.486006 2613 2610 -0.054089 2613 2611 3.678386 2613 2612 6.217939 2613 2613 292.491220 2613 2614 -194.875700 2613 2615 -329.417880 2613 2616 -0.000989 2613 2661 -0.000951 2614 2567 -5.586787 2614 2612 -1.007299 2614 2614 -55.647323 2614 2615 51.004900 2615 1509 -0.000010 2615 1510 -1.736640 2615 1511 -2.935616 2615 2565 -0.000010 2615 2566 -1.743573 2615 2567 -2.947335 2615 2610 -0.000010 2615 2611 -1.716692 2615 2612 -2.901894 2615 2613 0.000734 2615 2614 8.640671 2615 2615 14.606187 2615 2616 -0.000010 2615 2617 -1.752502 2615 2618 -2.962429 2615 2661 -0.000010 2615 2662 -1.685048 2615 2663 -2.848406 2616 1512 -0.039367 2616 2568 -0.116990 2616 2569 22.314308 2616 2570 37.720082 2616 2613 -0.049024 2616 2614 3.878796 2616 2615 6.556717 2616 2616 292.540140 2616 2617 -196.992950 2616 2618 -332.996700 2616 2619 -0.000998 2616 2664 -0.000992 2617 2570 -6.110688 2617 2615 -1.062175 2617 2617 -55.648296 2617 2618 51.582022 2618 1512 -0.000010 2618 1513 -1.731904 2618 1514 -2.927608 2618 2568 -0.000010 2618 2569 -1.745529 2618 2570 -2.950641 2618 2613 -0.000010 2618 2614 -1.752502 2618 2615 -2.962429 2618 2616 0.000735 2618 2617 8.729817 2618 2618 14.756875 2618 2619 -0.000010 2618 2620 -1.752501 2618 2621 -2.962426 2618 2664 -0.000010 2618 2665 -1.741164 2618 2666 -2.943262 2619 1515 -0.037136 2619 2571 -0.127846 2619 2572 23.380365 2619 2573 39.522169 2619 2616 -0.028113 2619 2617 1.822445 2619 2618 3.080660 2619 2619 292.531730 2619 2620 -197.216270 2619 2621 -333.374380 2619 2622 -0.022032 2619 2623 1.224559 2619 2624 2.069993 2619 2667 -0.000996 2620 2573 -6.402606 2620 2618 -0.499058 2620 2620 -55.648176 2620 2621 51.643267 2620 2624 -0.335333 2621 1515 -0.000010 2621 1516 -1.731899 2621 1517 -2.927602 2621 2571 -0.000010 2621 2572 -1.745518 2621 2573 -2.950624 2621 2616 -0.000010 2621 2617 -1.752501 2621 2618 -2.962426 2621 2619 0.000736 2621 2620 8.731226 2621 2621 14.759261 2621 2622 -0.000010 2621 2623 -1.752503 2621 2624 -2.962429 2621 2667 -0.000010 2621 2668 -1.742588 2621 2669 -2.945671 2622 1518 -0.038450 2622 2574 -0.125992 2622 2575 23.202076 2622 2576 39.220762 2622 2619 -0.000999 2622 2622 292.552610 2622 2623 -197.520590 2622 2624 -333.888620 2622 2625 -0.045425 2622 2626 3.524849 2622 2627 5.958405 2622 2670 -0.000995 2623 2576 -6.353800 2623 2623 -55.648621 2623 2624 51.725673 2623 2627 -0.965248 2624 1518 -0.000010 2624 1519 -1.730916 2624 1520 -2.925939 2624 2574 -0.000010 2624 2575 -1.746031 2624 2576 -2.951488 2624 2619 -0.000010 2624 2620 -1.752503 2624 2621 -2.962429 2624 2622 0.000735 2624 2623 8.732630 2624 2624 14.761630 2624 2625 -0.000010 2624 2626 -1.752406 2624 2627 -2.962267 2624 2670 -0.000010 2624 2671 -1.744558 2624 2672 -2.948999 2625 1521 -0.041432 2625 2577 -0.124322 2625 2578 22.200415 2625 2579 37.527582 2625 2622 -0.000991 2625 2625 292.548060 2625 2626 -197.535140 2625 2627 -333.913400 2625 2628 -0.067965 2625 2629 4.554214 2625 2630 7.698438 2625 2673 -0.000988 2626 2579 -6.079542 2626 2626 -55.647836 2626 2627 51.731839 2626 2630 -1.247138 2627 1521 -0.000010 2627 1522 -1.732089 2627 1523 -2.927923 2627 2577 -0.000010 2627 2578 -1.746086 2627 2579 -2.951584 2627 2622 -0.000010 2627 2623 -1.752406 2627 2624 -2.962267 2627 2625 0.000735 2627 2626 8.717101 2627 2627 14.735386 2627 2628 -0.000010 2627 2629 -1.734362 2627 2630 -2.931764 2627 2673 -0.000010 2627 2674 -1.745942 2627 2675 -2.951340 2628 1524 -0.044120 2628 2580 -0.122082 2628 2581 20.074998 2628 2582 33.934755 2628 2625 -0.000971 2628 2628 286.695420 2628 2629 -192.563890 2628 2630 -325.509750 2628 2631 -0.087941 2628 2632 5.113127 2628 2633 8.643229 2628 2676 -0.000967 2629 2582 -5.497546 2629 2629 -54.535101 2629 2630 50.417700 2629 2633 -1.400202 2630 1524 -0.000010 2630 1525 -1.768646 2630 1526 -2.989716 2630 2580 -0.000009 2630 2581 -1.676061 2630 2582 -2.833212 2630 2625 -0.000010 2630 2626 -1.734362 2630 2627 -2.931764 2630 2628 0.000720 2630 2629 8.575091 2630 2630 14.495325 2630 2631 -0.000010 2630 2632 -1.661949 2630 2633 -2.809358 2630 2676 -0.000010 2630 2677 -1.727981 2630 2678 -2.920977 2631 1527 -0.046165 2631 2583 -0.107003 2631 2584 17.330914 2631 2585 29.296178 2631 2628 -0.000919 2631 2631 269.126650 2631 2632 -179.261130 2631 2633 -303.023010 2631 2634 -0.103151 2631 2635 4.820267 2631 2636 8.148174 2631 2679 -0.000897 2632 2585 -4.746101 2632 2632 -51.197932 2632 2633 46.912740 2632 2636 -1.320014 2633 1527 -0.000011 2633 1528 -1.887902 2633 1529 -3.191310 2633 2583 -0.000009 2633 2584 -1.570612 2633 2585 -2.654962 2633 2628 -0.000010 2633 2629 -1.661949 2633 2630 -2.809358 2633 2631 0.000676 2633 2632 8.267012 2633 2633 13.974555 2633 2634 -0.000009 2633 2635 -1.517990 2633 2636 -2.566009 2633 2679 -0.000009 2633 2680 -1.622840 2633 2681 -2.743248 2634 1530 -0.047266 2634 2586 -0.052806 2634 2587 13.660367 2634 2588 23.091469 2634 2631 -0.000828 2634 2634 239.845290 2634 2635 -153.663950 2634 2636 -259.753370 2634 2682 -0.000799 2635 2588 -3.740930 2635 2635 -45.637013 2635 2636 40.130338 2636 1530 -0.000012 2636 1531 -2.114944 2636 1532 -3.575099 2636 2586 -0.000008 2636 2587 -1.413859 2636 2588 -2.389985 2636 2631 -0.000009 2636 2632 -1.517990 2636 2633 -2.566009 2636 2634 0.000598 2636 2635 6.517954 2636 2636 11.017941 2636 2682 -0.000008 2636 2683 -1.466061 2636 2684 -2.478228 2637 2637 1.000000 2638 2638 1.000000 2639 2639 1.000000 2640 2640 1.000000 2641 2641 1.000000 2642 2642 1.000000 2643 2643 1.000000 2644 2644 1.000000 2645 2645 1.000000 2646 2646 1.000000 2647 2647 1.000000 2648 2648 1.000000 2649 2649 1.000000 2650 2650 1.000000 2651 2651 1.000000 2652 1548 -0.048489 2652 2604 -0.000806 2652 2605 7.373340 2652 2606 12.463884 2652 2652 216.441350 2652 2653 -133.763990 2652 2654 -226.114460 2652 2655 -0.000778 2652 2700 -0.017667 2653 2606 -2.019122 2653 2653 -41.208238 2653 2654 34.812190 2654 1548 -0.000014 2654 1549 -2.351456 2654 1550 -3.974898 2654 2604 -0.000008 2654 2605 -1.395527 2654 2606 -2.358996 2654 2652 0.000544 2654 2653 6.274304 2654 2654 10.606074 2654 2655 -0.000008 2654 2656 -1.347007 2654 2657 -2.276979 2654 2700 -0.000007 2654 2701 -1.175701 2654 2702 -1.987403 2655 1551 -0.046791 2655 2607 -0.000859 2655 2608 13.568905 2655 2609 22.936876 2655 2652 -0.048658 2655 2653 0.622266 2655 2654 1.051877 2655 2655 233.933840 2655 2656 -150.862420 2655 2657 -255.017830 2655 2658 -0.000850 2655 2703 -0.014380 2656 2609 -3.715751 2656 2654 -0.170400 2656 2656 -44.544210 2656 2657 39.359599 2657 1551 -0.000013 2657 1552 -2.181072 2657 1553 -3.686883 2657 2607 -0.000009 2657 2608 -1.484417 2657 2609 -2.509259 2657 2652 -0.000008 2657 2653 -1.347007 2657 2654 -2.276979 2657 2655 0.000594 2657 2656 7.784931 2657 2657 13.159646 2657 2658 -0.000009 2657 2659 -1.468698 2657 2660 -2.482687 2657 2703 -0.000008 2657 2704 -1.298753 2657 2705 -2.195412 2658 1554 -0.042697 2658 2610 -0.035101 2658 2611 17.742896 2658 2612 29.992569 2658 2655 -0.067043 2658 2656 3.866122 2658 2657 6.535292 2658 2658 257.374050 2658 2659 -171.928550 2658 2660 -290.627820 2658 2661 -0.000931 2658 2706 -0.000830 2659 2612 -4.858763 2659 2657 -1.058688 2659 2659 -48.997177 2659 2660 44.936312 2660 1554 -0.000012 2660 1555 -1.979740 2660 1556 -3.346550 2660 2610 -0.000009 2660 2611 -1.595336 2660 2612 -2.696754 2660 2655 -0.000009 2660 2656 -1.468698 2660 2657 -2.482687 2660 2658 0.000651 2660 2659 8.060697 2660 2660 13.625795 2660 2661 -0.000010 2660 2662 -1.592668 2660 2663 -2.692244 2660 2706 -0.000009 2660 2707 -1.418773 2660 2708 -2.398292 2661 1557 -0.035557 2661 2613 -0.089967 2661 2614 21.966129 2661 2615 37.131544 2661 2658 -0.100182 2661 2659 6.460499 2661 2660 10.920820 2661 2661 274.973760 2661 2662 -189.016190 2661 2663 -319.512960 2661 2664 -0.001009 2661 2709 -0.000929 2662 2615 -6.015234 2662 2660 -1.769114 2662 2662 -52.337002 2662 2663 49.470820 2663 1557 -0.000012 2663 1558 -1.854414 2663 1559 -3.134701 2663 2613 -0.000010 2663 2614 -1.685048 2663 2615 -2.848406 2663 2658 -0.000010 2663 2659 -1.592668 2663 2660 -2.692244 2663 2661 0.000694 2663 2662 8.401055 2663 2663 14.201141 2663 2664 -0.000011 2663 2665 -1.698177 2663 2666 -2.870598 2663 2709 -0.000010 2663 2710 -1.564892 2663 2711 -2.645294 2664 1560 -0.026543 2664 2616 -0.160986 2664 2617 25.778745 2664 2618 43.576367 2664 2661 -0.113865 2664 2662 6.762803 2664 2663 11.431841 2664 2664 292.499690 2664 2665 -203.392450 2664 2666 -343.814330 2664 2667 -0.001057 2664 2712 -0.001027 2665 2618 -7.059249 2665 2663 -1.851879 2665 2665 -55.675534 2665 2666 53.266037 2666 1560 -0.000011 2666 1561 -1.742717 2666 1562 -2.945886 2666 2616 -0.000010 2666 2617 -1.741164 2666 2618 -2.943262 2666 2661 -0.000011 2666 2662 -1.698177 2666 2663 -2.870598 2666 2664 0.000738 2666 2665 8.644688 2666 2666 14.612973 2666 2667 -0.000011 2666 2668 -1.752938 2666 2669 -2.963164 2666 2712 -0.000011 2666 2713 -1.703465 2666 2714 -2.879535 2667 1563 -0.019503 2667 2619 -0.179478 2667 2620 27.604579 2667 2621 46.662780 2667 2664 -0.046635 2667 2665 3.638075 2667 2666 6.149797 2667 2667 292.503160 2667 2668 -204.147000 2667 2669 -345.090080 2667 2670 -0.021879 2667 2671 2.046923 2667 2672 3.460115 2667 2715 -0.001059 2668 2621 -7.559218 2668 2666 -0.996216 2668 2668 -55.676391 2668 2669 53.470185 2668 2672 -0.560508 2669 1563 -0.000011 2669 1564 -1.740045 2669 1565 -2.941372 2669 2619 -0.000010 2669 2620 -1.742588 2669 2621 -2.945671 2669 2664 -0.000011 2669 2665 -1.752938 2669 2666 -2.963164 2669 2667 0.000739 2669 2668 8.737749 2669 2669 14.770287 2669 2670 -0.000011 2669 2671 -1.752867 2669 2672 -2.963044 2669 2715 -0.000011 2669 2716 -1.743083 2669 2717 -2.946507 2670 1566 -0.024154 2670 2622 -0.179890 2670 2623 26.817401 2670 2624 45.332109 2670 2667 -0.001061 2670 2670 292.516610 2670 2671 -203.209120 2670 2672 -343.504450 2670 2673 -0.074649 2670 2674 5.550434 2670 2675 9.382454 2670 2718 -0.001054 2671 2624 -7.343669 2671 2671 -55.675291 2671 2672 53.216309 2671 2675 -1.519886 2672 1566 -0.000011 2672 1567 -1.737268 2672 1568 -2.936676 2672 2622 -0.000010 2672 2623 -1.744558 2672 2624 -2.948999 2672 2667 -0.000011 2672 2668 -1.752867 2672 2669 -2.963044 2672 2670 0.000738 2672 2671 8.735672 2672 2672 14.766772 2672 2673 -0.000011 2672 2674 -1.752665 2672 2675 -2.962706 2672 2718 -0.000011 2672 2719 -1.742086 2672 2720 -2.944819 2673 1569 -0.032290 2673 2625 -0.150961 2673 2626 24.820915 2673 2627 41.957275 2673 2670 -0.001048 2673 2673 292.560490 2673 2674 -202.417260 2673 2675 -342.166130 2673 2676 -0.095453 2673 2677 6.755399 2673 2678 11.419317 2673 2721 -0.001042 2674 2627 -6.796984 2674 2674 -55.674523 2674 2675 53.001769 2674 2678 -1.849860 2675 1569 -0.000011 2675 1570 -1.733724 2675 1571 -2.930687 2675 2625 -0.000010 2675 2626 -1.745942 2675 2627 -2.951340 2675 2670 -0.000011 2675 2671 -1.752665 2675 2672 -2.962706 2675 2673 0.000738 2675 2674 8.732950 2675 2675 14.762177 2675 2676 -0.000011 2675 2677 -1.751940 2675 2678 -2.961477 2675 2721 -0.000011 2675 2722 -1.742451 2675 2723 -2.945440 2676 1572 -0.038943 2676 2628 -0.122994 2676 2629 22.439305 2676 2630 37.931372 2676 2673 -0.001032 2676 2676 292.559700 2676 2677 -200.816080 2676 2678 -339.459220 2676 2679 -0.130196 2676 2680 7.555952 2676 2681 12.772581 2676 2724 -0.001027 2677 2630 -6.144839 2677 2677 -55.674209 2677 2678 52.564782 2677 2681 -2.069101 2678 1572 -0.000011 2678 1573 -1.734867 2678 1574 -2.932617 2678 2628 -0.000010 2678 2629 -1.727981 2678 2630 -2.920977 2678 2673 -0.000011 2678 2674 -1.751940 2678 2675 -2.961477 2678 2676 0.000737 2678 2677 8.661032 2678 2678 14.640600 2678 2679 -0.000010 2678 2680 -1.697568 2678 2681 -2.869568 2678 2724 -0.000011 2678 2725 -1.742449 2678 2726 -2.945433 2679 1575 -0.042704 2679 2631 -0.076916 2679 2632 18.842384 2679 2633 31.851165 2679 2676 -0.000983 2679 2679 275.072580 2679 2680 -191.454180 2679 2681 -323.634150 2679 2682 -0.160014 2679 2683 12.057719 2679 2684 20.382357 2679 2727 -0.000959 2680 2633 -5.159886 2680 2680 -52.336375 2680 2681 50.140954 2680 2684 -3.301911 2681 1575 -0.000011 2681 1576 -1.843384 2681 1577 -3.116056 2681 2631 -0.000009 2681 2632 -1.622840 2681 2633 -2.743248 2681 2676 -0.000010 2681 2677 -1.697568 2681 2678 -2.869568 2681 2679 0.000693 2681 2680 8.399661 2681 2681 14.198786 2681 2682 -0.000009 2681 2683 -1.573816 2681 2684 -2.660376 2681 2727 -0.000010 2681 2728 -1.656200 2681 2729 -2.799640 2682 1578 -0.045977 2682 2634 -0.020031 2682 2635 10.444244 2682 2636 17.654939 2682 2679 -0.000884 2682 2682 251.557290 2682 2683 -157.273780 2682 2684 -265.855450 2683 2636 -2.860122 2683 2683 -47.880521 2683 2684 40.980820 2684 1578 -0.000012 2684 1579 -2.015677 2684 1580 -3.407298 2684 2634 -0.000008 2684 2635 -1.466061 2684 2636 -2.478228 2684 2679 -0.000009 2684 2680 -1.573816 2684 2681 -2.660376 2684 2682 0.000618 2684 2683 5.060910 2684 2684 8.554956 2685 2685 1.000000 2686 2686 1.000000 2687 2687 1.000000 2688 2688 1.000000 2689 2689 1.000000 2690 2690 1.000000 2691 2691 1.000000 2692 2692 1.000000 2693 2693 1.000000 2694 2694 1.000000 2695 2695 1.000000 2696 2696 1.000000 2697 2697 1.000000 2698 2698 1.000000 2699 2699 1.000000 2700 1596 -0.048244 2700 2652 -0.000698 2700 2653 8.293174 2700 2654 14.018770 2700 2700 181.279450 2700 2701 -114.218350 2700 2702 -193.074610 2700 2703 -0.000684 2700 2748 -0.006890 2701 2654 -2.270983 2701 2701 -34.541974 2701 2702 29.714594 2702 1596 -0.000017 2702 1597 -2.799416 2702 1598 -4.732131 2702 2652 -0.000007 2702 2653 -1.175701 2702 2654 -1.987403 2702 2700 0.000462 2702 2701 6.140865 2702 2702 10.380512 2702 2703 -0.000007 2702 2704 -1.152668 2702 2705 -1.948468 2702 2748 -0.000006 2702 2749 -1.009209 2702 2750 -1.705965 2703 1599 -0.044945 2703 2655 -0.000779 2703 2656 11.894484 2703 2657 20.106436 2703 2700 -0.046208 2703 2701 2.957952 2703 2702 5.000119 2703 2703 204.725750 2703 2704 -134.431330 2703 2705 -227.242720 2703 2706 -0.000766 2703 2751 -0.000677 2704 2657 -3.257153 2704 2702 -0.809985 2704 2704 -38.998572 2704 2705 35.048730 2705 1599 -0.000016 2705 1600 -2.481216 2705 1601 -4.194248 2705 2655 -0.000008 2705 2656 -1.298753 2705 2657 -2.195412 2705 2700 -0.000007 2705 2701 -1.152668 2705 2702 -1.948468 2705 2703 0.000525 2705 2704 7.343362 2705 2705 12.413219 2705 2706 -0.000008 2705 2707 -1.277278 2705 2708 -2.159111 2705 2751 -0.000007 2705 2752 -1.129076 2705 2753 -1.908590 2706 1602 -0.036136 2706 2658 -0.032965 2706 2659 16.546834 2706 2660 27.970749 2706 2703 -0.100611 2706 2704 6.560144 2706 2705 11.089268 2706 2706 222.303950 2706 2707 -152.958530 2706 2708 -258.560970 2706 2709 -0.000864 2706 2754 -0.000765 2707 2660 -4.531112 2707 2705 -1.796374 2707 2707 -42.340527 2707 2708 39.972265 2708 1602 -0.000015 2708 1603 -2.287583 2708 1604 -3.866929 2708 2658 -0.000009 2708 2659 -1.418773 2708 2660 -2.398292 2708 2703 -0.000008 2708 2704 -1.277278 2708 2705 -2.159111 2708 2706 0.000568 2708 2707 7.655307 2708 2708 12.940525 2708 2709 -0.000009 2708 2710 -1.414297 2708 2711 -2.390727 2708 2754 -0.000008 2708 2755 -1.252630 2708 2756 -2.117444 2709 1605 -0.019913 2709 2661 -0.079157 2709 2662 22.556493 2709 2663 38.129496 2709 2706 -0.127625 2709 2707 9.626845 2709 2708 16.273212 2709 2709 251.639730 2709 2710 -179.098860 2709 2711 -302.748710 2709 2712 -0.000996 2709 2757 -0.000882 2710 2663 -6.176712 2710 2708 -2.636101 2710 2710 -47.913181 2710 2711 46.873893 2711 1605 -0.000013 2711 1606 -2.015473 2711 1607 -3.406955 2711 2661 -0.000010 2711 2662 -1.564892 2711 2663 -2.645294 2711 2706 -0.000009 2711 2707 -1.414297 2711 2708 -2.390727 2711 2709 0.000640 2711 2710 7.998507 2711 2711 13.520675 2711 2712 -0.000010 2711 2713 -1.590278 2711 2714 -2.688206 2711 2757 -0.000009 2711 2758 -1.408195 2711 2759 -2.380413 2712 1608 -0.001162 2712 2664 -0.131318 2712 2665 29.099360 2712 2666 49.189521 2712 2709 -0.148770 2712 2710 10.574914 2712 2711 17.875834 2712 2712 280.864350 2712 2713 -203.707380 2712 2714 -344.346720 2712 2715 -0.001102 2712 2760 -0.001028 2713 2666 -7.968291 2713 2711 -2.895663 2713 2713 -53.485001 2713 2714 53.357989 2714 1608 -0.000012 2714 1609 -1.810762 2714 1610 -3.060910 2714 2664 -0.000011 2714 2665 -1.703465 2714 2666 -2.879535 2714 2709 -0.000010 2714 2710 -1.590278 2714 2711 -2.688206 2714 2712 0.000712 2714 2713 8.429687 2714 2714 14.249535 2714 2715 -0.000012 2714 2716 -1.717499 2714 2717 -2.903258 2714 2760 -0.000011 2714 2761 -1.601688 2714 2762 -2.707491 2715 1611 -0.001127 2715 2667 -0.181157 2715 2668 32.808237 2715 2669 55.459044 2715 2712 -0.091822 2715 2713 6.551315 2715 2714 11.074335 2715 2715 292.604130 2715 2716 -214.774880 2715 2717 -363.055460 2715 2718 -0.030381 2715 2719 4.564827 2715 2720 7.716380 2715 2763 -0.001135 2716 2669 -8.983851 2716 2714 -1.793878 2716 2716 -55.713949 2716 2717 56.285871 2716 2720 -1.249935 2717 1611 -0.000012 2717 1612 -1.733026 2717 1613 -2.929508 2717 2667 -0.000011 2717 2668 -1.743083 2717 2669 -2.946507 2717 2712 -0.000012 2717 2713 -1.717499 2717 2714 -2.903258 2717 2715 0.000742 2717 2716 8.698509 2717 2717 14.703956 2717 2718 -0.000012 2717 2719 -1.753384 2717 2720 -2.963920 2717 2763 -0.000012 2717 2764 -1.745271 2717 2765 -2.950206 2718 1614 -0.001120 2718 2670 -0.172672 2718 2671 30.288338 2718 2672 51.199370 2718 2715 -0.001130 2718 2718 292.511430 2718 2719 -210.232150 2718 2720 -355.376290 2718 2721 -0.084683 2718 2722 9.063667 2718 2723 15.321223 2718 2766 -0.001124 2719 2672 -8.293851 2719 2719 -55.709291 2719 2720 55.053787 2719 2723 -2.481832 2720 1614 -0.000012 2720 1615 -1.737656 2720 1616 -2.937332 2720 2670 -0.000011 2720 2671 -1.742086 2720 2672 -2.944819 2720 2715 -0.000012 2720 2716 -1.753384 2720 2717 -2.963920 2720 2718 0.000742 2720 2719 8.737056 2720 2720 14.769114 2720 2721 -0.000012 2720 2722 -1.753205 2720 2723 -2.963617 2720 2766 -0.000012 2720 2767 -1.744482 2720 2768 -2.948872 2721 1617 -0.016261 2721 2673 -0.162787 2721 2674 26.804110 2721 2675 45.309667 2721 2718 -0.001110 2721 2721 292.487780 2721 2722 -206.609670 2721 2723 -349.252980 2721 2724 -0.117554 2721 2725 8.924396 2721 2726 15.085791 2721 2769 -0.001103 2722 2675 -7.339821 2722 2722 -55.703345 2722 2723 54.077195 2722 2726 -2.443725 2723 1617 -0.000012 2723 1618 -1.740848 2723 1619 -2.942729 2723 2673 -0.000011 2723 2674 -1.742451 2723 2675 -2.945440 2723 2718 -0.000012 2723 2719 -1.753205 2723 2720 -2.963617 2723 2721 0.000741 2723 2722 8.738894 2723 2723 14.772224 2723 2724 -0.000011 2723 2725 -1.752690 2723 2726 -2.962745 2723 2769 -0.000012 2723 2770 -1.743460 2723 2771 -2.947144 2724 1620 -0.030551 2724 2676 -0.140867 2724 2677 24.649625 2724 2678 41.667691 2724 2721 -0.001089 2724 2724 292.487150 2724 2725 -201.610140 2724 2726 -340.801610 2724 2727 -0.103736 2724 2728 6.076339 2724 2729 10.271443 2724 2772 -0.001083 2725 2678 -6.749914 2725 2725 -55.701882 2725 2726 52.712667 2725 2729 -1.663869 2726 1620 -0.000011 2726 1621 -1.741374 2726 1622 -2.943616 2726 2676 -0.000011 2726 2677 -1.742449 2726 2678 -2.945433 2726 2721 -0.000011 2726 2722 -1.752690 2726 2723 -2.962745 2726 2724 0.000740 2726 2725 8.703334 2726 2726 14.712108 2726 2727 -0.000011 2726 2728 -1.716647 2726 2729 -2.901821 2726 2772 -0.000011 2726 2773 -1.743935 2726 2774 -2.947945 2727 1623 -0.036772 2727 2679 -0.160837 2727 2680 24.937640 2727 2681 42.154587 2727 2724 -0.001053 2727 2727 280.761620 2727 2728 -188.954090 2727 2729 -319.408000 2727 2775 -0.001037 2728 2681 -6.828855 2728 2728 -53.475766 2728 2729 49.342559 2729 1623 -0.000012 2729 1624 -1.813471 2729 1625 -3.065492 2729 2679 -0.000010 2729 2680 -1.656200 2729 2681 -2.799640 2729 2724 -0.000011 2729 2725 -1.716647 2729 2726 -2.901821 2729 2727 0.000700 2729 2728 6.884603 2729 2729 11.637733 2729 2775 -0.000011 2729 2776 -1.692294 2729 2777 -2.860654 2730 2730 1.000000 2731 2731 1.000000 2732 2732 1.000000 2733 2733 1.000000 2734 2734 1.000000 2735 2735 1.000000 2736 2736 1.000000 2737 2737 1.000000 2738 2738 1.000000 2739 2739 1.000000 2740 2740 1.000000 2741 2741 1.000000 2742 2742 1.000000 2743 2743 1.000000 2744 2744 1.000000 2745 2745 1.000000 2746 2746 1.000000 2747 2747 1.000000 2748 1644 -0.048403 2748 2700 -0.000614 2748 2701 6.542096 2748 2702 11.058753 2748 2748 157.884050 2748 2749 -98.805163 2748 2750 -167.020130 2748 2751 -0.000606 2748 2796 -0.000541 2749 2702 -1.791442 2749 2749 -30.096993 2749 2750 25.665630 2750 1644 -0.000020 2750 1645 -3.202279 2750 1646 -5.413128 2750 2700 -0.000006 2750 2701 -1.009209 2750 2702 -1.705965 2750 2748 0.000408 2750 2749 6.101921 2750 2750 10.314680 2750 2751 -0.000006 2750 2752 -0.996783 2750 2753 -1.684961 2750 2796 -0.000006 2750 2797 -0.890273 2750 2798 -1.504917 2751 1647 -0.042824 2751 2703 -0.012524 2751 2704 9.411765 2751 2705 15.909648 2751 2748 -0.056619 2751 2749 4.404968 2751 2750 7.446152 2751 2751 175.478800 2751 2752 -116.341660 2751 2753 -196.663940 2751 2754 -0.000691 2751 2799 -0.000615 2752 2705 -2.577237 2752 2750 -1.206208 2752 2752 -33.442061 2752 2753 30.310371 2753 1647 -0.000019 2753 1648 -2.884855 2753 1649 -4.876560 2753 2703 -0.000007 2753 2704 -1.129076 2753 2705 -1.908590 2753 2748 -0.000006 2753 2749 -0.996783 2753 2750 -1.684961 2753 2751 0.000456 2753 2752 7.126502 2753 2753 12.046637 2753 2754 -0.000007 2753 2755 -1.117042 2753 2756 -1.888247 2753 2799 -0.000006 2753 2800 -0.994993 2753 2801 -1.681936 2754 1650 -0.027384 2754 2706 -0.039837 2754 2707 13.936147 2754 2708 23.557652 2754 2751 -0.111104 2754 2752 8.852419 2754 2753 14.964129 2754 2754 198.949310 2754 2755 -138.969300 2754 2756 -234.913530 2754 2757 -0.000800 2754 2802 -0.000710 2755 2708 -3.816109 2755 2753 -2.424024 2755 2755 -37.903255 2755 2756 36.293837 2756 1650 -0.000017 2756 1651 -2.552144 2756 1652 -4.314142 2756 2706 -0.000008 2756 2707 -1.252630 2756 2708 -2.117444 2756 2751 -0.000007 2756 2752 -1.117042 2756 2753 -1.888247 2756 2754 0.000513 2756 2755 7.299508 2756 2756 12.339081 2756 2757 -0.000008 2756 2758 -1.257777 2756 2759 -2.126144 2756 2802 -0.000007 2756 2803 -1.115661 2756 2804 -1.885912 2757 1653 -0.001509 2757 2709 -0.128191 2757 2710 20.776367 2757 2711 35.120371 2757 2754 -0.187967 2757 2755 13.123630 2757 2756 22.184168 2757 2757 222.333580 2757 2758 -163.800150 2757 2759 -276.887780 2757 2760 -0.000944 2757 2805 -0.000853 2758 2711 -5.689064 2758 2756 -3.593527 2758 2758 -42.362572 2758 2759 42.884400 2759 1653 -0.000016 2759 1654 -2.286282 2759 1655 -3.864731 2759 2709 -0.000009 2759 2710 -1.408195 2759 2711 -2.380413 2759 2754 -0.000008 2759 2755 -1.257777 2759 2756 -2.126144 2759 2757 0.000572 2759 2758 7.678512 2759 2759 12.979755 2759 2760 -0.000010 2759 2761 -1.429739 2759 2762 -2.416830 2759 2805 -0.000009 2759 2806 -1.291764 2759 2807 -2.183598 2760 1656 -0.001351 2760 2712 -0.178737 2760 2713 30.389582 2760 2714 51.370514 2760 2757 -0.163133 2760 2758 15.538893 2760 2759 26.266945 2760 2760 257.580600 2760 2761 -196.284140 2760 2762 -331.798480 2760 2763 -0.001123 2760 2808 -0.001016 2761 2714 -8.321260 2761 2759 -4.254772 2761 2761 -49.059757 2761 2762 51.446462 2762 1656 -0.000014 2762 1657 -1.973253 2762 1658 -3.335585 2762 2712 -0.000011 2762 2713 -1.601688 2762 2714 -2.707491 2762 2757 -0.000010 2762 2758 -1.429739 2762 2759 -2.416830 2762 2760 0.000659 2762 2761 8.135586 2762 2762 13.752387 2762 2763 -0.000012 2762 2764 -1.640883 2762 2765 -2.773746 2762 2808 -0.000011 2762 2809 -1.484513 2762 2810 -2.509420 2763 1659 -0.001220 2763 2715 -0.299170 2763 2716 39.402394 2763 2717 66.605807 2763 2760 -0.185897 2763 2761 12.169841 2763 2762 20.571884 2763 2763 292.737760 2763 2764 -234.562610 2763 2765 -396.504630 2763 2766 -0.140935 2763 2767 12.060554 2763 2768 20.387148 2763 2811 -0.001201 2764 2717 -10.789049 2764 2762 -3.332192 2764 2764 -55.748297 2764 2765 61.616126 2764 2768 -3.302265 2765 1659 -0.000013 2765 1660 -1.737883 2765 1661 -2.937718 2765 2715 -0.000012 2765 2716 -1.745271 2765 2717 -2.950206 2765 2760 -0.000012 2765 2761 -1.640883 2765 2762 -2.773746 2765 2763 0.000745 2765 2764 8.595787 2765 2765 14.530315 2765 2766 -0.000013 2765 2767 -1.753899 2765 2768 -2.964790 2765 2811 -0.000013 2765 2812 -1.711591 2765 2813 -2.893273 2766 1662 -0.001190 2766 2718 -0.189128 2766 2719 31.930030 2766 2720 53.974502 2766 2763 -0.001203 2766 2766 292.612180 2766 2767 -217.908060 2766 2768 -368.351550 2766 2769 -0.163158 2766 2770 15.094148 2766 2771 25.515148 2766 2814 -0.001199 2767 2720 -8.743041 2767 2767 -55.744062 2767 2768 57.067662 2767 2771 -4.132967 2768 1662 -0.000012 2768 1663 -1.734435 2768 1664 -2.931888 2768 2718 -0.000012 2768 2719 -1.744482 2768 2720 -2.948872 2768 2763 -0.000013 2768 2764 -1.753899 2768 2765 -2.964790 2768 2766 0.000745 2768 2767 8.741552 2768 2768 14.776712 2768 2769 -0.000012 2768 2770 -1.753726 2768 2771 -2.964499 2768 2814 -0.000013 2768 2815 -1.748750 2768 2816 -2.956085 2769 1665 -0.001155 2769 2721 -0.111032 2769 2722 25.917748 2769 2723 43.811362 2769 2766 -0.001169 2769 2769 292.531630 2769 2770 -209.224400 2769 2771 -353.672930 2769 2772 -0.152986 2769 2773 12.407653 2769 2774 20.973881 2769 2817 -0.001165 2770 2723 -7.096851 2770 2770 -55.737111 2770 2771 54.708381 2770 2774 -3.397428 2771 1665 -0.000012 2771 1666 -1.733594 2771 1667 -2.930466 2771 2721 -0.000012 2771 2722 -1.743460 2771 2723 -2.947144 2771 2766 -0.000012 2771 2767 -1.753726 2771 2768 -2.964499 2771 2769 0.000744 2771 2770 8.739058 2771 2771 14.772502 2771 2772 -0.000012 2771 2773 -1.753268 2771 2774 -2.963722 2771 2817 -0.000012 2771 2818 -1.748755 2771 2819 -2.956095 2772 1668 -0.019894 2772 2724 -0.075843 2772 2725 22.461520 2772 2726 37.968935 2772 2769 -0.001140 2772 2772 292.499520 2772 2773 -201.339030 2772 2774 -340.343250 2772 2775 -0.120098 2772 2776 8.001904 2772 2777 13.526419 2772 2820 -0.001138 2773 2726 -6.150532 2773 2773 -55.733785 2773 2774 52.558623 2773 2777 -2.191082 2774 1668 -0.000012 2774 1669 -1.732973 2774 1670 -2.929415 2774 2724 -0.000011 2774 2725 -1.743935 2774 2726 -2.947945 2774 2769 -0.000012 2774 2770 -1.753268 2774 2771 -2.963722 2774 2772 0.000742 2774 2773 8.721750 2774 2774 14.743237 2774 2775 -0.000012 2774 2776 -1.735331 2774 2777 -2.933403 2774 2820 -0.000012 2774 2821 -1.749989 2774 2822 -2.958180 2775 1671 -0.030771 2775 2727 -0.058737 2775 2728 19.981820 2775 2729 33.777269 2775 2772 -0.001110 2775 2775 286.581580 2775 2776 -187.427920 2775 2777 -316.828150 2775 2823 -0.001108 2776 2729 -5.471574 2776 2776 -54.619660 2776 2777 48.800221 2777 1671 -0.000012 2777 1672 -1.767162 2777 1673 -2.987210 2777 2727 -0.000011 2777 2728 -1.692294 2777 2729 -2.860654 2777 2772 -0.000012 2777 2773 -1.735331 2777 2774 -2.933403 2777 2775 0.000716 2777 2776 6.933208 2777 2777 11.719894 2777 2823 -0.000012 2777 2824 -1.732292 2777 2825 -2.928266 2778 2778 1.000000 2779 2779 1.000000 2780 2780 1.000000 2781 2781 1.000000 2782 2782 1.000000 2783 2783 1.000000 2784 2784 1.000000 2785 2785 1.000000 2786 2786 1.000000 2787 2787 1.000000 2788 2788 1.000000 2789 2789 1.000000 2790 2790 1.000000 2791 2791 1.000000 2792 2792 1.000000 2793 1689 -0.052333 2793 2793 116.917980 2793 2794 -69.421330 2793 2795 -117.349820 2793 2796 -0.000467 2793 2841 -0.024738 2793 2842 1.041592 2793 2843 1.760707 2794 2794 -22.297074 2794 2795 17.972447 2794 2843 -0.285218 2795 1689 -0.000028 2795 1690 -4.319810 2795 1691 -7.302207 2795 2793 0.000310 2795 2794 5.789129 2795 2795 9.785944 2795 2796 -0.000005 2795 2797 -0.765398 2795 2798 -1.293829 2795 2841 -0.000004 2795 2842 -0.701417 2795 2843 -1.185676 2796 1692 -0.049676 2796 2748 -0.000585 2796 2749 3.134930 2796 2750 5.299283 2796 2793 -0.015879 2796 2794 1.980721 2796 2795 3.348210 2796 2796 140.341690 2796 2797 -87.160026 2796 2798 -147.335220 2796 2799 -0.000549 2796 2844 -0.027019 2797 2750 -0.858435 2797 2795 -0.542377 2797 2797 -26.758321 2797 2798 22.617766 2798 1692 -0.000023 2798 1693 -3.602981 2798 1694 -6.090476 2798 2748 -0.000006 2798 2749 -0.890273 2798 2750 -1.504917 2798 2793 -0.000005 2798 2794 -0.765398 2798 2795 -1.293829 2798 2796 0.000373 2798 2797 6.917890 2798 2798 11.693996 2798 2799 -0.000006 2798 2800 -0.891516 2798 2801 -1.507018 2798 2844 -0.000005 2798 2845 -0.764717 2798 2846 -1.292677 2799 1695 -0.042453 2799 2751 -0.012406 2799 2752 5.617180 2799 2753 9.495282 2799 2796 -0.061160 2799 2797 5.833197 2799 2798 9.860430 2799 2799 157.923820 2799 2800 -103.738760 2799 2801 -175.360000 2799 2802 -0.000629 2799 2847 -0.025382 2800 2753 -1.538131 2800 2798 -1.597285 2800 2800 -30.106230 2800 2801 26.993128 2801 1695 -0.000021 2801 1696 -3.205047 2801 1697 -5.417811 2801 2751 -0.000006 2801 2752 -0.994993 2801 2753 -1.681936 2801 2796 -0.000006 2801 2797 -0.891516 2801 2798 -1.507018 2801 2799 0.000415 2801 2800 6.982097 2801 2801 11.802536 2801 2802 -0.000007 2801 2803 -0.996933 2801 2804 -1.685215 2801 2847 -0.000006 2801 2848 -0.890227 2801 2849 -1.504840 2802 1698 -0.019960 2802 2754 -0.028418 2802 2755 9.032298 2802 2756 15.268185 2802 2799 -0.112097 2802 2800 10.342836 2802 2801 17.483529 2802 2802 175.525420 2802 2803 -121.917900 2802 2804 -206.089890 2802 2805 -0.000751 2802 2850 -0.017076 2803 2756 -2.473234 2803 2801 -2.832101 2803 2803 -33.456331 2803 2804 31.800895 2804 1698 -0.000020 2804 1699 -2.884187 2804 1700 -4.875426 2804 2754 -0.000007 2804 2755 -1.115661 2804 2756 -1.885912 2804 2799 -0.000007 2804 2800 -0.996933 2804 2801 -1.685215 2804 2802 0.000459 2804 2803 7.163197 2804 2804 12.108662 2804 2805 -0.000008 2804 2806 -1.147923 2804 2807 -1.940448 2804 2850 -0.000007 2804 2851 -1.014734 2804 2852 -1.715305 2805 1701 -0.001648 2805 2757 -0.047987 2805 2758 14.508479 2805 2759 24.525133 2805 2802 -0.184903 2805 2803 15.575259 2805 2804 26.328400 2805 2805 210.680910 2805 2806 -153.128020 2805 2807 -258.847600 2805 2808 -0.000922 2805 2853 -0.039306 2806 2759 -3.972629 2806 2804 -4.264752 2806 2806 -40.153071 2806 2807 40.015170 2807 1701 -0.000017 2807 1702 -2.404773 2807 1703 -4.065028 2807 2757 -0.000009 2807 2758 -1.291764 2807 2759 -2.183598 2807 2802 -0.000008 2807 2803 -1.147923 2807 2804 -1.940448 2807 2805 0.000545 2807 2806 7.380206 2807 2807 12.475499 2807 2808 -0.000010 2807 2809 -1.344772 2807 2810 -2.273203 2807 2853 -0.000009 2807 2854 -1.186460 2807 2855 -2.005591 2808 1704 -0.001526 2808 2760 -0.154046 2808 2761 24.571690 2808 2762 41.535956 2808 2805 -0.242978 2808 2806 21.768511 2808 2807 36.797491 2808 2808 240.122120 2808 2809 -189.003000 2808 2810 -319.490440 2808 2811 -0.001121 2808 2856 -0.091497 2808 2857 2.519614 2808 2858 4.259152 2809 2762 -6.727911 2809 2807 -5.960374 2809 2809 -45.739429 2809 2810 49.546697 2809 2858 -0.689865 2810 1704 -0.000016 2810 1705 -2.112323 2810 1706 -3.570668 2810 2760 -0.000011 2810 2761 -1.484513 2810 2762 -2.509420 2810 2805 -0.000010 2810 2806 -1.344772 2810 2807 -2.273203 2810 2808 0.000619 2810 2809 7.860536 2810 2810 13.287442 2810 2811 -0.000012 2810 2812 -1.551506 2810 2813 -2.622664 2810 2856 -0.000010 2810 2857 -1.362276 2810 2858 -2.302789 2811 1707 -0.001384 2811 2763 -0.375093 2811 2764 49.880579 2811 2765 84.318130 2811 2808 -0.354729 2811 2809 31.038869 2811 2810 52.468065 2811 2811 281.898260 2811 2812 -302.958660 2811 2813 -512.121300 2811 2814 -0.354007 2811 2815 35.445146 2811 2816 59.916433 2811 2859 -0.305345 2811 2860 22.650621 2811 2861 38.288610 2812 2765 -13.657432 2812 2810 -8.498342 2812 2812 -53.561180 2812 2813 80.335994 2812 2816 -9.704780 2812 2861 -6.201579 2813 1707 -0.000014 2813 1708 -1.803479 2813 1709 -3.048600 2813 2763 -0.000013 2813 2764 -1.711591 2813 2765 -2.893273 2813 2808 -0.000012 2813 2809 -1.551506 2813 2810 -2.622664 2813 2811 0.000724 2813 2812 8.839132 2813 2813 14.941665 2813 2814 -0.000013 2813 2815 -1.718750 2813 2816 -2.905372 2813 2859 -0.000012 2813 2860 -1.626687 2813 2861 -2.749751 2814 1710 -0.001248 2814 2766 -0.163547 2814 2767 26.923069 2814 2768 45.510728 2814 2811 -0.001239 2814 2814 292.691800 2814 2815 -220.219250 2814 2816 -372.258370 2814 2817 -0.222788 2814 2818 21.807030 2814 2819 36.862603 2814 2862 -0.084129 2814 2863 0.565647 2814 2864 0.956170 2815 2768 -7.371726 2815 2815 -55.772693 2815 2816 57.627715 2815 2819 -5.970877 2815 2864 -0.154873 2816 1710 -0.000013 2816 1711 -1.731037 2816 1712 -2.926143 2816 2766 -0.000013 2816 2767 -1.748750 2816 2768 -2.956085 2816 2811 -0.000013 2816 2812 -1.718750 2816 2813 -2.905372 2816 2814 0.000748 2816 2815 8.710367 2816 2816 14.723995 2816 2817 -0.000013 2816 2818 -1.754257 2816 2819 -2.965397 2816 2862 -0.000013 2816 2863 -1.751301 2816 2864 -2.960397 2817 1713 -0.001200 2817 2769 -0.104125 2817 2770 20.234483 2817 2771 34.204370 2817 2814 -0.001215 2817 2817 292.482780 2817 2818 -206.096930 2817 2819 -348.386250 2817 2820 -0.170188 2817 2821 14.942885 2817 2822 25.259436 2817 2865 -0.001213 2818 2771 -5.540455 2818 2818 -55.761113 2818 2819 53.791450 2818 2822 -4.091520 2819 1713 -0.000013 2819 1714 -1.731841 2819 1715 -2.927504 2819 2769 -0.000012 2819 2770 -1.748755 2819 2771 -2.956095 2819 2814 -0.000013 2819 2815 -1.754257 2819 2816 -2.965397 2819 2817 0.000746 2819 2818 8.746176 2819 2819 14.784534 2819 2820 -0.000012 2819 2821 -1.753944 2819 2822 -2.964864 2819 2865 -0.000013 2819 2866 -1.751113 2819 2867 -2.960082 2820 1716 -0.011850 2820 2772 -0.087073 2820 2773 17.722819 2820 2774 29.958631 2820 2817 -0.001181 2820 2820 292.489260 2820 2821 -201.689720 2820 2822 -340.936080 2820 2823 -0.159428 2820 2824 13.042016 2820 2825 22.046224 2820 2868 -0.001179 2821 2774 -4.852811 2821 2821 -55.755356 2821 2822 52.600284 2821 2825 -3.571104 2822 1716 -0.000012 2822 1717 -1.730419 2822 1718 -2.925098 2822 2772 -0.000012 2822 2773 -1.749989 2822 2774 -2.958180 2822 2817 -0.000012 2822 2818 -1.753944 2822 2819 -2.964864 2822 2820 0.000745 2822 2821 8.745912 2822 2822 14.784082 2822 2823 -0.000012 2822 2824 -1.753781 2822 2825 -2.964591 2822 2868 -0.000012 2822 2869 -1.751516 2822 2870 -2.960761 2823 1719 -0.027058 2823 2775 -0.048589 2823 2776 12.648323 2823 2777 21.380725 2823 2820 -0.001151 2823 2823 292.398770 2823 2824 -183.518220 2823 2825 -310.219190 2824 2777 -3.463364 2824 2824 -55.751694 2824 2825 47.634733 2825 1719 -0.000012 2825 1720 -1.731666 2825 1721 -2.927208 2825 2775 -0.000012 2825 2776 -1.732292 2825 2777 -2.928266 2825 2820 -0.000012 2825 2821 -1.753781 2825 2822 -2.964591 2825 2823 0.000719 2825 2824 5.224001 2825 2825 8.830651 2826 2826 1.000000 2827 2827 1.000000 2828 2828 1.000000 2829 2829 1.000000 2830 2830 1.000000 2831 2831 1.000000 2832 2832 1.000000 2833 2833 1.000000 2834 2834 1.000000 2835 2835 1.000000 2836 2836 1.000000 2837 2837 1.000000 2838 2838 1.000000 2839 2839 1.000000 2840 2840 1.000000 2841 1737 -0.052764 2841 2793 -0.000426 2841 2841 116.940080 2841 2842 -71.513262 2841 2843 -120.886020 2841 2844 -0.000426 2841 2889 -0.042488 2841 2890 3.126292 2841 2891 5.284685 2842 2842 -22.298278 2842 2843 18.542426 2842 2891 -0.856079 2843 1737 -0.000027 2843 1738 -4.321552 2843 1739 -7.305152 2843 2793 -0.000004 2843 2794 -0.701417 2843 2795 -1.185676 2843 2841 0.000314 2843 2842 6.428423 2843 2843 10.866607 2843 2844 -0.000004 2843 2845 -0.701439 2843 2846 -1.185713 2843 2889 -0.000004 2843 2890 -0.701511 2843 2891 -1.185833 2844 1740 -0.051145 2844 2796 -0.000472 2844 2797 0.237245 2844 2798 0.401038 2844 2841 -0.014510 2844 2842 3.074341 2844 2843 5.196866 2844 2844 116.981860 2844 2845 -73.655198 2844 2846 -124.506660 2844 2847 -0.000472 2844 2892 -0.037647 2844 2893 1.974108 2844 2894 3.337031 2845 2798 -0.064964 2845 2843 -0.841845 2845 2845 -22.302114 2845 2846 19.119340 2845 2894 -0.540567 2846 1740 -0.000028 2846 1741 -4.321276 2846 1742 -7.304679 2846 2796 -0.000005 2846 2797 -0.764717 2846 2798 -1.292677 2846 2841 -0.000004 2846 2842 -0.701439 2846 2843 -1.185713 2846 2844 0.000320 2846 2845 7.256808 2846 2846 12.266901 2846 2847 -0.000005 2846 2848 -0.765451 2846 2849 -1.293918 2846 2892 -0.000004 2846 2893 -0.701420 2846 2894 -1.185679 2847 1743 -0.045466 2847 2799 -0.000565 2847 2800 1.546114 2847 2801 2.613551 2847 2844 -0.057739 2847 2845 6.099991 2847 2846 10.311418 2847 2847 140.408860 2847 2848 -91.323808 2847 2849 -154.373760 2847 2850 -0.000576 2847 2895 -0.042281 2847 2896 1.630936 2847 2897 2.756933 2848 2801 -0.423361 2848 2846 -1.670339 2848 2848 -26.766776 2848 2849 23.736591 2848 2897 -0.446587 2849 1743 -0.000024 2849 1744 -3.602770 2849 1745 -6.090122 2849 2799 -0.000006 2849 2800 -0.890227 2849 2801 -1.504840 2849 2844 -0.000005 2849 2845 -0.765451 2849 2846 -1.293918 2849 2847 0.000374 2849 2848 6.933268 2849 2849 11.719995 2849 2850 -0.000006 2849 2851 -0.906773 2849 2852 -1.532808 2849 2895 -0.000005 2849 2896 -0.765039 2849 2897 -1.293222 2850 1746 -0.029380 2850 2802 -0.000669 2850 2803 2.230659 2850 2804 3.770703 2850 2847 -0.112564 2850 2848 9.825410 2850 2849 16.608873 2850 2850 163.813100 2850 2851 -109.961840 2850 2852 -185.879390 2850 2853 -0.000691 2850 2898 -0.060381 2850 2899 2.184291 2850 2900 3.692323 2851 2804 -0.610790 2851 2849 -2.690407 2851 2851 -31.231894 2851 2852 28.617763 2851 2900 -0.598094 2852 1746 -0.000021 2852 1747 -3.090092 2852 1748 -5.223489 2852 2802 -0.000007 2852 2803 -1.014734 2852 2804 -1.715305 2852 2847 -0.000006 2852 2848 -0.906773 2852 2849 -1.532808 2852 2850 0.000431 2852 2851 6.987925 2852 2852 11.812382 2852 2853 -0.000007 2852 2854 -1.047860 2852 2855 -1.771302 2852 2898 -0.000006 2852 2899 -0.924954 2852 2900 -1.563541 2853 1749 -0.001863 2853 2805 -0.000817 2853 2806 1.776910 2853 2807 3.003689 2853 2850 -0.151719 2853 2851 13.482684 2853 2852 22.791115 2853 2853 187.243250 2853 2854 -129.245670 2853 2855 -218.476890 2853 2856 -0.000829 2853 2901 -0.094354 2853 2902 4.581557 2853 2903 7.744664 2854 2807 -0.486531 2854 2852 -3.691753 2854 2854 -35.699346 2854 2855 33.669408 2854 2903 -1.254471 2855 1749 -0.000019 2855 1750 -2.704891 2855 1751 -4.572347 2855 2805 -0.000009 2855 2806 -1.186460 2855 2807 -2.005591 2855 2850 -0.000007 2855 2851 -1.047860 2855 2852 -1.771302 2855 2853 0.000489 2855 2854 7.231765 2855 2855 12.224575 2855 2856 -0.000009 2855 2857 -1.203871 2855 2858 -2.035024 2855 2901 -0.000008 2855 2902 -1.084668 2855 2903 -1.833523 2856 1752 -0.001680 2856 2808 -0.000978 2856 2853 -0.176557 2856 2854 15.457157 2856 2855 26.128778 2856 2856 216.557680 2856 2857 -151.392050 2856 2858 -255.912970 2856 2859 -0.001023 2856 2904 -0.149658 2856 2905 9.450693 2856 2906 15.975441 2857 2855 -4.232265 2857 2857 -41.283654 2857 2858 39.447704 2857 2906 -2.587626 2858 1752 -0.000018 2858 1753 -2.340037 2858 1754 -3.955596 2858 2808 -0.000010 2858 2809 -1.362276 2858 2810 -2.302789 2858 2853 -0.000009 2858 2854 -1.203871 2858 2855 -2.035024 2858 2856 0.000563 2858 2857 7.613836 2858 2858 12.870422 2858 2859 -0.000011 2858 2860 -1.424649 2858 2861 -2.408225 2858 2904 -0.000009 2858 2905 -1.278358 2858 2906 -2.160934 2859 1755 -0.001416 2859 2811 -0.001197 2859 2856 -0.153991 2859 2857 11.298069 2859 2858 19.098244 2859 2859 263.422520 2859 2860 -192.365090 2859 2861 -325.173940 2859 2862 -0.110191 2859 2863 11.669962 2859 2864 19.726888 2859 2907 -0.230820 2859 2908 15.533079 2859 2909 26.257116 2860 2858 -3.093388 2860 2860 -50.211097 2860 2861 50.228609 2860 2864 -3.195205 2860 2909 -4.252946 2861 1755 -0.000015 2861 1756 -1.923952 2861 1757 -3.252249 2861 2811 -0.000012 2861 2812 -1.626687 2861 2813 -2.749751 2861 2856 -0.000011 2861 2857 -1.424649 2861 2858 -2.408225 2861 2859 0.000678 2861 2860 8.201110 2861 2861 13.863152 2861 2862 -0.000012 2861 2863 -1.662238 2861 2864 -2.809845 2861 2907 -0.000012 2861 2908 -1.557933 2861 2909 -2.633530 2862 1758 -0.001246 2862 2814 -0.001261 2862 2859 -0.001197 2862 2862 292.461160 2862 2863 -191.117990 2862 2864 -323.065590 2862 2865 -0.139241 2862 2866 12.739216 2862 2867 21.534371 2862 2910 -0.145309 2862 2911 7.432785 2862 2912 12.564371 2863 2863 -55.782280 2863 2864 49.636495 2863 2867 -3.488023 2863 2912 -2.035097 2864 1758 -0.000013 2864 1759 -1.730476 2864 1760 -2.925195 2864 2814 -0.000013 2864 2815 -1.751301 2864 2816 -2.960397 2864 2859 -0.000012 2864 2860 -1.662238 2864 2861 -2.809845 2864 2862 0.000749 2864 2863 8.656239 2864 2864 14.632498 2864 2865 -0.000013 2864 2866 -1.754513 2864 2867 -2.965828 2864 2910 -0.000013 2864 2911 -1.751435 2864 2912 -2.960625 2865 1761 -0.001217 2865 2817 -0.001766 2865 2818 8.486992 2865 2819 14.346412 2865 2862 -0.001234 2865 2865 292.366410 2865 2866 -188.081950 2865 2867 -317.933730 2865 2868 -0.089048 2865 2869 8.645098 2865 2870 14.613665 2865 2913 -0.049930 2866 2819 -2.323782 2866 2866 -55.776604 2866 2867 48.820171 2866 2870 -2.367073 2867 1761 -0.000013 2867 1762 -1.729695 2867 1763 -2.923877 2867 2817 -0.000013 2867 2818 -1.751113 2867 2819 -2.960082 2867 2862 -0.000013 2867 2863 -1.754513 2867 2864 -2.965828 2867 2865 0.000748 2867 2866 8.747352 2867 2867 14.786522 2867 2868 -0.000013 2867 2869 -1.754465 2867 2870 -2.965746 2867 2913 -0.000013 2867 2914 -1.751292 2867 2915 -2.960384 2868 1764 -0.011707 2868 2820 -0.082800 2868 2821 14.779875 2868 2822 24.983885 2868 2865 -0.001215 2868 2868 292.307290 2868 2869 -185.722040 2868 2870 -313.944340 2868 2916 -0.017816 2869 2822 -4.046886 2869 2869 -55.771995 2869 2870 48.186100 2870 1764 -0.000013 2870 1765 -1.730274 2870 1766 -2.924854 2870 2820 -0.000012 2870 2821 -1.751516 2870 2822 -2.960761 2870 2865 -0.000013 2870 2866 -1.754465 2870 2867 -2.965746 2870 2868 0.000734 2870 2869 6.994246 2870 2870 11.823066 2870 2916 -0.000013 2870 2917 -1.751719 2870 2918 -2.961104 2871 2871 1.000000 2872 2872 1.000000 2873 2873 1.000000 2874 2874 1.000000 2875 2875 1.000000 2876 2876 1.000000 2877 2877 1.000000 2878 2878 1.000000 2879 2879 1.000000 2880 2880 1.000000 2881 2881 1.000000 2882 2882 1.000000 2883 2883 1.000000 2884 2884 1.000000 2885 2885 1.000000 2886 1782 -0.052840 2886 2886 122.763670 2886 2887 -74.141000 2886 2888 -125.327870 2886 2889 -0.000421 2886 2934 -0.015280 2886 2935 2.330081 2886 2936 3.938766 2887 2887 -23.407988 2887 2888 19.223281 2887 2936 -0.638063 2888 1782 -0.000025 2888 1783 -4.116348 2888 1784 -6.958270 2888 2886 0.000322 2888 2887 5.622511 2888 2888 9.504287 2888 2889 -0.000004 2888 2890 -0.717922 2888 2891 -1.213575 2888 2934 -0.000005 2888 2935 -0.785615 2888 2936 -1.328003 2889 1785 -0.052962 2889 2841 -0.000419 2889 2886 -0.012451 2889 2887 3.407376 2889 2888 5.759824 2889 2889 116.963480 2889 2890 -74.727793 2889 2891 -126.319860 2889 2892 -0.000418 2889 2937 -0.039294 2889 2938 2.937664 2889 2939 4.965826 2890 2888 -0.933059 2890 2890 -22.297929 2890 2891 19.423783 2890 2939 -0.804434 2891 1785 -0.000027 2891 1786 -4.323953 2891 1787 -7.309211 2891 2841 -0.000004 2891 2842 -0.701511 2891 2843 -1.185833 2891 2886 -0.000004 2891 2887 -0.717922 2891 2888 -1.213575 2891 2889 0.000318 2891 2890 7.165543 2891 2891 12.112634 2891 2892 -0.000004 2891 2893 -0.701183 2891 2894 -1.185280 2891 2937 -0.000004 2891 2938 -0.718470 2891 2939 -1.214502 2892 1788 -0.052331 2892 2844 -0.000428 2892 2889 -0.019336 2892 2890 4.224428 2892 2891 7.140973 2892 2892 116.985380 2892 2893 -75.477566 2892 2894 -127.587220 2892 2895 -0.000428 2892 2940 -0.039897 2892 2941 2.871332 2892 2942 4.853698 2893 2891 -1.156784 2893 2893 -22.303262 2893 2894 19.615711 2893 2942 -0.786260 2894 1788 -0.000028 2894 1789 -4.320322 2894 1790 -7.303069 2894 2844 -0.000004 2894 2845 -0.701420 2894 2846 -1.185679 2894 2889 -0.000004 2894 2890 -0.701183 2894 2891 -1.185280 2894 2892 0.000319 2894 2893 7.128685 2894 2894 12.050324 2894 2895 -0.000004 2894 2896 -0.701681 2894 2897 -1.186120 2894 2940 -0.000004 2894 2941 -0.701573 2894 2942 -1.185939 2895 1791 -0.049201 2895 2847 -0.000482 2895 2892 -0.051813 2895 2893 6.070538 2895 2894 10.261632 2895 2895 117.022330 2895 2896 -77.644013 2895 2897 -131.249440 2895 2898 -0.000491 2895 2943 -0.046668 2895 2944 3.198839 2895 2945 5.407317 2896 2894 -1.662285 2896 2896 -22.307808 2896 2897 20.197250 2896 2945 -0.875924 2897 1791 -0.000028 2897 1792 -4.320544 2897 1793 -7.303447 2897 2847 -0.000005 2897 2848 -0.765039 2897 2849 -1.293222 2897 2892 -0.000004 2897 2893 -0.701681 2897 2894 -1.186120 2897 2895 0.000321 2897 2896 7.271184 2897 2897 12.291208 2897 2898 -0.000005 2897 2899 -0.779764 2897 2900 -1.318112 2897 2943 -0.000005 2897 2944 -0.701649 2897 2945 -1.186068 2898 1794 -0.040000 2898 2850 -0.000605 2898 2895 -0.088995 2898 2896 8.269744 2898 2897 13.979175 2898 2898 146.285930 2898 2899 -98.102872 2898 2900 -165.832990 2898 2901 -0.000626 2898 2946 -0.086061 2898 2947 4.349211 2898 2948 7.351902 2899 2897 -2.264444 2899 2899 -27.889063 2899 2900 25.522133 2899 2948 -1.190898 2900 1794 -0.000024 2900 1795 -3.463996 2900 1796 -5.855535 2900 2850 -0.000006 2900 2851 -0.924954 2900 2852 -1.563541 2900 2895 -0.000005 2900 2896 -0.779764 2900 2897 -1.318112 2900 2898 0.000389 2900 2899 6.948916 2900 2900 11.746441 2900 2901 -0.000007 2900 2902 -0.956926 2900 2903 -1.617587 2900 2946 -0.000005 2900 2947 -0.820139 2900 2948 -1.386363 2901 1797 -0.019987 2901 2853 -0.000737 2901 2898 -0.117784 2901 2899 10.529944 2901 2900 17.799806 2901 2901 175.551540 2901 2902 -119.782820 2901 2903 -202.480880 2901 2904 -0.000780 2901 2949 -0.112524 2901 2950 6.682387 2901 2951 11.295907 2902 2900 -2.883266 2902 2902 -33.471603 2902 2903 31.177756 2902 2951 -1.829725 2903 1797 -0.000021 2903 1798 -2.885504 2903 1799 -4.877655 2903 2853 -0.000008 2903 2854 -1.084668 2903 2855 -1.833523 2903 2898 -0.000007 2903 2899 -0.956926 2903 2900 -1.617587 2903 2901 0.000460 2903 2902 7.092170 2903 2903 11.988602 2903 2904 -0.000008 2903 2905 -1.148179 2903 2906 -1.940881 2903 2949 -0.000007 2903 2950 -1.013127 2903 2951 -1.712590 2904 1800 -0.001686 2904 2856 -0.000896 2904 2901 -0.133850 2904 2902 11.103122 2904 2903 18.768717 2904 2904 210.651740 2904 2905 -144.066010 2904 2906 -243.529010 2904 2907 -0.000974 2904 2952 -0.154186 2904 2953 9.863041 2904 2954 16.672475 2905 2903 -3.040134 2905 2905 -40.169576 2905 2906 37.492727 2905 2954 -2.700578 2906 1800 -0.000018 2906 1801 -2.404928 2906 1802 -4.065287 2906 2856 -0.000009 2906 2857 -1.278358 2906 2858 -2.160934 2906 2901 -0.000008 2906 2902 -1.148179 2906 2903 -1.940881 2906 2904 0.000546 2906 2905 7.450284 2906 2906 12.593953 2906 2907 -0.000010 2906 2908 -1.389370 2906 2909 -2.348590 2906 2952 -0.000009 2906 2953 -1.224929 2906 2954 -2.070619 2907 1803 -0.001404 2907 2859 -0.001111 2907 2904 -0.106975 2907 2905 7.437077 2907 2906 12.571626 2907 2907 257.396410 2907 2908 -171.361080 2907 2909 -289.668760 2907 2910 -0.001779 2907 2911 2.125165 2907 2912 3.592377 2907 2955 -0.188991 2907 2956 11.347922 2907 2957 19.182526 2908 2906 -2.036292 2908 2908 -49.096209 2908 2909 44.531218 2908 2912 -0.581870 2908 2957 -3.107108 2909 1803 -0.000015 2909 1804 -1.968134 2909 1805 -3.326934 2909 2859 -0.000012 2909 2860 -1.557933 2909 2861 -2.633530 2909 2904 -0.000010 2909 2905 -1.389370 2909 2906 -2.348590 2909 2907 0.000661 2909 2908 8.068391 2909 2909 13.638805 2909 2910 -0.000012 2909 2911 -1.642573 2909 2912 -2.776604 2909 2955 -0.000011 2909 2956 -1.504854 2909 2957 -2.543806 2910 1806 -0.001230 2910 2862 -0.001245 2910 2907 -0.001167 2910 2910 292.357580 2910 2911 -183.392210 2910 2912 -310.005990 2910 2913 -0.043703 2910 2914 4.180308 2910 2915 7.066393 2910 2958 -0.161869 2910 2959 8.223601 2910 2960 13.901166 2911 2911 -55.787051 2911 2912 47.510016 2911 2915 -1.144575 2911 2960 -2.251647 2912 1806 -0.000013 2912 1807 -1.731237 2912 1808 -2.926480 2912 2862 -0.000013 2912 2863 -1.751435 2912 2864 -2.960625 2912 2907 -0.000012 2912 2908 -1.642573 2912 2909 -2.776604 2912 2910 0.000748 2912 2911 8.637157 2912 2912 14.600243 2912 2913 -0.000013 2912 2914 -1.754617 2912 2915 -2.966005 2912 2958 -0.000013 2912 2959 -1.751017 2912 2960 -2.959917 2913 1809 -0.006031 2913 2865 -0.001235 2913 2866 1.110960 2913 2867 1.877967 2913 2910 -0.001237 2913 2913 292.296900 2913 2914 -176.690160 2913 2915 -298.677050 2913 2916 -0.056888 2913 2917 4.634097 2913 2918 7.833474 2914 2867 -0.304183 2914 2914 -55.784865 2914 2915 45.680730 2914 2918 -1.268831 2915 1809 -0.000013 2915 1810 -1.732066 2915 1811 -2.927885 2915 2865 -0.000013 2915 2866 -1.751292 2915 2867 -2.960384 2915 2910 -0.000013 2915 2911 -1.754617 2915 2912 -2.966005 2915 2913 0.000735 2915 2914 6.998827 2915 2915 11.830815 2915 2916 -0.000013 2915 2917 -1.754575 2915 2918 -2.965931 2916 1812 -0.017019 2916 2868 -0.001224 2916 2869 5.115950 2916 2870 8.647996 2916 2913 -0.001226 2916 2916 292.278220 2916 2917 -176.058170 2916 2918 -297.608570 2917 2870 -1.400774 2917 2917 -55.783494 2917 2918 45.511484 2918 1812 -0.000013 2918 1813 -1.730493 2918 1814 -2.925224 2918 2868 -0.000013 2918 2869 -1.751719 2918 2870 -2.961104 2918 2913 -0.000013 2918 2914 -1.754575 2918 2915 -2.965931 2918 2916 0.000722 2918 2917 5.243063 2918 2918 8.862868 2919 2919 1.000000 2920 2920 1.000000 2921 2921 1.000000 2922 2922 1.000000 2923 2923 1.000000 2924 2924 1.000000 2925 2925 1.000000 2926 2926 1.000000 2927 2927 1.000000 2928 2928 1.000000 2929 2929 1.000000 2930 2930 1.000000 2931 2931 1.000000 2932 2932 1.000000 2933 2933 1.000000 2934 1830 -0.052524 2934 2886 -0.000455 2934 2934 140.304940 2934 2935 -85.988916 2934 2936 -145.355580 2934 2937 -0.014952 2934 2982 -0.025936 2934 2983 3.918270 2934 2984 6.623438 2935 2935 -26.749432 2935 2936 22.319922 2935 2984 -1.072978 2936 1830 -0.000022 2936 1831 -3.609268 2936 1832 -6.101103 2936 2886 -0.000005 2936 2887 -0.785615 2936 2888 -1.328003 2936 2934 0.000365 2936 2935 6.072683 2936 2936 10.265257 2936 2937 -0.000005 2936 2938 -0.784093 2936 2939 -1.325430 2936 2982 -0.000005 2936 2983 -0.890706 2936 2984 -1.505649 2937 1833 -0.052799 2937 2889 -0.000422 2937 2934 -0.000461 2937 2935 2.840873 2937 2936 4.802209 2937 2937 122.819040 2937 2938 -77.998744 2937 2939 -131.849080 2937 2940 -0.000422 2937 2985 -0.014222 2937 2986 3.360142 2937 2987 5.679985 2938 2936 -0.777936 2938 2938 -23.412403 2938 2939 20.268814 2938 2987 -0.920133 2939 1833 -0.000025 2939 1834 -4.120276 2939 1835 -6.964914 2939 2889 -0.000004 2939 2890 -0.718470 2939 2891 -1.214502 2939 2934 -0.000005 2939 2935 -0.784093 2939 2936 -1.325430 2939 2937 0.000331 2939 2938 7.129016 2939 2939 12.050888 2939 2940 -0.000004 2939 2941 -0.718184 2939 2942 -1.214018 2939 2985 -0.000005 2939 2986 -0.785365 2939 2987 -1.327581 2940 1836 -0.052786 2940 2892 -0.000422 2940 2937 -0.018239 2940 2938 4.323829 2940 2939 7.309001 2940 2940 116.981090 2940 2941 -75.997533 2940 2942 -128.466150 2940 2943 -0.000422 2940 2988 -0.023639 2940 2989 3.298516 2940 2990 5.575808 2941 2939 -1.184015 2941 2941 -22.303045 2941 2942 19.758867 2941 2990 -0.903246 2942 1836 -0.000027 2942 1837 -4.321090 2942 1838 -7.304366 2942 2892 -0.000004 2942 2893 -0.701573 2942 2894 -1.185939 2942 2937 -0.000004 2942 2938 -0.718184 2942 2939 -1.214018 2942 2940 0.000318 2942 2941 7.146204 2942 2942 12.079937 2942 2943 -0.000004 2942 2944 -0.701387 2942 2945 -1.185624 2942 2988 -0.000004 2942 2989 -0.701464 2942 2990 -1.185754 2943 1839 -0.051639 2943 2895 -0.000435 2943 2940 -0.045028 2943 2941 5.740741 2943 2942 9.704143 2943 2943 116.993330 2943 2944 -77.946499 2943 2945 -131.760760 2943 2946 -0.000455 2943 2991 -0.042629 2943 2992 3.815696 2943 2993 6.450052 2944 2942 -1.571992 2944 2944 -22.307860 2944 2945 20.280237 2944 2993 -1.044849 2945 1839 -0.000028 2945 1840 -4.322044 2945 1841 -7.305982 2945 2895 -0.000005 2945 2896 -0.701649 2945 2897 -1.186068 2945 2940 -0.000004 2945 2941 -0.701387 2945 2942 -1.185624 2945 2943 0.000320 2945 2944 7.164206 2945 2945 12.110372 2945 2946 -0.000005 2945 2947 -0.734913 2945 2948 -1.242296 2945 2991 -0.000004 2945 2992 -0.701705 2945 2993 -1.186162 2946 1842 -0.047034 2946 2898 -0.000526 2946 2943 -0.055637 2946 2944 7.246957 2946 2945 12.250255 2946 2946 128.759700 2946 2947 -87.385812 2946 2948 -147.716890 2946 2949 -0.000555 2946 2994 -0.066907 2946 2995 4.929220 2946 2996 8.332348 2947 2945 -1.984403 2947 2947 -24.545170 2947 2948 22.741959 2947 2996 -1.349736 2948 1842 -0.000026 2948 1843 -3.929329 2948 1844 -6.642133 2948 2898 -0.000005 2948 2899 -0.820139 2948 2900 -1.386363 2948 2943 -0.000005 2948 2944 -0.734913 2948 2945 -1.242296 2948 2946 0.000348 2948 2947 7.105568 2948 2948 12.011246 2948 2949 -0.000006 2948 2950 -0.864518 2948 2951 -1.461380 2948 2994 -0.000005 2948 2995 -0.753908 2948 2996 -1.274405 2949 1845 -0.037777 2949 2901 -0.000673 2949 2946 -0.101106 2949 2947 8.395032 2949 2948 14.190954 2949 2949 163.855520 2949 2950 -111.190550 2949 2951 -187.956510 2949 2952 -0.000716 2949 2997 -0.136190 2949 2998 7.039553 2949 2999 11.899659 2950 2948 -2.298722 2950 2950 -31.242159 2950 2951 28.928800 2950 2999 -1.927556 2951 1845 -0.000022 2951 1846 -3.100324 2951 1847 -5.240788 2951 2901 -0.000007 2951 2902 -1.013127 2951 2903 -1.712590 2951 2946 -0.000006 2951 2947 -0.864518 2951 2948 -1.461380 2951 2949 0.000431 2951 2950 7.003183 2951 2951 11.838180 2951 2952 -0.000007 2951 2953 -1.077522 2951 2954 -1.821443 2951 2997 -0.000006 2951 2998 -0.944176 2951 2999 -1.596036 2952 1848 -0.024271 2952 2904 -0.000836 2952 2949 -0.109652 2952 2950 8.850513 2952 2951 14.960908 2952 2952 198.950030 2952 2953 -134.665010 2952 2954 -227.637610 2952 2955 -0.000900 2952 3000 -0.150164 2952 3001 9.552097 2952 3002 16.146856 2953 2951 -2.423387 2953 2953 -37.939422 2953 2954 35.024388 2953 3002 -2.615488 2954 1848 -0.000018 2954 1849 -2.546503 2954 1850 -4.304606 2954 2904 -0.000009 2954 2905 -1.224929 2954 2906 -2.070619 2954 2949 -0.000007 2954 2950 -1.077522 2954 2951 -1.821443 2954 2952 0.000517 2954 2953 7.360557 2954 2954 12.442280 2954 2955 -0.000009 2954 2956 -1.318588 2954 2957 -2.228939 2954 3000 -0.000008 2954 3001 -1.188745 2954 3002 -2.009454 2955 1851 -0.015525 2955 2907 -0.001048 2955 2952 -0.101891 2955 2953 7.731886 2955 2954 13.069973 2955 2955 245.685780 2955 2956 -158.573580 2955 2957 -268.052780 2955 2958 -0.001115 2955 3003 -0.141279 2955 3004 7.208432 2955 3005 12.185133 2956 2954 -2.117051 2956 2956 -46.867737 2956 2957 41.131714 2956 3005 -1.973721 2957 1851 -0.000015 2957 1852 -2.061775 2957 1853 -3.485225 2957 2907 -0.000011 2957 2908 -1.504854 2957 2909 -2.543806 2957 2952 -0.000009 2957 2953 -1.318588 2957 2954 -2.228939 2957 2955 0.000632 2957 2956 7.945251 2957 2957 13.430650 2957 2958 -0.000012 2957 2959 -1.601982 2957 2960 -2.707990 2957 3003 -0.000010 2957 3004 -1.452776 2957 3005 -2.455772 2958 1854 -0.019986 2958 2910 -0.001225 2958 2955 -0.053627 2958 2956 2.484269 2958 2957 4.199408 2958 2958 292.357990 2958 2959 -179.346790 2958 2960 -303.167610 2958 3006 -0.140855 2958 3007 5.871554 2958 3008 9.925269 2959 2957 -0.680203 2959 2959 -55.792557 2959 2960 46.389658 2959 3008 -1.607663 2960 1854 -0.000013 2960 1855 -1.731620 2960 1856 -2.927129 2960 2910 -0.000013 2960 2911 -1.751017 2960 2912 -2.959917 2960 2955 -0.000012 2960 2956 -1.601982 2960 2957 -2.707990 2960 2958 0.000734 2960 2959 6.824196 2960 2960 11.535616 2960 3006 -0.000013 2960 3007 -1.733297 2960 3008 -2.929964 2961 2961 1.000000 2962 2962 1.000000 2963 2963 1.000000 2964 2964 1.000000 2965 2965 1.000000 2966 2966 1.000000 2967 2967 1.000000 2968 2968 1.000000 2969 2969 1.000000 2970 2970 1.000000 2971 2971 1.000000 2972 2972 1.000000 2973 2973 1.000000 2974 2974 1.000000 2975 2975 1.000000 2976 2976 1.000000 2977 2977 1.000000 2978 2978 1.000000 2979 1875 -0.051616 2979 2979 175.379410 2979 2980 -104.056960 2979 2981 -175.897890 2979 2982 -0.010040 2979 3027 -0.000591 2979 3028 1.476702 2979 3029 2.496218 2980 2980 -33.424919 2980 2981 26.990414 2980 3029 -0.404384 2981 1875 -0.000017 2981 1876 -2.883379 2981 1877 -4.874064 2981 2979 0.000439 2981 2980 4.933650 2981 2981 8.339842 2981 2982 -0.000006 2981 2983 -0.994955 2981 2984 -1.681872 2981 3027 -0.000006 2981 3028 -1.051570 2981 3029 -1.777574 2982 1878 -0.052015 2982 2934 -0.000507 2982 2979 -0.000566 2982 2980 3.044582 2982 2981 5.146561 2982 2982 157.872980 2982 2983 -98.166516 2982 2984 -165.940560 2982 2985 -0.007157 2982 3030 -0.000567 2982 3031 2.800946 2982 3032 4.734716 2983 2981 -0.833734 2983 2983 -30.088923 2983 2984 25.511811 2983 3032 -0.767016 2984 1878 -0.000019 2984 1879 -3.208021 2984 1880 -5.422834 2984 2934 -0.000005 2984 2935 -0.890706 2984 2936 -1.505649 2984 2979 -0.000006 2984 2980 -0.994955 2984 2981 -1.681872 2984 2982 0.000411 2984 2983 6.982558 2984 2984 11.803310 2984 2985 -0.000005 2984 2986 -0.889449 2984 2987 -1.503523 2984 3030 -0.000006 2984 3031 -0.996054 2984 3032 -1.683728 2985 1881 -0.052447 2985 2937 -0.000454 2985 2982 -0.000514 2985 2983 3.329718 2985 2984 5.628552 2985 2985 140.315040 2985 2986 -88.453895 2985 2987 -149.522460 2985 2988 -0.000441 2985 3033 -0.013011 2985 3034 3.064588 2985 3035 5.180379 2986 2984 -0.911810 2986 2986 -26.752309 2986 2987 22.987933 2986 3035 -0.839206 2987 1881 -0.000022 2987 1882 -3.607311 2987 1883 -6.097798 2987 2937 -0.000005 2987 2938 -0.785365 2987 2939 -1.327581 2987 2982 -0.000005 2987 2983 -0.889449 2987 2984 -1.503523 2987 2985 0.000370 2987 2986 6.907690 2987 2987 11.676758 2987 2988 -0.000005 2987 2989 -0.763978 2987 2990 -1.291428 2987 3033 -0.000005 2987 3034 -0.858586 2987 3035 -1.451353 2988 1884 -0.052925 2988 2940 -0.000414 2988 2985 -0.007492 2988 2986 4.275631 2988 2987 7.227526 2988 2988 116.949170 2988 2989 -75.896088 2988 2990 -128.294650 2988 2991 -0.000414 2988 3036 -0.017678 2988 3037 3.231911 2988 3038 5.463220 2989 2987 -1.170828 2989 2989 -22.299969 2989 2990 19.738918 2989 3038 -0.885016 2990 1884 -0.000027 2990 1885 -4.327036 2990 1886 -7.314416 2990 2940 -0.000004 2990 2941 -0.701464 2990 2942 -1.185754 2990 2985 -0.000005 2990 2986 -0.763978 2990 2987 -1.291428 2990 2988 0.000318 2990 2989 7.213790 2990 2990 12.194183 2990 2991 -0.000004 2990 2992 -0.700525 2990 2993 -1.184166 2990 3036 -0.000004 2990 3037 -0.718283 2990 3038 -1.214186 2991 1887 -0.052635 2991 2943 -0.000426 2991 2988 -0.026024 2991 2989 5.218415 2991 2990 8.821202 2991 2991 116.969630 2991 2992 -77.511946 2991 2993 -131.026190 2991 2994 -0.000436 2991 3039 -0.029847 2991 3040 3.909314 2991 3041 6.608305 2992 2990 -1.428979 2992 2992 -22.306268 2992 2993 20.165486 2992 3041 -1.070498 2993 1887 -0.000027 2993 1888 -4.327819 2993 1889 -7.315746 2993 2943 -0.000004 2993 2944 -0.701705 2993 2945 -1.186162 2993 2988 -0.000004 2993 2989 -0.700525 2993 2990 -1.184166 2993 2991 0.000319 2993 2992 7.151861 2993 2993 12.089506 2993 2994 -0.000005 2993 2995 -0.717940 2993 2996 -1.213607 2993 3039 -0.000004 2993 3040 -0.701364 2993 3041 -1.185587 2994 1890 -0.050597 2994 2946 -0.000473 2994 2991 -0.034251 2994 2992 6.289234 2994 2993 10.631321 2994 2994 122.846130 2994 2995 -83.034678 2994 2996 -140.361740 2994 2997 -0.000511 2994 3042 -0.043417 2994 3043 4.938726 2994 3044 8.348418 2995 2993 -1.722176 2995 2995 -23.428959 2995 2996 21.606154 2995 3044 -1.352361 2996 1890 -0.000027 2996 1891 -4.118346 2996 1892 -6.961649 2996 2946 -0.000005 2996 2947 -0.753908 2996 2948 -1.274405 2996 2991 -0.000005 2996 2992 -0.717940 2996 2993 -1.213607 2996 2994 0.000334 2996 2995 7.144039 2996 2996 12.076278 2996 2997 -0.000005 2996 2998 -0.814435 2996 2999 -1.376720 2996 3042 -0.000005 2996 3043 -0.736774 2996 3044 -1.245443 2997 1893 -0.045817 2997 2949 -0.000611 2997 2994 -0.050044 2997 2995 7.160969 2997 2996 12.104894 2997 2997 152.200950 2997 2998 -103.068430 2997 2999 -174.226880 2997 3000 -0.000668 2997 3045 -0.072043 2997 3046 7.035841 2997 3047 11.893386 2998 2996 -1.960842 2998 2998 -29.014860 2998 2999 26.803302 2998 3047 -1.926574 2999 1893 -0.000022 2999 1894 -3.327678 2999 1895 -5.625107 2999 2949 -0.000006 2999 2950 -0.944176 2999 2951 -1.596036 2999 2994 -0.000005 2999 2995 -0.814435 2999 2996 -1.376720 2999 2997 0.000403 2999 2998 7.034397 2999 2999 11.890944 2999 3000 -0.000007 2999 3001 -1.033222 2999 3002 -1.746558 2999 3045 -0.000006 2999 3046 -0.911620 2999 3047 -1.541002 3000 1896 -0.039785 3000 2952 -0.000790 3000 2997 -0.123653 3000 2998 7.887425 3000 2999 13.332903 3000 3000 198.981280 3000 3001 -136.765470 3000 3002 -231.188230 3000 3003 -0.000867 3000 3048 -0.215836 3000 3049 12.586195 3000 3050 21.275686 3001 2999 -2.159719 3001 3001 -37.941031 3001 3002 35.596443 3001 3050 -3.446350 3002 1896 -0.000018 3002 1897 -2.555645 3002 1898 -4.320061 3002 2952 -0.000008 3002 2953 -1.188745 3002 2954 -2.009454 3002 2997 -0.000007 3002 2998 -1.033222 3002 2999 -1.746558 3002 3000 0.000515 3002 3001 7.274993 3002 3002 12.297642 3002 3003 -0.000009 3002 3004 -1.304463 3002 3005 -2.205063 3002 3048 -0.000008 3002 3049 -1.188647 3002 3050 -2.009287 3003 1899 -0.032199 3003 2955 -0.000995 3003 3000 -0.138717 3003 3001 11.658090 3003 3002 19.706825 3003 3003 239.812300 3003 3004 -151.846150 3003 3005 -256.680730 3003 3006 -0.001073 3004 3002 -3.192137 3004 3004 -45.756514 3004 3005 39.333292 3005 1899 -0.000015 3005 1900 -2.113221 3005 1901 -3.572189 3005 2955 -0.000010 3005 2956 -1.452776 3005 2957 -2.455772 3005 3000 -0.000009 3005 3001 -1.304463 3005 3002 -2.205063 3005 3003 0.000607 3005 3004 6.442203 3005 3005 10.889900 3005 3006 -0.000011 3005 3007 -1.566592 3005 3008 -2.648166 3006 1902 -0.031922 3006 2958 -0.001199 3006 3003 -0.077473 3006 3004 4.895659 3006 3005 8.275621 3006 3006 286.484620 3006 3007 -172.456830 3006 3008 -291.520850 3007 3005 -1.340467 3007 3007 -54.683742 3007 3008 44.540689 3008 1902 -0.000013 3008 1903 -1.767325 3008 1904 -2.987485 3008 2958 -0.000013 3008 2959 -1.733297 3008 2960 -2.929964 3008 3003 -0.000011 3008 3004 -1.566592 3008 3005 -2.648166 3008 3006 0.000707 3008 3007 5.073372 3008 3008 8.576024 3009 3009 1.000000 3010 3010 1.000000 3011 3011 1.000000 3012 3012 1.000000 3013 3013 1.000000 3014 3014 1.000000 3015 3015 1.000000 3016 3016 1.000000 3017 3017 1.000000 3018 3018 1.000000 3019 3019 1.000000 3020 3020 1.000000 3021 3021 1.000000 3022 3022 1.000000 3023 3023 1.000000 3024 3024 1.000000 3025 3025 1.000000 3026 3026 1.000000 3027 1923 -0.051506 3027 2979 -0.006156 3027 3027 175.387120 3027 3028 -104.234320 3027 3029 -176.197690 3027 3030 -0.008636 3027 3075 -0.000588 3027 3076 1.645896 3027 3077 2.782222 3028 3028 -33.421480 3028 3029 27.047472 3028 3077 -0.450718 3029 1923 -0.000017 3029 1924 -2.881140 3029 1925 -4.870280 3029 2979 -0.000006 3029 2980 -1.051570 3029 2981 -1.777574 3029 3027 0.000446 3029 3028 6.038001 3029 3029 10.206637 3029 3030 -0.000006 3029 3031 -1.049945 3029 3032 -1.774827 3029 3075 -0.000006 3029 3076 -1.051602 3029 3077 -1.777628 3030 1926 -0.051856 3030 2982 -0.007689 3030 3027 -0.000591 3030 3028 1.734777 3030 3029 2.932467 3030 3030 175.382140 3030 3031 -106.645850 3030 3032 -180.274020 3030 3033 -0.028402 3030 3078 -0.008770 3030 3079 2.323025 3030 3080 3.926838 3031 3029 -0.475056 3031 3031 -33.425726 3031 3032 27.697435 3031 3080 -0.636144 3032 1926 -0.000017 3032 1927 -2.888000 3032 1928 -4.881872 3032 2982 -0.000006 3032 2983 -0.996054 3032 2984 -1.683728 3032 3027 -0.000006 3032 3028 -1.049945 3032 3029 -1.774827 3032 3030 0.000451 3032 3031 6.943351 3032 3032 11.737033 3032 3033 -0.000006 3032 3034 -0.953881 3032 3035 -1.612439 3032 3078 -0.000006 3032 3079 -1.051725 3032 3080 -1.777834 3033 1929 -0.052252 3033 2985 -0.000489 3033 3030 -0.000543 3033 3031 2.848468 3033 3032 4.815047 3033 3033 146.177530 3033 3034 -90.982103 3033 3035 -153.796150 3033 3036 -0.000640 3033 3081 -0.006010 3033 3082 2.651522 3033 3083 4.482132 3034 3032 -0.780029 3034 3034 -27.862876 3034 3035 23.639133 3034 3083 -0.726097 3035 1929 -0.000021 3035 1930 -3.463328 3035 1931 -5.854410 3035 2985 -0.000005 3035 2986 -0.858586 3035 2987 -1.451353 3035 3030 -0.000006 3035 3031 -0.953881 3035 3032 -1.612439 3035 3033 0.000383 3035 3034 6.954253 3035 3035 11.755468 3035 3036 -0.000005 3035 3037 -0.798951 3035 3038 -1.350547 3035 3081 -0.000005 3035 3082 -0.876382 3035 3083 -1.481436 3036 1932 -0.052868 3036 2988 -0.000417 3036 3033 -0.000463 3036 3034 3.728140 3036 3035 6.302048 3036 3036 122.779940 3036 3037 -78.539113 3036 3038 -132.762450 3036 3039 -0.000416 3036 3084 -0.009392 3036 3085 3.008693 3036 3086 5.085891 3037 3035 -1.020913 3037 3037 -23.411151 3037 3038 20.420065 3037 3086 -0.823899 3038 1932 -0.000025 3038 1933 -4.124800 3038 1934 -6.972558 3038 2988 -0.000004 3038 2989 -0.718283 3038 2990 -1.214186 3038 3033 -0.000005 3038 3034 -0.798951 3038 3035 -1.350547 3038 3036 0.000330 3038 3037 7.097995 3038 3038 11.998445 3038 3039 -0.000004 3038 3040 -0.717180 3038 3041 -1.212320 3038 3084 -0.000004 3038 3085 -0.736153 3038 3086 -1.244392 3039 1935 -0.052990 3039 2991 -0.000417 3039 3036 -0.013775 3039 3037 4.571886 3039 3038 7.728312 3039 3039 116.948740 3039 3040 -76.761331 3039 3041 -129.757350 3039 3042 -0.000427 3039 3087 -0.018424 3039 3088 3.797739 3039 3089 6.419699 3040 3038 -1.251951 3040 3040 -22.302868 3040 3041 19.968614 3040 3089 -1.039959 3041 1935 -0.000027 3041 1936 -4.332423 3041 1937 -7.323529 3041 2991 -0.000004 3041 2992 -0.701364 3041 2993 -1.185587 3041 3036 -0.000004 3041 3037 -0.717180 3041 3038 -1.212320 3041 3039 0.000318 3041 3040 7.172015 3041 3041 12.123573 3041 3042 -0.000004 3041 3043 -0.717473 3041 3044 -1.212817 3041 3087 -0.000004 3041 3088 -0.701068 3041 3089 -1.185086 3042 1938 -0.052052 3042 2994 -0.000451 3042 3039 -0.022481 3042 3040 5.474747 3042 3041 9.254513 3042 3042 122.810080 3042 3043 -82.076518 3042 3044 -138.742050 3042 3045 -0.000498 3042 3090 -0.034770 3042 3091 4.795548 3042 3092 8.106390 3043 3041 -1.499165 3043 3043 -23.425410 3043 3044 21.352934 3043 3092 -1.313175 3044 1938 -0.000026 3044 1939 -4.122364 3044 1940 -6.968440 3044 2994 -0.000005 3044 2995 -0.736774 3044 2996 -1.245443 3044 3039 -0.000004 3044 3040 -0.717473 3044 3041 -1.212817 3044 3042 0.000333 3044 3043 7.129001 3044 3044 12.050855 3044 3045 -0.000005 3044 3046 -0.814188 3044 3047 -1.376303 3044 3090 -0.000005 3044 3091 -0.735566 3044 3092 -1.243400 3045 1941 -0.049918 3045 2997 -0.000574 3045 3042 -0.033660 3045 3043 6.332380 3045 3044 10.704248 3045 3045 152.034910 3045 3046 -99.703530 3045 3047 -168.538850 3045 3048 -0.000650 3045 3093 -0.005821 3045 3094 4.466525 3045 3095 7.550213 3046 3044 -1.733981 3046 3046 -29.011120 3046 3047 25.891734 3046 3095 -1.223051 3047 1941 -0.000022 3047 1942 -3.334240 3047 1943 -5.636199 3047 2997 -0.000006 3047 2998 -0.911620 3047 2999 -1.541002 3047 3042 -0.000005 3047 3043 -0.814188 3047 3044 -1.376303 3047 3045 0.000401 3047 3046 7.007365 3047 3047 11.845249 3047 3048 -0.000007 3047 3049 -1.032927 3047 3050 -1.746060 3047 3093 -0.000006 3047 3094 -0.911125 3047 3095 -1.540166 3048 1944 -0.047987 3048 3000 -0.000761 3048 3045 -0.017674 3048 3046 4.919676 3048 3047 8.316221 3048 3048 198.903700 3048 3049 -127.310250 3048 3050 -215.205070 3048 3096 -0.008591 3048 3097 6.176205 3048 3098 10.440251 3049 3047 -1.347120 3049 3049 -37.945497 3049 3050 32.997687 3049 3098 -1.691188 3050 1944 -0.000017 3050 1945 -2.550221 3050 1946 -4.310890 3050 3000 -0.000008 3050 3001 -1.188647 3050 3002 -2.009287 3050 3045 -0.000007 3050 3046 -1.032927 3050 3047 -1.746060 3050 3048 0.000505 3050 3049 5.948867 3050 3050 10.055958 3050 3096 -0.000008 3050 3097 -1.172799 3050 3098 -1.982498 3051 3051 1.000000 3052 3052 1.000000 3053 3053 1.000000 3054 3054 1.000000 3055 3055 1.000000 3056 3056 1.000000 3057 3057 1.000000 3058 3058 1.000000 3059 3059 1.000000 3060 3060 1.000000 3061 3061 1.000000 3062 3062 1.000000 3063 3063 1.000000 3064 3064 1.000000 3065 3065 1.000000 3066 3066 1.000000 3067 3067 1.000000 3068 3068 1.000000 3069 3069 1.000000 3070 3070 1.000000 3071 3071 1.000000 3072 3072 1.000000 3073 3073 1.000000 3074 3074 1.000000 3075 1971 -0.051494 3075 3027 -0.009576 3075 3075 175.386370 3075 3076 -103.734500 3075 3077 -175.352800 3075 3078 -0.025780 3075 3123 -0.000584 3075 3124 1.146120 3075 3125 1.937401 3076 3076 -33.417286 3076 3077 26.920936 3076 3125 -0.313859 3077 1971 -0.000017 3077 1972 -2.881532 3077 1973 -4.870942 3077 3027 -0.000006 3077 3028 -1.051602 3077 3029 -1.777628 3077 3075 0.000445 3077 3076 6.038774 3077 3077 10.207943 3077 3078 -0.000006 3077 3079 -1.050140 3077 3080 -1.775157 3077 3123 -0.000006 3077 3124 -1.051757 3077 3125 -1.777891 3078 1974 -0.051778 3078 3030 -0.000587 3078 3075 -0.000586 3078 3076 1.059146 3078 3077 1.790380 3078 3078 175.416220 3078 3079 -105.396550 3078 3080 -178.162180 3078 3081 -0.027000 3078 3126 -0.000577 3078 3127 1.752014 3078 3128 2.961602 3079 3077 -0.290040 3079 3079 -33.422495 3079 3080 27.363394 3079 3128 -0.479779 3080 1974 -0.000017 3080 1975 -2.885760 3080 1976 -4.878084 3080 3030 -0.000006 3080 3031 -1.051725 3080 3032 -1.777834 3080 3075 -0.000006 3080 3076 -1.050140 3080 3077 -1.775157 3080 3078 0.000451 3080 3079 6.979811 3080 3080 11.798665 3080 3081 -0.000006 3080 3082 -0.954525 3080 3083 -1.613527 3080 3126 -0.000006 3080 3127 -1.033917 3080 3128 -1.747733 3081 1977 -0.052196 3081 3033 -0.000493 3081 3078 -0.000537 3081 3079 2.070671 3081 3080 3.500259 3081 3081 146.173570 3081 3082 -89.727004 3081 3083 -151.674530 3081 3084 -0.005342 3081 3129 -0.003462 3081 3130 2.179455 3081 3131 3.684150 3082 3080 -0.567039 3082 3082 -27.858703 3082 3083 23.305832 3082 3131 -0.596829 3083 1977 -0.000020 3083 1978 -3.461300 3083 1979 -5.850982 3083 3033 -0.000005 3083 3034 -0.876382 3083 3035 -1.481436 3083 3078 -0.000006 3083 3079 -0.954525 3083 3080 -1.613527 3083 3081 0.000383 3083 3082 6.952922 3083 3083 11.753218 3083 3084 -0.000005 3083 3085 -0.799048 3083 3086 -1.350711 3083 3129 -0.000005 3083 3130 -0.858544 3083 3131 -1.451282 3084 1980 -0.052843 3084 3036 -0.000420 3084 3081 -0.000456 3084 3082 2.880340 3084 3083 4.868927 3084 3084 122.771330 3084 3085 -77.362189 3084 3086 -130.772960 3084 3087 -0.000409 3084 3132 -0.011494 3084 3133 2.668981 3084 3134 4.511643 3085 3083 -0.788757 3085 3085 -23.406774 3085 3086 20.108738 3085 3134 -0.730878 3086 1980 -0.000025 3086 1981 -4.122979 3086 1982 -6.969480 3086 3036 -0.000004 3086 3037 -0.736153 3086 3038 -1.244392 3086 3081 -0.000005 3086 3082 -0.799048 3086 3083 -1.350711 3086 3084 0.000329 3086 3085 7.095763 3086 3086 11.994671 3086 3087 -0.000004 3086 3088 -0.716721 3086 3089 -1.211544 3086 3132 -0.000004 3086 3133 -0.718236 3086 3134 -1.214106 3087 1983 -0.053129 3087 3039 -0.000408 3087 3084 -0.004076 3087 3085 3.615660 3087 3086 6.111908 3087 3087 116.927240 3087 3088 -75.851741 3087 3089 -128.219780 3087 3090 -0.000418 3087 3135 -0.018922 3087 3136 3.846637 3087 3137 6.502356 3088 3086 -0.990110 3088 3088 -22.298205 3088 3089 19.731273 3088 3137 -1.053362 3089 1983 -0.000026 3089 1984 -4.336609 3089 1985 -7.330604 3089 3039 -0.000004 3089 3040 -0.701068 3089 3041 -1.185086 3089 3084 -0.000004 3089 3085 -0.716721 3089 3086 -1.211544 3089 3087 0.000317 3089 3088 7.175295 3089 3089 12.129118 3089 3090 -0.000004 3089 3091 -0.717509 3089 3092 -1.212877 3089 3135 -0.000004 3089 3136 -0.700884 3089 3137 -1.184775 3090 1986 -0.052581 3090 3042 -0.000439 3090 3087 -0.007420 3090 3088 4.683879 3090 3089 7.917630 3090 3090 122.839510 3090 3091 -83.210913 3090 3092 -140.659650 3090 3093 -0.000486 3090 3138 -0.026702 3090 3139 6.726466 3090 3140 11.370411 3091 3089 -1.282616 3091 3091 -23.421014 3091 3092 21.674765 3091 3140 -1.841960 3092 1986 -0.000026 3092 1987 -4.127419 3092 1988 -6.976984 3092 3042 -0.000005 3092 3043 -0.735566 3092 3044 -1.243400 3092 3087 -0.000004 3092 3088 -0.717509 3092 3089 -1.212877 3092 3090 0.000332 3092 3091 7.150266 3092 3092 12.086803 3092 3093 -0.000005 3092 3094 -0.814816 3092 3095 -1.377364 3092 3138 -0.000005 3092 3139 -0.752324 3092 3140 -1.271728 3093 1989 -0.051129 3093 3045 -0.000563 3093 3090 -0.067005 3093 3091 7.655198 3093 3092 12.940339 3093 3093 151.975000 3093 3094 -96.579452 3093 3095 -163.257900 3093 3096 -0.000631 3094 3092 -2.096239 3094 3094 -29.003616 3094 3095 25.055078 3095 1989 -0.000021 3095 1990 -3.329250 3095 1991 -5.627765 3095 3045 -0.000006 3095 3046 -0.911125 3095 3047 -1.540166 3095 3090 -0.000005 3095 3091 -0.814816 3095 3092 -1.377364 3095 3093 0.000395 3095 3094 6.078102 3095 3095 10.274423 3095 3096 -0.000007 3095 3097 -1.019649 3095 3098 -1.723615 3096 1992 -0.050210 3096 3048 -0.000737 3096 3093 -0.016492 3096 3094 4.485347 3096 3095 7.582031 3096 3096 192.863050 3096 3097 -117.341770 3096 3098 -198.354410 3097 3095 -1.228204 3097 3097 -36.819304 3097 3098 30.348281 3098 1992 -0.000017 3098 1993 -2.627090 3098 1994 -4.440830 3098 3048 -0.000008 3098 3049 -1.172799 3098 3050 -1.982498 3098 3093 -0.000007 3098 3094 -1.019649 3098 3095 -1.723615 3098 3096 0.000483 3098 3097 4.823681 3098 3098 8.153946 3099 3099 1.000000 3100 3100 1.000000 3101 3101 1.000000 3102 3102 1.000000 3103 3103 1.000000 3104 3104 1.000000 3105 3105 1.000000 3106 3106 1.000000 3107 3107 1.000000 3108 3108 1.000000 3109 3109 1.000000 3110 3110 1.000000 3111 3111 1.000000 3112 3112 1.000000 3113 3113 1.000000 3114 3114 1.000000 3115 3115 1.000000 3116 3116 1.000000 3117 3117 1.000000 3118 3118 1.000000 3119 3119 1.000000 3120 3120 1.000000 3121 3121 1.000000 3122 3122 1.000000 3123 2019 -0.051492 3123 3075 -0.004367 3123 3123 175.384750 3123 3124 -102.592570 3123 3125 -173.422480 3123 3126 -0.023788 3124 3124 -33.414684 3124 3125 26.614646 3125 2019 -0.000017 3125 2020 -2.879925 3125 2021 -4.868225 3125 3075 -0.000006 3125 3076 -1.051757 3125 3077 -1.777891 3125 3123 0.000439 3125 3124 4.967957 3125 3125 8.397835 3125 3126 -0.000006 3125 3127 -1.032534 3125 3128 -1.745396 3126 2022 -0.051840 3126 3078 -0.005853 3126 3123 -0.000572 3126 3124 0.416853 3126 3125 0.704649 3126 3126 169.559040 3126 3127 -100.616180 3126 3128 -170.081480 3126 3129 -0.033882 3126 3174 -0.003079 3126 3175 1.034420 3126 3176 1.748582 3127 3125 -0.114153 3127 3127 -32.304568 3127 3128 26.113754 3127 3176 -0.283270 3128 2022 -0.000017 3128 2023 -2.983769 3128 2024 -5.043760 3128 3078 -0.000006 3128 3079 -1.033917 3128 3080 -1.747733 3128 3123 -0.000006 3128 3124 -1.032534 3128 3125 -1.745396 3128 3126 0.000437 3128 3127 6.934065 3128 3128 11.721336 3128 3129 -0.000005 3128 3130 -0.919168 3128 3131 -1.553760 3128 3174 -0.000006 3128 3175 -0.961059 3128 3176 -1.624572 3129 2025 -0.052323 3129 3081 -0.000478 3129 3126 -0.000512 3129 3127 1.218111 3129 3128 2.059094 3129 3129 140.336210 3129 3130 -84.868844 3129 3131 -143.462290 3129 3132 -0.014245 3129 3177 -0.002348 3129 3178 1.584534 3129 3179 2.678497 3130 3128 -0.333573 3130 3130 -26.740796 3130 3131 22.034918 3130 3179 -0.433916 3131 2025 -0.000021 3131 2026 -3.604792 3131 2027 -6.093541 3131 3081 -0.000005 3131 3082 -0.858544 3131 3083 -1.451282 3131 3126 -0.000005 3131 3127 -0.919168 3131 3128 -1.553760 3131 3129 0.000369 3131 3130 6.934774 3131 3131 11.722541 3131 3132 -0.000004 3131 3133 -0.763958 3131 3134 -1.291395 3131 3177 -0.000005 3131 3178 -0.785315 3131 3179 -1.327497 3132 2028 -0.052937 3132 3084 -0.000404 3132 3129 -0.000430 3132 3130 1.854249 3132 3131 3.134422 3132 3132 116.937180 3132 3133 -72.342964 3132 3134 -122.288470 3132 3135 -0.004515 3132 3180 -0.004638 3132 3181 2.104738 3132 3182 3.557846 3133 3131 -0.507774 3133 3133 -22.288761 3133 3134 18.794041 3133 3182 -0.576369 3134 2028 -0.000025 3134 2029 -4.326679 3134 2030 -7.313814 3134 3084 -0.000004 3134 3085 -0.718236 3134 3086 -1.214106 3134 3129 -0.000004 3134 3130 -0.763958 3134 3131 -1.291395 3134 3132 0.000316 3134 3133 7.213076 3134 3134 12.192977 3134 3135 -0.000004 3134 3136 -0.700651 3134 3137 -1.184379 3134 3180 -0.000004 3134 3181 -0.701053 3134 3182 -1.185059 3135 2031 -0.053057 3135 3087 -0.000399 3135 3132 -0.000399 3135 3133 2.292791 3135 3134 3.875731 3135 3135 116.930790 3135 3136 -73.470486 3135 3137 -124.194510 3135 3138 -0.000418 3135 3183 -0.004731 3135 3184 2.787532 3135 3185 4.712045 3136 3134 -0.627862 3136 3136 -22.293510 3136 3137 19.090994 3136 3185 -0.763344 3137 2031 -0.000026 3137 2032 -4.327212 3137 2033 -7.314718 3137 3087 -0.000004 3137 3088 -0.700884 3137 3089 -1.184775 3137 3132 -0.000004 3137 3133 -0.700651 3137 3134 -1.184379 3137 3135 0.000316 3137 3136 7.165999 3137 3137 12.113403 3137 3138 -0.000004 3137 3139 -0.734021 3137 3140 -1.240789 3137 3183 -0.000004 3137 3184 -0.700730 3137 3185 -1.184514 3138 2034 -0.052824 3138 3090 -0.000434 3138 3135 -0.001348 3138 3136 2.257240 3138 3137 3.815638 3138 3138 128.618690 3138 3139 -80.808617 3138 3140 -136.598800 3138 3186 -0.009467 3138 3187 3.328598 3138 3188 5.626658 3139 3137 -0.618122 3139 3139 -24.527093 3139 3140 20.987143 3139 3188 -0.911505 3140 2034 -0.000024 3140 2035 -3.936805 3140 2036 -6.654771 3140 3090 -0.000005 3140 3091 -0.752324 3140 3092 -1.271728 3140 3135 -0.000004 3140 3136 -0.734021 3140 3137 -1.240789 3140 3138 0.000338 3140 3139 6.214035 3140 3140 10.504199 3140 3186 -0.000005 3140 3187 -0.788131 3140 3188 -1.332257 3141 3141 1.000000 3142 3142 1.000000 3143 3143 1.000000 3144 3144 1.000000 3145 3145 1.000000 3146 3146 1.000000 3147 3147 1.000000 3148 3148 1.000000 3149 3149 1.000000 3150 3150 1.000000 3151 3151 1.000000 3152 3152 1.000000 3153 3153 1.000000 3154 3154 1.000000 3155 3155 1.000000 3156 3156 1.000000 3157 3157 1.000000 3158 3158 1.000000 3159 3159 1.000000 3160 3160 1.000000 3161 3161 1.000000 3162 3162 1.000000 3163 3163 1.000000 3164 3164 1.000000 3165 3165 1.000000 3166 3166 1.000000 3167 3167 1.000000 3168 3168 1.000000 3169 3169 1.000000 3170 3170 1.000000 3171 3171 1.000000 3172 3172 1.000000 3173 3173 1.000000 3174 2070 -0.052088 3174 3126 -0.000530 3174 3174 152.001170 3174 3175 -88.913889 3174 3176 -150.299940 3174 3177 -0.029814 3175 3175 -28.961215 3175 3176 23.061769 3176 2070 -0.000019 3176 2071 -3.327513 3176 2072 -5.624825 3176 3126 -0.000006 3176 3127 -0.961059 3176 3128 -1.624572 3176 3174 0.000385 3176 3175 5.105427 3176 3176 8.630208 3176 3177 -0.000005 3176 3178 -0.813612 3176 3179 -1.375329 3177 2073 -0.052643 3177 3129 -0.000434 3177 3174 -0.000449 3177 3175 0.312256 3177 3176 0.527837 3177 3177 122.796920 3177 3178 -73.378153 3177 3179 -124.038430 3177 3180 -0.015979 3177 3225 -0.000709 3177 3226 1.262960 3177 3227 2.134908 3178 3176 -0.085510 3178 3178 -23.395689 3178 3179 19.045226 3178 3227 -0.345856 3179 2073 -0.000024 3179 2074 -4.117729 3179 2075 -6.960609 3179 3129 -0.000005 3179 3130 -0.785315 3179 3131 -1.327497 3179 3174 -0.000005 3179 3175 -0.813612 3179 3176 -1.375329 3179 3177 0.000328 3179 3178 7.155242 3179 3179 12.095220 3179 3180 -0.000004 3179 3181 -0.717735 3179 3182 -1.213259 3179 3225 -0.000004 3179 3226 -0.718229 3179 3227 -1.214095 3180 2076 -0.052986 3180 3132 -0.000390 3180 3177 -0.000399 3180 3178 1.035362 3180 3179 1.750175 3180 3180 116.935840 3180 3181 -71.087844 3180 3182 -120.166810 3180 3183 -0.004602 3180 3228 -0.000390 3180 3229 1.662928 3180 3230 2.811012 3181 3179 -0.283528 3181 3181 -22.285431 3181 3182 18.458632 3181 3230 -0.455385 3182 2076 -0.000025 3182 2077 -4.323339 3182 2078 -7.308167 3182 3132 -0.000004 3182 3133 -0.701053 3182 3134 -1.185059 3182 3177 -0.000004 3182 3178 -0.717735 3182 3179 -1.213259 3182 3180 0.000315 3182 3181 7.146388 3182 3182 12.080246 3182 3183 -0.000004 3182 3184 -0.700761 3182 3185 -1.184566 3182 3228 -0.000004 3182 3229 -0.701002 3182 3230 -1.184974 3183 2079 -0.053022 3183 3135 -0.000393 3183 3180 -0.000393 3183 3181 1.609325 3183 3182 2.720402 3183 3183 116.922090 3183 3184 -72.281303 3183 3185 -122.184320 3183 3186 -0.003415 3183 3231 -0.000412 3183 3232 2.286183 3183 3233 3.864564 3184 3182 -0.440704 3184 3184 -22.288936 3184 3185 18.776741 3184 3233 -0.626058 3185 2079 -0.000025 3185 2080 -4.327224 3185 2081 -7.314740 3185 3135 -0.000004 3185 3136 -0.700730 3185 3137 -1.184514 3185 3180 -0.000004 3185 3181 -0.700761 3185 3182 -1.184566 3185 3183 0.000316 3185 3184 7.214881 3185 3185 12.196034 3185 3186 -0.000004 3185 3187 -0.749608 3185 3188 -1.267137 3185 3231 -0.000004 3185 3232 -0.734058 3185 3233 -1.240852 3186 2082 -0.052729 3186 3138 -0.000447 3186 3183 -0.000425 3186 3184 2.121216 3186 3185 3.585703 3186 3186 134.454320 3186 3187 -80.766249 3186 3188 -136.527180 3187 3185 -0.580879 3187 3187 -25.636890 3187 3188 20.936337 3188 2082 -0.000022 3188 2083 -3.762768 3188 2084 -6.360580 3188 3138 -0.000005 3188 3139 -0.788131 3188 3140 -1.332257 3188 3183 -0.000004 3188 3184 -0.749608 3188 3185 -1.267137 3188 3186 0.000346 3188 3187 5.303384 3188 3188 8.964836 3189 3189 1.000000 3190 3190 1.000000 3191 3191 1.000000 3192 3192 1.000000 3193 3193 1.000000 3194 3194 1.000000 3195 3195 1.000000 3196 3196 1.000000 3197 3197 1.000000 3198 3198 1.000000 3199 3199 1.000000 3200 3200 1.000000 3201 3201 1.000000 3202 3202 1.000000 3203 3203 1.000000 3204 3204 1.000000 3205 3205 1.000000 3206 3206 1.000000 3207 3207 1.000000 3208 3208 1.000000 3209 3209 1.000000 3210 3210 1.000000 3211 3211 1.000000 3212 3212 1.000000 3213 3213 1.000000 3214 3214 1.000000 3215 3215 1.000000 3216 3216 1.000000 3217 3217 1.000000 3218 3218 1.000000 3219 3219 1.000000 3220 3220 1.000000 3221 3221 1.000000 3222 3222 1.000000 3223 3223 1.000000 3224 3224 1.000000 3225 2121 -0.052989 3225 3177 -0.000394 3225 3225 116.927460 3225 3226 -69.220622 3225 3227 -117.010540 3225 3228 -0.015054 3225 3273 -0.000385 3225 3274 0.826290 3225 3275 1.396761 3226 3226 -22.279374 3226 3227 17.962197 3226 3275 -0.226277 3227 2121 -0.000025 3227 2122 -4.321770 3227 2123 -7.305520 3227 3177 -0.000004 3227 3178 -0.718229 3227 3179 -1.214095 3227 3225 0.000310 3227 3226 6.444480 3227 3227 10.893749 3227 3228 -0.000004 3227 3229 -0.700916 3227 3230 -1.184829 3227 3273 -0.000004 3227 3274 -0.701069 3227 3275 -1.185087 3228 2124 -0.053004 3228 3180 -0.000630 3228 3225 -0.000386 3228 3226 0.580854 3228 3227 0.981876 3228 3228 116.938550 3228 3229 -70.175975 3228 3230 -118.625400 3228 3231 -0.003640 3228 3276 -0.000386 3228 3277 1.212652 3228 3278 2.049865 3229 3227 -0.159064 3229 3229 -22.282337 3229 3230 18.216588 3229 3278 -0.332080 3230 2124 -0.000025 3230 2125 -4.321222 3230 2126 -7.304589 3230 3180 -0.000004 3230 3181 -0.701002 3230 3182 -1.184974 3230 3225 -0.000004 3230 3226 -0.700916 3230 3227 -1.184829 3230 3228 0.000315 3230 3229 7.161095 3230 3230 12.105109 3230 3231 -0.000004 3230 3232 -0.734503 3230 3233 -1.241603 3230 3276 -0.000004 3230 3277 -0.700955 3230 3278 -1.184894 3231 2127 -0.052835 3231 3183 -0.001842 3231 3228 -0.000407 3231 3229 1.141636 3231 3230 1.929820 3231 3231 128.610050 3231 3232 -76.368722 3231 3233 -129.093690 3232 3230 -0.312632 3232 3232 -24.513213 3232 3233 19.805802 3233 2127 -0.000023 3233 2128 -3.930456 3233 2129 -6.644043 3233 3183 -0.000004 3233 3184 -0.734058 3233 3185 -1.240852 3233 3228 -0.000004 3233 3229 -0.734503 3233 3230 -1.241603 3233 3231 0.000332 3233 3232 5.401765 3233 3233 9.131143 3234 3234 1.000000 3235 3235 1.000000 3236 3236 1.000000 3237 3237 1.000000 3238 3238 1.000000 3239 3239 1.000000 3240 3240 1.000000 3241 3241 1.000000 3242 3242 1.000000 3243 3243 1.000000 3244 3244 1.000000 3245 3245 1.000000 3246 3246 1.000000 3247 3247 1.000000 3248 3248 1.000000 3249 3249 1.000000 3250 3250 1.000000 3251 3251 1.000000 3252 3252 1.000000 3253 3253 1.000000 3254 3254 1.000000 3255 3255 1.000000 3256 3256 1.000000 3257 3257 1.000000 3258 3258 1.000000 3259 3259 1.000000 3260 3260 1.000000 3261 3261 1.000000 3262 3262 1.000000 3263 3263 1.000000 3264 3264 1.000000 3265 3265 1.000000 3266 3266 1.000000 3267 3267 1.000000 3268 3268 1.000000 3269 3269 1.000000 3270 3270 1.000000 3271 3271 1.000000 3272 3272 1.000000 3273 2169 -0.053043 3273 3225 -0.005702 3273 3273 116.923770 3273 3274 -68.392282 3273 3275 -115.610310 3273 3276 -0.015552 3274 3274 -22.277164 3274 3275 17.740800 3275 2169 -0.000025 3275 2170 -4.320365 3275 2171 -7.303145 3275 3225 -0.000004 3275 3226 -0.701069 3275 3227 -1.185087 3275 3273 0.000306 3275 3274 5.724840 3275 3275 9.677270 3275 3276 -0.000004 3275 3277 -0.700912 3275 3278 -1.184822 3276 2172 -0.053061 3276 3228 -0.005202 3276 3273 -0.000383 3276 3274 0.194354 3276 3275 0.328536 3276 3276 116.936470 3276 3277 -68.581138 3276 3278 -115.929490 3277 3275 -0.053223 3277 3277 -22.279477 3277 3278 17.786906 3278 2172 -0.000025 3278 2173 -4.321573 3278 2174 -7.305183 3278 3228 -0.000004 3278 3229 -0.700955 3278 3230 -1.184894 3278 3273 -0.000004 3278 3274 -0.700912 3278 3275 -1.184822 3278 3276 0.000306 3278 3277 5.725936 3278 3278 9.679117 3279 3279 1.000000 3280 3280 1.000000 3281 3281 1.000000 3282 3282 1.000000 3283 3283 1.000000 3284 3284 1.000000 3285 3285 1.000000 3286 3286 1.000000 3287 3287 1.000000 3288 3288 1.000000 3289 3289 1.000000 3290 3290 1.000000 3291 3291 1.000000 3292 3292 1.000000 3293 3293 1.000000 3294 3294 1.000000 3295 3295 1.000000 3296 3296 1.000000 3297 3297 1.000000 3298 3298 1.000000 3299 3299 1.000000 3300 3300 1.000000 3301 3301 1.000000 3302 3302 1.000000 3303 3303 1.000000 3304 3304 1.000000 3305 3305 1.000000 3306 3306 1.000000 3307 3307 1.000000 3308 3308 1.000000 3309 3309 1.000000 3310 3310 1.000000 3311 3311 1.000000 itsol-1.0.0/TESTS_COO/MATRICES/PORES3.COO0000640000265600020320000030664711062577473016144 0ustar tilleaadmin 532 532 3474 0 0 -31.554891 0 1 1433.257682 0 2 31.366384 1 0 -0.023761 1 1 -1659.633607 2 0 31.366384 2 2 -69.492811 2 3 1477.128137 2 4 37.910166 3 2 -0.024484 3 3 -1710.279238 4 2 37.910166 4 4 -82.880758 4 5 1521.070604 4 6 44.747896 5 4 -0.025207 5 5 -1760.980423 6 4 44.747896 6 6 -96.856679 6 7 1565.042077 6 8 51.879647 7 6 -0.025930 7 7 -1811.691043 8 6 51.879647 8 8 -111.419804 8 9 1609.074027 8 10 59.304571 9 8 -0.026654 9 9 -1862.449777 10 8 59.304571 10 10 -126.567907 10 11 1653.127801 10 12 67.021297 11 10 -0.027377 11 11 -1913.213311 12 10 67.021297 12 12 -142.297918 12 13 1697.237442 12 14 75.028119 13 12 -0.028100 13 13 -1964.021980 14 12 75.028119 14 14 -158.605833 14 15 1741.365858 14 16 83.322747 15 14 -0.028824 15 15 -2014.833476 16 14 83.322747 16 16 -175.488204 16 17 1785.530185 16 18 91.904020 17 16 -0.029547 17 17 -2065.668037 18 16 91.904020 18 18 -192.941377 18 19 1829.747855 18 20 100.769441 19 18 -0.030271 19 19 -2116.546092 20 18 100.769441 20 20 -210.960716 20 21 1873.982631 20 22 109.916877 21 20 -0.030994 21 21 -2167.425885 22 20 109.916877 22 22 -229.541928 22 23 1918.270248 22 24 119.344164 23 22 -0.031718 23 23 -2218.348838 24 22 119.344164 24 24 -248.680591 24 25 1962.574689 24 26 129.049047 25 24 -0.032441 25 25 -2269.273336 26 24 129.049047 26 26 -268.372225 26 27 2006.931887 26 28 139.029298 27 26 -0.033165 27 27 -2320.240931 28 26 139.029298 28 28 -288.611692 28 29 2051.305935 28 30 149.282012 29 28 -0.033889 29 29 -2371.210077 30 28 149.282012 30 30 -309.395057 30 31 2095.714895 30 32 159.806154 31 30 -0.034612 31 31 -2422.201609 32 30 159.806154 32 32 -330.718362 32 33 2140.176878 32 34 170.598801 33 32 -0.035336 33 33 -2473.236392 34 32 170.598801 34 34 -352.576379 34 35 2184.656036 34 36 181.657651 35 34 -0.036060 35 35 -2524.272919 36 34 181.657651 36 36 -374.964524 36 37 2229.188522 36 38 192.980419 37 36 -0.036784 37 37 -2575.352883 38 36 192.980419 38 38 -397.878145 38 39 2273.738490 38 40 204.564741 39 38 -0.037508 39 39 -2626.434777 40 38 204.564741 40 40 -421.312589 40 41 2318.342137 40 42 216.408325 41 40 -0.038232 41 41 -2677.560322 42 40 216.408325 42 42 -445.262380 42 43 2362.963601 42 44 228.507992 43 42 -0.038956 43 43 -2728.688002 44 42 228.507992 44 44 -469.723688 44 45 2407.621079 44 46 240.863086 45 44 -0.039680 45 45 -2779.838736 46 44 240.863086 46 46 -494.692732 46 47 2452.332782 46 48 253.470482 47 46 -0.040404 47 47 -2831.033455 48 46 253.470482 48 48 -520.164080 48 49 2497.062814 48 50 266.327875 49 48 -0.041128 49 49 -2882.230620 50 48 266.327875 50 50 -546.133091 50 51 2541.847429 50 52 279.432927 51 50 -0.041852 51 51 -2933.471988 52 50 279.432927 52 52 -572.595144 52 53 2586.650697 52 54 292.783358 53 52 -0.042576 53 53 -2984.715999 54 52 292.783358 54 54 -599.545716 54 55 2631.508888 54 56 306.376921 55 54 -0.043301 55 55 -3036.004419 56 54 306.376921 56 56 -626.980198 56 57 2676.386035 56 58 320.211259 57 56 -0.044025 57 57 -3087.295663 58 56 320.211259 58 58 -654.894018 58 59 2721.318420 58 60 334.284152 59 58 -0.044749 59 59 -3138.631507 60 58 334.284152 60 60 -683.281571 60 61 2766.270038 60 62 348.592221 61 60 -0.045474 61 61 -3189.970342 62 60 348.592221 62 62 -712.139454 62 63 2811.259095 62 64 363.135437 63 62 -0.046198 63 63 -3241.333092 64 62 363.135437 64 64 -741.464310 64 65 2856.303813 64 66 377.910470 65 64 -0.046922 65 65 -3292.740695 66 64 377.910470 66 66 -771.250589 66 67 2901.368122 66 68 392.915106 67 66 -0.047647 67 67 -3344.151500 68 66 392.915106 68 68 -801.493935 68 69 2946.488337 68 70 408.147199 69 68 -0.048372 69 69 -3395.607301 70 68 408.147199 70 70 -786.358191 70 71 2991.628347 70 72 377.772821 70 73 -2576.563419 71 70 -0.649367 71 71 -3447.066423 71 72 0.600219 71 73 32.106796 72 70 377.772821 72 72 -557.347702 72 73 5613.483824 72 74 179.149693 72 75 -2874.688652 73 70 0.600219 73 72 -84.074929 73 73 -3530.729661 73 74 83.412261 73 75 2992.814733 74 72 179.149693 74 74 -179.475903 74 75 5957.592646 75 72 83.412261 75 74 -83.499469 75 75 -6543.446184 76 76 -49206.594470 76 77 2343.500438 76 78 217.696150 76 79 -378.588481 76 152 48988.774070 77 76 -0.523750 77 77 -2372.214451 77 78 0.002119 77 79 3.483604 77 152 0.488961 78 76 217.696150 78 78 -48269.192930 78 79 2442.855555 78 80 221.643266 78 81 -385.922501 78 154 47829.554300 79 76 0.002119 79 78 -0.503969 79 79 -2478.380203 79 80 0.002101 79 81 3.556206 79 154 0.465552 80 78 221.643266 80 80 -47115.646180 80 81 2541.037154 80 82 225.081079 80 83 -392.069294 80 156 46668.609210 81 78 0.002101 81 80 -0.482342 81 81 -2585.234577 81 82 0.002076 81 83 3.617372 81 156 0.442441 82 80 225.081079 82 82 -45961.216690 82 83 2638.033159 82 84 228.012100 82 85 -397.011130 82 158 45507.797490 83 80 0.002076 83 82 -0.461193 83 83 -2691.955403 83 84 0.002045 83 85 3.666798 83 158 0.419822 84 82 228.012100 84 84 -44804.012970 84 85 2733.918630 84 86 230.437085 84 87 -400.807036 84 160 44345.224360 85 82 0.002045 85 84 -0.440531 85 85 -2798.560951 85 86 0.002007 85 87 3.705172 85 160 0.397702 86 84 230.437085 86 86 -43645.933420 86 87 2828.730119 86 88 232.356784 86 89 -403.531282 86 162 43182.786720 87 84 0.002007 87 86 -0.420390 87 87 -2905.011859 87 88 0.001963 87 89 3.733249 87 162 0.376116 88 86 232.356784 88 88 -42485.169280 88 89 2922.539665 88 90 233.773787 88 91 -405.240278 88 164 42018.672460 89 86 0.001963 89 88 -0.400771 89 89 -3011.326323 89 90 0.001914 89 91 3.751682 89 164 0.355063 90 88 233.773787 90 90 -41323.370400 90 91 3015.409754 90 92 234.689609 90 93 -405.999202 90 166 40854.527340 91 88 0.001914 91 90 -0.381702 91 91 -3117.507106 91 92 0.001860 91 93 3.761140 91 166 0.334570 92 90 234.689609 92 92 -40158.898350 92 93 3107.409448 92 94 235.105773 92 95 -405.879847 92 168 39688.709880 93 90 0.001860 93 92 -0.363178 93 93 -3223.551489 93 94 0.001802 93 95 3.762438 93 168 0.314631 94 92 235.105773 94 94 -38993.237290 94 95 3198.587253 94 96 235.023776 94 97 -404.933620 94 170 38522.701230 95 92 0.001802 95 94 -0.345219 95 95 -3329.461972 95 96 0.001739 95 97 3.756130 95 170 0.295267 96 94 235.023776 96 96 -37824.858340 96 97 3289.005858 96 98 234.445150 96 99 -403.226230 96 172 37354.969470 97 94 0.001739 97 96 -0.327820 97 97 -3435.235845 97 98 0.001673 97 99 3.742943 97 172 0.276469 98 96 234.445150 98 98 -36655.121730 98 99 3378.710815 98 100 233.372014 98 101 -400.806215 98 174 36186.871180 99 96 0.001673 99 98 -0.310995 99 99 -3540.875527 99 100 0.001604 99 101 3.723404 99 174 0.258253 100 98 233.372014 100 100 -35482.540240 100 101 3467.767536 100 102 231.805038 100 103 -397.724041 100 176 35016.916370 101 98 0.001604 101 100 -0.294737 101 101 -3646.399168 101 102 0.001531 101 103 3.698084 101 176 0.240609 102 100 231.805038 102 102 -34308.512800 102 103 3556.194542 102 104 229.744991 102 105 -394.036859 102 178 33846.502510 103 100 0.001531 103 102 -0.279056 103 103 -3751.767409 103 104 0.001456 103 105 3.667615 103 178 0.223548 104 102 229.744991 104 104 -33132.183010 104 105 3644.050407 104 106 227.193984 104 107 -389.788056 104 180 32674.770330 105 102 0.001456 105 104 -0.263949 105 105 -3856.999526 105 106 0.001379 105 107 3.632485 105 180 0.207066 106 104 227.193984 106 106 -31952.915070 106 107 3731.380482 106 108 224.153289 106 109 -385.025426 106 182 31501.080630 107 104 0.001379 107 106 -0.249412 107 107 -3962.094119 107 108 0.001300 107 109 3.593206 107 182 0.191157 108 106 224.153289 108 108 -30771.784090 108 109 3818.235093 108 110 220.624231 108 111 -379.801560 108 184 30326.505950 109 106 0.001300 109 108 -0.235451 109 109 -4067.053547 109 110 0.001219 109 111 3.550415 109 184 0.175829 110 108 220.624231 110 110 -29587.526590 110 111 3904.652954 110 112 216.608084 110 113 -374.157152 110 186 29149.780190 111 108 0.001219 111 110 -0.222060 111 111 -4171.874982 111 112 0.001137 111 113 3.504523 111 186 0.161071 112 110 216.608084 112 112 -28401.106390 112 113 3990.678526 112 114 212.106194 112 115 -368.138263 112 188 27971.864560 113 110 0.001137 113 112 -0.209242 113 113 -4276.560641 113 114 0.001055 113 115 3.456101 113 188 0.146889 114 112 212.106194 114 114 -27211.363740 114 115 4076.361118 114 116 207.120216 114 117 -361.795524 114 190 26791.596320 115 112 0.001055 115 114 -0.196991 115 115 -4381.108015 115 116 0.000972 115 117 3.405678 115 190 0.133276 116 114 207.120216 116 116 -26019.065670 116 117 4161.757481 116 118 201.650864 116 119 -355.168685 116 192 25609.740100 117 114 0.000972 117 116 -0.185310 117 117 -4485.539971 117 118 0.000890 117 119 3.353766 117 192 0.120232 118 116 201.650864 118 118 -24823.184340 118 119 4246.875230 118 120 195.698760 118 121 -348.301603 118 194 24425.266740 119 116 0.000890 119 118 -0.174194 119 119 -4589.812240 119 120 0.000807 119 121 3.300827 119 194 0.107753 120 118 195.698760 120 120 -23624.332110 120 121 4331.780992 120 122 189.265621 120 123 -341.242976 120 196 23238.786270 121 118 0.000807 121 120 -0.163646 121 121 -4693.947656 121 122 0.000725 121 123 3.247450 121 196 0.095841 122 120 189.265621 122 122 -22421.444910 122 123 4416.512639 122 124 182.352572 122 125 -334.030033 122 198 22049.231770 123 120 0.000725 123 122 -0.153660 123 123 -4797.943822 123 124 0.000644 123 125 3.194064 123 198 0.084489 124 122 182.352572 124 124 -21215.012760 124 125 4501.111818 124 126 174.960663 124 127 -326.703117 124 200 20857.091090 125 122 0.000644 125 124 -0.144241 125 125 -4901.802475 125 126 0.000565 125 127 3.141145 125 200 0.073702 126 124 174.960663 126 126 -20004.272540 126 127 4585.619943 126 128 167.090821 126 129 -319.301465 126 202 19661.599110 127 124 0.000565 127 126 -0.135387 127 127 -5005.522180 127 128 0.000487 127 129 3.089159 127 202 0.063477 128 126 167.090821 128 128 -18788.463680 128 129 4670.068675 128 130 158.744371 128 131 -311.853492 128 204 18461.993040 129 126 0.000487 129 128 -0.127101 129 129 -5109.101447 129 130 0.000411 129 131 3.038443 129 204 0.053815 130 128 158.744371 130 130 -17567.733400 130 131 4754.503499 130 132 149.921834 130 133 -304.382240 130 206 17258.418220 131 128 0.000411 131 130 -0.119387 131 131 -5212.562452 131 132 0.000338 131 133 2.989289 131 206 0.044721 132 130 149.921834 132 132 -16340.900270 132 133 4838.909153 132 134 140.623574 132 135 -296.901867 132 208 16049.692360 133 130 0.000338 133 132 -0.112250 133 133 -5315.861038 133 134 0.000268 133 135 2.941875 133 208 0.036199 134 132 140.623574 134 134 -15107.675040 134 135 4923.306136 134 136 130.850396 134 137 -289.406241 134 210 14835.525040 135 132 0.000268 135 134 -0.105698 135 135 -5419.018480 135 136 0.000201 135 137 2.896151 135 210 0.028255 136 134 130.850396 136 136 -13866.562660 136 137 5007.680952 136 138 120.602539 136 139 -281.869912 136 212 13614.420160 137 134 0.000201 137 136 -0.099747 137 137 -5522.031904 137 138 0.000138 137 139 2.851846 137 212 0.020905 138 136 120.602539 138 138 -12616.708290 138 139 5091.987487 138 140 109.879716 138 141 -274.228219 138 214 12385.522920 139 136 0.000138 139 138 -0.094420 139 139 -5624.900625 139 140 0.000079 139 141 2.808221 139 214 0.014170 140 138 109.879716 140 140 -11355.978440 140 141 5176.129997 140 142 98.680609 140 143 -266.366164 140 216 11146.701440 141 138 0.000079 141 140 -0.089729 141 141 -5727.620448 141 142 0.000026 141 143 2.763971 141 216 0.008062 142 140 98.680609 142 142 -10082.378530 142 143 5259.951219 142 144 87.000618 142 218 9895.967047 143 140 0.000026 143 142 -0.085754 143 143 -5830.188381 143 218 0.002637 144 142 87.000618 144 144 -8792.145612 144 145 5082.965969 144 146 74.833469 144 220 8629.567670 145 144 -0.084620 145 145 -5893.890293 146 144 74.833469 146 146 -7480.962486 146 147 5175.969994 146 148 62.167728 146 222 7343.203814 147 146 -0.086150 147 147 -6001.067153 148 146 62.167728 148 148 -6139.865977 148 149 5269.178620 148 150 46.980413 148 151 -257.816313 148 224 6029.946712 149 148 -0.111331 149 149 -6108.375801 149 150 0.023649 149 151 2.883539 150 148 46.980413 150 150 -4656.818420 150 151 5620.698272 150 226 4609.065822 150 227 -21.084927 151 148 0.023649 151 150 -2.376847 151 151 -6239.128977 151 226 2.259662 152 76 48988.774070 152 77 -11.900364 152 152 -99637.193150 152 153 598.090299 152 154 8.287033 152 155 -14.409564 152 228 50640.055220 153 76 0.488961 153 77 96.956458 153 152 -0.956213 153 153 -881.189583 153 154 0.000073 153 155 0.132114 153 228 0.457677 154 78 47829.554300 154 79 -19.155006 154 152 8.287033 154 154 -97867.394850 154 155 597.159460 154 156 7.987170 154 157 -13.906443 154 230 50021.484310 155 78 0.465552 155 79 97.733867 155 152 0.000073 155 154 -0.916745 155 155 -869.155445 155 156 0.000069 155 157 0.127690 155 230 0.441677 156 80 46668.609210 156 81 -18.455831 156 154 7.987170 156 156 -96073.803690 156 157 588.280856 156 158 7.692850 156 159 -13.399566 156 232 49389.433520 157 80 0.442441 157 81 98.278075 157 154 0.000069 157 156 -0.877448 157 157 -857.033606 157 158 0.000065 157 159 0.123191 157 232 0.425627 158 82 45507.797490 158 83 -17.729510 158 156 7.692850 158 158 -94268.581600 158 159 579.359594 158 160 7.404060 158 161 -12.891277 158 234 48745.607380 159 82 0.419822 159 83 98.681590 159 156 0.000065 159 158 -0.838663 159 159 -844.852923 159 160 0.000061 159 161 0.118642 159 234 0.409597 160 84 44345.224360 160 85 -17.051229 160 158 7.404060 160 160 -92447.256580 160 161 570.502646 160 162 7.120787 160 163 -12.384932 160 236 48087.428660 161 84 0.397702 161 85 98.942446 161 158 0.000061 161 160 -0.800406 161 161 -832.639105 161 162 0.000057 161 163 0.114085 161 236 0.393596 162 86 43182.786720 162 87 -16.434218 162 160 7.120787 162 162 -90613.304900 162 163 561.697604 162 164 6.843009 162 165 -11.883739 162 238 47416.476780 163 86 0.376116 163 87 99.062002 163 160 0.000057 163 162 -0.762746 163 163 -820.363914 163 164 0.000053 163 165 0.109553 163 238 0.377658 164 88 42018.672460 164 89 -15.858611 164 162 6.843009 164 164 -88762.280530 164 165 552.954931 164 166 6.570715 164 167 -11.389770 164 240 46730.117860 165 88 0.355063 165 89 99.037137 165 162 0.000053 165 164 -0.725687 165 165 -808.051815 165 166 0.000049 165 167 0.105072 165 240 0.361787 166 90 40854.527340 166 91 -15.330606 166 164 6.570715 166 166 -86897.382820 166 167 544.253840 166 168 6.303888 166 169 -10.905026 166 242 46029.905510 167 90 0.334570 167 91 98.870042 167 164 0.000049 167 166 -0.689286 167 167 -795.674490 167 168 0.000046 167 169 0.100665 167 242 0.346015 168 92 39688.709880 168 93 -14.854177 168 166 6.303888 168 168 -85014.279470 168 169 535.628361 168 170 6.042511 168 171 -10.431336 168 244 45313.148920 169 92 0.314631 169 93 98.557389 169 166 0.000046 169 168 -0.653541 169 169 -783.256509 169 170 0.000043 169 171 0.096354 169 244 0.330342 170 94 38522.701230 170 95 -14.406092 170 168 6.042511 170 170 -83115.852250 170 171 527.027286 170 172 5.786564 170 173 -9.969705 170 246 44581.248800 171 94 0.295267 171 95 98.100899 171 168 0.000043 171 170 -0.618496 171 171 -770.768677 171 172 0.000040 171 173 0.092150 171 246 0.314797 172 96 37354.969470 172 97 -13.997656 172 170 5.786564 172 172 -81197.844630 172 173 518.491346 172 174 5.536026 172 175 -9.521306 172 248 43831.480530 173 96 0.276469 173 97 97.497328 173 170 0.000040 173 172 -0.584146 173 173 -758.235572 173 174 0.000037 173 175 0.088068 173 248 0.299379 174 98 36186.871180 174 99 -13.608690 174 172 5.536026 174 174 -79262.878460 174 175 509.971982 174 176 5.290882 174 177 -9.086694 174 250 43065.109450 175 98 0.258253 175 99 96.748351 175 172 0.000037 175 174 -0.550529 175 175 -745.627575 175 176 0.000034 175 177 0.084114 175 250 0.284112 176 100 35016.916370 176 101 -13.238214 176 174 5.290882 176 176 -77306.764570 176 177 501.497094 176 178 5.051116 176 179 -8.666418 176 252 42279.436400 177 100 0.240609 177 101 95.850890 177 174 0.000034 177 176 -0.517636 177 177 -732.968730 177 178 0.000031 177 179 0.080296 177 252 0.268997 178 102 33846.502510 178 103 -12.889756 178 176 5.051116 178 178 -75331.936630 178 179 493.041802 178 180 4.816629 178 181 -8.260924 178 254 41475.497680 179 102 0.223548 179 103 94.806276 179 176 0.000031 179 178 -0.485499 179 179 -720.230534 179 180 0.000028 179 181 0.076619 179 254 0.254054 180 104 32674.770330 180 105 -12.546775 180 178 4.816629 180 180 -73335.718850 180 181 484.604093 180 182 4.587557 180 183 -7.870620 180 256 40651.476760 181 104 0.207066 181 105 93.612377 181 178 0.000028 181 180 -0.454118 181 181 -707.421877 181 182 0.000026 181 183 0.073088 181 256 0.239288 182 106 31501.080630 182 107 -12.211000 182 180 4.587557 182 182 -71315.578830 182 183 476.199965 182 184 4.363806 182 185 -7.495604 182 258 39805.480370 183 106 0.191157 183 107 92.267155 183 180 0.000026 183 182 -0.423493 183 183 -694.553798 183 184 0.000024 183 185 0.069706 183 258 0.224706 184 108 30326.505950 184 109 -11.884649 184 182 4.363806 184 184 -69273.502280 184 185 467.803180 184 186 4.145356 184 187 -7.136142 184 260 38938.421820 185 108 0.175829 185 109 90.772260 185 182 0.000024 185 184 -0.393650 185 185 -681.595784 185 186 0.000021 185 187 0.066476 185 260 0.210324 186 110 29149.780190 186 111 -11.553448 186 184 4.145356 186 186 -67205.200620 186 187 459.428046 186 188 3.932185 186 189 -6.792234 186 262 38047.278660 187 110 0.161071 187 111 89.123967 187 184 0.000021 187 186 -0.364581 187 187 -668.571093 187 188 0.000019 187 189 0.063398 187 262 0.196144 188 112 27971.864560 188 113 -11.220657 188 186 3.932185 188 188 -65112.352830 188 189 451.049294 188 190 3.724279 188 191 -6.463983 188 264 37132.768690 189 112 0.146889 189 113 87.323759 189 186 0.000019 189 188 -0.336305 189 189 -655.448566 189 190 0.000017 189 191 0.060475 189 264 0.182183 190 114 26791.596320 190 115 -10.888904 190 188 3.724279 190 190 -62990.713240 190 191 442.698390 190 192 3.521621 190 193 -6.151554 190 266 36191.809030 191 114 0.133276 191 115 85.368159 191 188 0.000017 191 190 -0.308818 191 191 -642.251483 191 192 0.000015 191 193 0.057709 191 266 0.168441 192 116 25609.740100 192 117 -10.545712 192 190 3.521621 192 192 -60841.525010 192 193 434.334313 192 194 3.324192 192 195 -5.854951 192 268 35224.878220 193 116 0.120232 193 117 83.258320 193 190 0.000015 193 192 -0.282138 193 193 -628.947686 193 194 0.000014 193 195 0.055101 193 268 0.154936 194 118 24425.266740 194 119 -10.193634 194 192 3.324192 194 194 -58660.448270 194 195 425.988483 194 196 3.131970 194 197 -5.574279 194 270 34228.665600 195 118 0.107753 195 119 80.990218 195 192 0.000014 195 194 -0.256260 195 195 -615.559599 195 196 0.000012 195 197 0.052652 195 270 0.141669 196 120 23238.786270 196 121 -9.836467 196 194 3.131970 196 196 -56448.265270 196 197 417.636438 196 198 2.944941 196 199 -5.309743 196 272 33203.343450 197 120 0.095841 197 121 78.564799 197 194 0.000012 197 196 -0.231202 197 197 -602.054197 197 198 0.000011 197 199 0.050366 197 272 0.128656 198 122 22049.231770 198 123 -9.461961 198 196 2.944941 198 198 -54200.475890 198 199 409.294875 198 200 2.763090 198 201 -5.061447 198 274 32145.478570 199 122 0.084489 199 123 75.978159 199 196 0.000011 199 198 -0.206964 199 199 -588.452901 199 200 0.000009 199 201 0.048245 199 274 0.115900 200 124 20857.091090 200 125 -9.072797 200 198 2.763090 200 200 -51917.243940 200 201 400.938264 200 202 2.586348 200 203 -4.829554 200 276 31054.747010 201 124 0.073702 201 125 73.230490 201 198 0.000009 201 200 -0.183563 201 201 -574.722168 201 202 0.000008 201 203 0.046292 201 276 0.103416 202 126 19661.599110 202 127 -8.667914 202 200 2.586348 202 202 -49594.877800 202 203 392.580732 202 204 2.414795 202 205 -4.614633 202 278 29928.222260 203 126 0.063477 203 127 70.318508 203 200 0.000008 203 202 -0.161004 203 203 -560.867522 203 204 0.000007 203 205 0.044512 203 278 0.091214 204 128 18461.993040 204 129 -8.237099 204 202 2.414795 204 204 -47229.350190 204 205 384.227071 204 206 2.248366 204 207 -4.417018 204 280 28762.639820 205 128 0.053815 205 129 67.238560 205 202 0.000007 205 204 -0.139300 205 205 -546.894763 205 206 0.000006 205 207 0.042913 205 280 0.079303 206 130 17258.418220 206 131 -7.776316 206 204 2.248366 206 206 -44819.772600 206 207 375.845709 206 208 2.087046 206 209 -4.237383 206 282 27556.965920 207 130 0.044721 207 131 63.989682 207 204 0.000006 207 206 -0.118471 207 207 -532.766537 207 208 0.000004 207 209 0.041501 207 282 0.067698 208 132 16049.692360 208 133 -7.278839 208 206 2.087046 208 208 -42360.259990 208 209 367.460017 208 210 1.930813 208 211 -4.076694 208 284 26306.497840 209 132 0.036199 209 133 60.566179 209 206 0.000004 209 208 -0.098534 209 209 -518.499980 209 210 0.000004 209 211 0.040290 209 284 0.056413 210 134 14835.525040 210 135 -6.727998 210 208 1.930813 210 210 -39848.397190 210 211 359.026605 210 212 1.779652 210 213 -3.936254 210 286 25009.110880 211 134 0.028255 211 135 56.965121 211 208 0.000004 211 210 -0.079469 211 211 -504.053548 211 212 0.000003 211 213 0.039296 211 286 0.045423 212 136 13614.420160 212 137 -6.109805 212 210 1.779652 212 212 -37277.016850 212 213 350.562824 212 214 1.633547 212 215 -3.818052 212 288 23659.133800 213 136 0.020905 213 137 53.179417 213 210 0.000003 213 212 -0.061367 213 213 -489.440665 213 214 0.000002 213 215 0.038543 213 288 0.034801 214 138 12385.522920 214 139 -5.394960 214 212 1.633547 214 214 -34641.440440 214 215 342.012604 214 216 1.492480 214 217 -3.724984 214 290 22252.742910 215 138 0.014170 215 139 49.203091 215 212 0.000002 215 214 -0.044271 215 215 -474.613309 215 216 0.000001 215 217 0.038068 215 290 0.024570 216 140 11146.701440 216 141 -4.540912 216 214 1.492480 216 216 -31931.772470 216 217 333.372056 216 218 1.356430 216 219 -3.661596 216 292 20782.174670 217 140 0.008062 217 141 45.025299 217 214 0.000001 217 216 -0.027986 217 217 -459.576523 217 218 0.000000 217 219 0.037926 217 292 0.014523 218 142 9895.967047 218 143 -3.489743 218 216 1.356430 218 218 -29138.900270 218 219 324.561387 218 220 1.225349 218 294 19240.305110 219 142 0.002637 219 143 40.634274 219 216 0.000000 219 218 -0.012869 219 219 -444.269588 219 294 0.004961 220 144 8629.567670 220 218 1.225349 220 220 -26246.319020 220 221 308.959187 220 222 1.099214 220 296 17614.381580 221 220 -0.005143 221 221 -358.240525 222 146 7343.203814 222 220 1.099214 222 222 -23234.897440 222 223 301.304207 222 224 0.978023 222 298 15889.572290 223 222 -0.005015 223 223 -349.325680 224 148 6029.946712 224 222 0.978023 224 224 -20073.111500 224 225 293.668450 224 226 0.849142 224 227 -4.543279 224 300 14041.294650 225 224 -0.005034 225 225 -340.430578 225 226 0.000148 225 227 0.050787 226 150 4609.065822 226 224 0.849142 226 226 -14827.401190 226 227 311.666099 226 302 10217.444600 226 303 -22.183398 227 150 2.259662 227 151 20.242283 227 224 0.000148 227 226 -4.327037 227 227 -379.064760 227 302 2.062386 228 152 50640.055220 228 153 -14.955642 228 228 -52368.687170 228 229 8215.298735 228 230 1723.156682 228 231 -2996.510079 228 304 6.031542 228 305 -23.644221 229 152 0.457677 229 153 220.371978 229 228 -0.561655 229 229 -6022.333554 229 230 0.017774 229 231 27.510409 229 304 0.000059 229 305 0.242700 230 154 50021.484310 230 155 -22.013766 230 228 1723.156682 230 230 -53428.104500 230 231 8138.564103 230 232 1675.470517 230 233 -2917.661582 230 306 7.240671 230 307 -27.890206 231 154 0.441677 231 155 217.252849 231 228 0.017774 231 230 -0.562309 231 231 -6004.200646 231 232 0.016802 231 233 26.826518 231 306 0.000068 231 307 0.285862 232 156 49389.433520 232 157 -21.224763 232 230 1675.470517 232 232 -52702.034270 232 233 8050.931467 232 234 1628.041461 232 235 -2836.228399 232 308 8.337736 232 309 -31.264149 233 156 0.425627 233 157 213.998603 233 230 0.016802 233 232 -0.544192 233 233 -5992.889403 233 234 0.015858 233 235 26.110689 233 308 0.000077 233 309 0.319585 234 158 48745.607380 234 159 -20.413456 234 232 1628.041461 234 234 -51964.655400 234 235 7960.693728 234 236 1580.868761 234 237 -2752.904179 234 310 9.388046 234 311 -33.995489 235 158 0.409597 235 159 210.703648 235 232 0.015858 235 234 -0.526153 235 235 -5981.523826 235 236 0.014943 235 237 25.370111 235 310 0.000084 235 311 0.346174 236 160 48087.428660 236 161 -19.656087 236 234 1580.868761 236 236 -51213.368680 236 237 7868.579659 236 238 1533.953234 236 239 -2668.357786 236 312 10.369551 236 313 -36.033640 237 160 0.393596 237 161 207.360660 237 234 0.014943 237 236 -0.508201 237 237 -5970.152137 237 238 0.014058 237 239 24.613091 237 312 0.000090 237 313 0.365130 238 162 47416.476780 238 163 -18.965362 238 236 1533.953234 238 238 -50449.734330 238 239 7775.222226 238 240 1487.293709 238 241 -2583.249163 238 314 11.263414 238 315 -37.375724 239 162 0.377658 239 163 203.974427 239 236 0.014058 239 238 -0.490369 239 239 -5958.741110 239 240 0.013202 239 241 23.846460 239 314 0.000095 239 315 0.376492 240 164 46730.117860 240 165 -18.320120 240 238 1487.293709 240 240 -49671.174460 240 241 7681.316704 240 242 1440.890320 240 243 -2498.009654 240 316 12.126663 240 317 -38.272971 241 164 0.361787 241 165 200.536346 241 238 0.013202 241 240 -0.472662 241 241 -5947.338746 241 242 0.012376 241 243 23.075756 241 316 0.000099 241 317 0.382861 242 166 46029.905510 242 167 -17.725958 242 240 1440.890320 242 242 -48879.220080 242 243 7587.258703 242 244 1394.741673 242 245 -2413.071221 242 318 12.937951 242 319 -38.722370 243 166 0.346015 243 167 197.051130 243 240 0.012376 243 242 -0.455110 243 243 -5935.909152 243 244 0.011578 243 245 22.305443 243 318 0.000102 243 319 0.384294 244 168 45313.148920 244 169 -17.186467 244 242 1394.741673 244 244 -48071.159750 244 245 7493.515667 244 246 1348.847402 244 247 -2328.847267 244 320 13.678410 244 321 -38.741223 245 168 0.330342 245 169 193.510282 245 242 0.011578 245 244 -0.437716 245 245 -5924.498061 245 246 0.010810 245 247 21.540681 245 320 0.000105 245 321 0.381068 246 170 44581.248800 246 171 -16.677055 246 244 1348.847402 246 246 -47248.443450 246 247 7400.465420 246 248 1303.206173 246 249 -2245.577119 246 322 14.399018 246 323 -38.531188 247 170 0.314797 247 171 189.917634 247 244 0.010810 247 246 -0.420505 247 247 -5913.069303 247 248 0.010070 247 249 20.784009 247 322 0.000107 247 323 0.375257 248 172 43831.480530 248 173 -16.208986 248 246 1303.206173 248 248 -46408.301920 248 249 7308.382912 248 250 1257.817245 248 251 -2163.550146 248 324 15.057197 248 325 -38.033518 249 172 0.299379 249 173 186.264693 249 246 0.010070 249 248 -0.403479 249 249 -5901.666775 249 250 0.009358 249 251 20.039025 249 324 0.000108 249 325 0.366381 250 174 43065.109450 250 175 -15.760972 250 248 1257.817245 250 250 -45552.044080 250 251 7217.522050 250 252 1212.676996 250 253 -2082.916311 250 326 15.700910 250 327 -37.411347 251 174 0.284112 251 175 182.554873 251 248 0.009358 251 250 -0.386658 251 251 -5890.252822 251 252 0.008674 251 253 19.307307 251 326 0.000108 251 327 0.356090 252 176 42279.436400 252 177 -15.331877 252 250 1212.676996 252 252 -44676.950570 252 253 7128.050762 252 254 1167.788778 252 255 -2003.841489 252 328 16.310207 252 329 -36.651443 253 176 0.268997 253 177 178.779138 253 250 0.008674 253 252 -0.370045 253 253 -5878.849801 253 254 0.008018 253 255 18.591052 253 328 0.000108 253 329 0.344324 254 178 41475.497680 254 179 -14.924713 254 252 1167.788778 254 254 -43784.039700 254 255 7040.152943 254 256 1123.148985 254 257 -1926.493623 254 330 16.867340 254 331 -35.749809 255 178 0.254054 255 179 174.942026 255 252 0.008018 255 254 -0.353658 255 255 -5867.480720 255 256 0.007388 255 257 17.892136 255 330 0.000108 255 331 0.331124 256 180 40651.476760 256 181 -14.522762 256 254 1123.148985 256 256 -42871.533330 256 257 6953.961247 256 258 1078.756324 256 259 -1850.946096 256 332 17.415641 256 333 -34.818528 257 180 0.239288 257 181 171.035872 257 254 0.007388 257 256 -0.337501 257 257 -5856.106317 257 258 0.006786 257 259 17.211493 257 332 0.000107 257 333 0.317572 258 182 39805.480370 258 183 -14.127338 258 256 1078.756324 258 258 -41937.516960 258 259 6869.585012 258 260 1034.609557 258 261 -1777.292026 258 334 17.936372 258 335 -33.835923 259 182 0.224706 259 183 167.055151 259 256 0.006786 259 258 -0.321580 259 259 -5844.769095 259 260 0.006209 259 261 16.550314 259 334 0.000105 259 335 0.303512 260 184 38938.421820 260 185 -13.740552 260 258 1034.609557 260 260 -40982.884150 260 261 6787.082178 260 262 990.707336 260 263 -1705.636338 260 336 18.412392 260 337 -32.787541 261 184 0.210324 261 185 163.002398 261 258 0.006209 261 260 -0.305911 261 261 -5833.429178 261 262 0.005659 261 263 15.909930 261 336 0.000103 261 337 0.288861 262 186 38047.278660 262 187 -13.347917 262 260 990.707336 262 262 -40004.649780 262 263 6706.593792 262 264 947.048153 262 265 -1636.019481 262 338 18.883883 262 339 -31.750834 263 186 0.196144 263 187 158.867763 263 260 0.005659 263 262 -0.290496 263 263 -5822.129572 263 264 0.005134 263 265 15.290846 263 338 0.000101 263 339 0.274318 264 188 37132.768690 264 189 -12.952607 264 262 947.048153 264 264 -39003.510970 264 265 6628.125280 264 266 903.630738 264 267 -1568.501998 264 340 19.332921 264 341 -30.700510 265 188 0.182183 265 189 154.653136 265 262 0.005134 265 264 -0.275348 265 265 -5810.829815 265 266 0.004634 265 267 14.693909 265 340 0.000098 265 341 0.259682 266 190 36191.809030 266 191 -12.557442 266 264 903.630738 266 266 -37976.365940 266 267 6551.773496 266 268 860.453639 266 269 -1503.156950 266 342 19.743358 266 343 -29.618731 267 190 0.168441 267 191 150.348680 267 264 0.004634 267 266 -0.260471 267 267 -5799.572556 267 268 0.004159 267 269 14.119993 267 342 0.000095 267 343 0.244827 268 192 35224.878220 268 193 -12.149675 268 266 860.453639 268 268 -36923.727380 268 269 6477.576697 268 270 817.515639 268 271 -1440.013150 268 344 20.151996 268 345 -28.559844 269 192 0.154936 269 193 145.955284 269 266 0.004159 269 268 -0.245877 269 269 -5788.317838 269 270 0.003708 269 271 13.569647 269 344 0.000091 269 345 0.230202 270 194 34228.665600 270 195 -11.732155 270 268 817.515639 270 270 -35842.265000 270 271 6405.600274 270 272 774.815109 270 273 -1379.116322 270 346 20.542048 270 347 -27.500693 271 194 0.141669 271 195 141.462239 271 268 0.003708 271 270 -0.231570 271 271 -5777.108184 271 272 0.003281 271 273 13.043411 271 346 0.000087 271 347 0.215622 272 196 33203.343450 272 197 -11.308752 272 270 774.815109 272 272 -34732.131060 272 273 6335.855434 272 274 732.349255 272 275 -1320.521526 272 348 20.897940 272 349 -26.424859 273 196 0.128656 273 197 136.869563 273 270 0.003281 273 272 -0.217563 273 273 -5765.903492 273 274 0.002877 273 275 12.542032 273 348 0.000083 273 349 0.200979 274 198 32145.478570 274 199 -10.867360 274 272 732.349255 274 274 -33589.925560 274 275 6268.416389 274 276 690.119425 274 277 -1264.249967 274 350 21.254287 274 351 -25.374535 275 198 0.115900 275 199 132.165526 275 272 0.002877 275 274 -0.203860 275 275 -5754.726049 275 276 0.002497 275 277 12.065914 275 350 0.000078 275 351 0.186588 276 200 31054.747010 276 201 -10.410772 276 274 690.119425 276 276 -32415.306810 276 277 6203.323739 276 278 648.122674 276 279 -1210.333382 276 352 21.594975 276 353 -24.332574 277 200 0.103416 277 201 127.349621 277 274 0.002497 277 276 -0.190476 277 277 -5743.597961 277 278 0.002139 277 279 11.615514 277 352 0.000073 277 353 0.172332 278 202 29928.222260 278 203 -9.938584 278 276 648.122674 278 278 -31205.329160 278 279 6140.575450 278 280 606.357435 278 281 -1158.809487 278 354 21.905339 278 355 -23.289495 279 202 0.091214 279 203 122.410752 279 276 0.002139 279 278 -0.177417 279 279 -5732.479520 279 280 0.001804 279 281 11.191359 279 354 0.000068 279 355 0.158180 280 204 28762.639820 280 205 -9.440625 280 278 606.357435 280 280 -29956.756790 280 281 6080.247175 280 282 564.822036 280 283 -1109.683529 280 356 22.217339 280 357 -22.283444 281 204 0.079303 281 205 117.338074 281 278 0.001804 281 280 -0.164694 281 281 -5721.414102 281 282 0.001491 281 283 10.793700 281 356 0.000062 281 357 0.144413 282 206 27556.965920 282 207 -8.913370 282 280 564.822036 282 282 -28668.537240 282 283 6022.311256 282 284 523.514572 282 285 -1062.964682 282 358 22.515834 282 359 -21.309753 283 206 0.067698 283 207 112.127239 283 280 0.001491 283 282 -0.152322 283 283 -5710.362352 283 284 0.001201 283 285 10.422725 283 358 0.000055 283 359 0.131059 284 208 26306.497840 284 209 -8.350803 284 282 523.514572 284 284 -27335.949750 284 285 5966.815944 284 286 482.433133 284 287 -1018.658087 284 360 22.786607 284 361 -20.373259 285 208 0.056413 285 209 106.762148 285 282 0.001201 285 284 -0.140313 285 285 -5699.368041 285 286 0.000933 285 287 10.078677 285 360 0.000048 285 361 0.118250 286 210 25009.110880 286 211 -7.736886 286 284 482.433133 286 286 -25956.895540 286 287 5913.734948 286 288 441.575254 286 289 -976.731971 286 362 23.059953 286 363 -19.521182 287 210 0.045423 287 211 101.234216 287 284 0.000933 287 286 -0.128644 287 287 -5688.392757 287 288 0.000687 287 289 9.761269 287 362 0.000041 287 363 0.106388 288 212 23659.133800 288 213 -7.058848 288 286 441.575254 288 288 -24525.669410 288 289 5863.077567 288 290 400.938157 288 291 -937.151267 288 364 23.307145 288 365 -18.762872 289 212 0.034801 289 213 95.523558 289 286 0.000687 289 288 -0.117385 289 289 -5677.481079 289 290 0.000463 289 291 9.470343 289 364 0.000033 289 365 0.095740 290 214 22252.742910 290 215 -6.286833 290 288 400.938157 290 290 -23038.469430 290 291 5814.779987 290 292 360.517784 290 293 -899.839321 290 366 23.556793 290 367 -18.161548 291 214 0.024570 291 215 89.615022 291 288 0.000463 291 290 -0.106563 291 291 -5666.595925 291 292 0.000263 291 293 9.205093 291 366 0.000024 291 367 0.086906 292 216 20782.174670 292 217 -5.385045 292 290 360.517784 292 292 -21487.508500 292 293 5768.810452 292 294 320.308810 292 295 -864.699902 292 368 23.794713 292 369 -17.760989 293 216 0.014523 293 217 83.480199 293 290 0.000263 293 292 -0.095971 293 293 -5655.783814 293 294 0.000086 293 295 8.964712 293 368 0.000014 293 369 0.080488 294 218 19240.305110 294 219 -4.297088 294 292 320.308810 294 294 -19865.630010 294 295 5725.049514 294 296 280.297271 294 370 24.007555 294 371 -17.612535 295 218 0.004961 295 219 77.091043 295 292 0.000086 295 294 -0.085976 295 295 -5645.010580 295 370 0.000003 295 371 0.077183 296 220 17614.381580 296 294 280.297271 296 296 -18160.080100 296 297 4851.817578 296 298 240.470129 296 372 24.221094 297 296 -0.080768 297 297 -5625.579835 298 222 15889.572290 298 296 240.470129 298 298 -16355.972260 298 299 4843.365598 298 300 200.799798 298 301 -771.465396 298 374 24.421239 299 298 -0.080728 299 299 -5615.156137 299 300 0.000119 299 301 8.386128 300 224 14041.294650 300 298 200.799798 300 300 -14404.405270 300 301 5606.518652 300 302 137.008495 300 303 -781.854366 300 376 24.594787 301 298 0.000119 301 300 -0.396048 301 301 -5613.208481 301 302 0.315447 301 303 61.864792 302 226 10217.444600 302 300 137.008495 302 302 -10379.877750 302 303 5631.194603 302 378 24.760485 303 226 2.062386 303 227 47.482514 303 300 0.315447 303 302 -2.521061 303 303 -5656.784620 303 378 0.048478 304 228 6.031542 304 304 -12.037723 304 305 236.845729 304 306 0.002036 304 307 -0.003401 304 380 5.972952 304 381 -22.326975 305 228 0.000059 305 304 -0.003678 305 305 -248.035101 305 306 0.000000 305 307 0.000031 305 380 0.000054 305 381 0.218127 306 230 7.240671 306 304 0.002036 306 306 -14.436427 306 307 248.811439 306 308 0.002572 306 309 -0.004215 306 382 7.158826 306 383 -26.528130 307 230 0.000068 307 304 0.000000 307 306 -0.003825 307 307 -257.029022 307 308 0.000000 307 309 0.000038 307 382 0.000063 307 383 0.259599 308 232 8.337736 308 306 0.002572 308 308 -16.608237 308 309 259.904469 308 310 0.003135 308 311 -0.005058 308 384 8.231342 308 385 -29.857367 309 232 0.000077 309 306 0.000000 309 308 -0.003969 309 309 -266.014740 309 310 0.000000 309 311 0.000046 309 384 0.000071 309 385 0.292012 310 234 9.388046 310 308 0.003135 310 310 -18.684480 310 311 270.356913 310 312 0.003734 310 313 -0.005956 310 386 9.254983 310 387 -32.546808 311 234 0.000084 311 308 0.000000 311 310 -0.004111 311 311 -274.994606 311 312 0.000000 311 313 0.000054 311 386 0.000077 311 387 0.317588 312 236 10.369551 312 310 0.003734 312 312 -20.621979 312 313 280.121841 312 314 0.004359 312 315 -0.006899 312 388 10.208622 312 389 -34.545977 313 236 0.000090 313 310 0.000000 313 312 -0.004252 313 313 -283.972301 313 314 0.000000 313 315 0.000062 313 388 0.000083 313 389 0.335841 314 238 11.263414 314 312 0.004359 314 314 -22.384078 314 315 289.189313 314 316 0.005012 314 317 -0.007891 314 390 11.074452 314 391 -35.852088 315 238 0.000095 315 312 0.000000 315 314 -0.004390 315 315 -292.939641 315 316 0.000000 315 317 0.000071 315 390 0.000087 315 391 0.346809 316 240 12.126663 316 314 0.005012 316 316 -24.083452 316 317 297.814168 316 318 0.005701 316 319 -0.008952 316 392 11.908104 316 393 -36.716337 317 240 0.000099 317 314 0.000000 317 316 -0.004526 317 317 -301.903389 317 318 0.000000 317 319 0.000081 317 392 0.000091 317 393 0.353021 318 242 12.937951 318 316 0.005701 318 318 -25.678276 318 319 305.993466 318 320 0.006415 318 321 -0.010067 318 394 12.689104 318 395 -37.135800 319 242 0.000102 319 316 0.000000 319 318 -0.004662 319 319 -310.863634 319 320 0.000000 319 321 0.000091 319 394 0.000094 319 395 0.354542 320 244 13.678410 320 318 0.006415 320 320 -27.131776 320 321 313.744539 320 322 0.007157 320 323 -0.011238 320 396 13.399557 320 397 -37.127812 321 244 0.000105 321 318 0.000000 321 320 -0.004795 321 321 -319.820685 321 322 0.000000 321 323 0.000101 321 396 0.000097 321 397 0.351652 322 246 14.399018 322 320 0.007157 322 322 -28.544168 322 323 321.269076 322 324 0.007931 322 325 -0.012475 322 398 14.088694 322 399 -36.894054 323 246 0.000107 323 320 0.000000 323 322 -0.004927 323 323 -328.776632 323 324 0.000000 323 325 0.000113 323 398 0.000098 323 399 0.346374 324 248 15.057197 324 322 0.007931 324 324 -29.832134 324 325 328.511937 324 326 0.008733 324 327 -0.013770 324 400 14.715772 324 401 -36.375870 325 248 0.000108 325 322 0.000000 325 324 -0.005058 325 325 -337.735153 325 326 0.000000 325 327 0.000125 325 400 0.000099 325 401 0.338248 326 250 15.700910 326 324 0.008733 326 326 -31.089679 326 327 335.629150 326 328 0.009571 326 329 -0.015141 326 402 15.326832 326 403 -35.736479 327 250 0.000108 327 324 0.000000 327 326 -0.005188 327 327 -346.689645 327 328 0.000000 327 329 0.000137 327 402 0.000100 327 403 0.328887 328 252 16.310207 328 326 0.009571 328 328 -32.277782 328 329 342.611091 328 330 0.010433 328 331 -0.016570 328 404 15.902805 328 405 -34.962775 329 252 0.000108 329 326 0.000000 329 328 -0.005316 329 329 -355.644200 329 330 0.000000 329 331 0.000151 329 404 0.000100 329 405 0.318237 330 254 16.867340 330 328 0.010433 330 330 -33.361884 330 331 349.453769 330 332 0.011324 330 333 -0.018061 330 406 16.426888 330 407 -34.050858 331 254 0.000108 331 328 0.000000 331 330 -0.005444 331 331 -364.598875 331 332 0.000000 331 333 0.000165 331 406 0.000099 331 407 0.306332 332 256 17.415641 332 330 0.011324 332 332 -34.426528 332 333 356.269295 332 334 0.012250 332 335 -0.019637 332 408 16.940281 332 409 -33.112919 333 256 0.000107 333 330 0.000000 333 332 -0.005570 333 333 -373.554768 333 334 0.000000 333 335 0.000179 333 408 0.000098 333 409 0.294239 334 258 17.936372 334 332 0.012250 334 334 -35.435103 334 335 363.036044 334 336 0.013200 334 337 -0.021281 334 410 17.425113 334 411 -32.127462 335 258 0.000105 335 332 0.000000 335 334 -0.005696 335 335 -382.511741 335 336 0.000000 335 337 0.000195 335 410 0.000097 335 411 0.281800 336 260 18.412392 336 334 0.013200 336 336 -36.354234 336 337 369.743142 336 338 0.014179 336 339 -0.023002 336 412 17.865162 336 413 -31.080139 337 260 0.000103 337 334 0.000000 337 336 -0.005821 337 337 -391.473869 337 338 0.000000 337 339 0.000211 337 412 0.000095 337 413 0.268925 338 262 18.883883 338 336 0.014179 338 338 -37.261931 338 339 376.460964 338 340 0.015193 338 341 -0.024828 338 414 18.298240 338 415 -30.048566 339 262 0.000101 339 336 0.000000 339 338 -0.005945 339 339 -400.433603 339 340 0.000000 339 341 0.000229 339 414 0.000093 339 415 0.256313 340 264 19.332921 340 338 0.015193 340 340 -38.123148 340 341 383.167853 340 342 0.016230 340 343 -0.026747 340 416 18.707233 340 417 -29.007628 341 264 0.000098 341 338 0.000000 341 340 -0.006068 341 341 -409.394908 341 342 0.000000 341 343 0.000247 341 416 0.000090 341 417 0.243756 342 266 19.743358 342 340 0.016230 342 342 -38.906419 342 343 389.846020 342 344 0.017295 342 345 -0.028778 342 418 19.076830 342 419 -27.939603 343 266 0.000095 343 340 0.000000 343 342 -0.006191 343 343 -418.357696 343 344 0.000000 343 345 0.000267 343 418 0.000087 343 419 0.231118 344 268 20.151996 344 342 0.017295 344 344 -39.682684 344 345 396.549896 344 346 0.018396 344 347 -0.030961 344 420 19.441155 344 421 -26.898964 345 268 0.000091 345 342 0.000000 345 344 -0.006312 345 345 -427.322458 345 346 0.000000 345 347 0.000288 345 420 0.000083 345 421 0.218858 346 270 20.542048 346 344 0.018396 346 346 -40.419004 346 347 403.256451 346 348 0.019519 346 349 -0.033293 346 422 19.784062 346 423 -25.862727 347 270 0.000087 347 344 0.000000 347 346 -0.006433 347 347 -436.289067 347 348 0.000000 347 349 0.000312 347 422 0.000080 347 423 0.206787 348 272 20.897940 348 346 0.019519 348 348 -41.084851 348 349 409.952938 348 350 0.020669 348 351 -0.035811 348 424 20.090606 348 425 -24.814546 349 272 0.000083 349 346 0.000000 349 348 -0.006554 349 349 -445.261620 349 350 0.000000 349 351 0.000337 349 424 0.000075 349 425 0.194778 350 274 21.254287 350 348 0.020669 350 350 -41.746229 350 351 416.674585 350 352 0.021856 350 353 -0.038574 350 426 20.392163 350 427 -23.796722 351 274 0.000078 351 348 0.000000 351 350 -0.006673 351 351 -454.232242 351 352 0.000000 351 353 0.000365 351 426 0.000071 351 427 0.183174 352 276 21.594975 352 350 0.021856 352 352 -42.371120 352 353 423.408031 352 354 0.023063 352 355 -0.041604 352 428 20.672834 352 429 -22.792214 353 276 0.000073 353 350 0.000000 353 352 -0.006792 353 353 -463.205059 353 354 0.000000 353 355 0.000396 353 428 0.000066 353 429 0.171847 354 278 21.905339 354 352 0.023063 354 354 -42.930185 354 355 430.144022 354 356 0.024298 354 357 -0.044974 354 430 20.917955 354 431 -21.791539 355 278 0.000068 355 352 0.000000 355 354 -0.006910 355 355 -472.180170 355 356 0.000000 355 357 0.000431 355 430 0.000061 355 431 0.160748 356 280 22.217339 356 354 0.024298 356 356 -43.482943 356 357 436.921022 356 358 0.025568 356 359 -0.048789 356 432 21.155070 356 433 -20.832813 357 280 0.000062 357 354 0.000000 357 356 -0.007027 357 357 -481.158015 357 358 0.000000 357 359 0.000471 357 432 0.000055 357 433 0.150196 358 282 22.515834 358 356 0.025568 358 358 -43.997976 358 359 443.734784 358 360 0.026858 358 361 -0.053130 358 434 21.367908 358 435 -19.911337 359 282 0.000055 359 356 0.000000 359 358 -0.007143 359 359 -490.138828 359 360 0.000000 359 361 0.000518 359 434 0.000049 359 435 0.140207 360 284 22.786607 360 358 0.026858 360 360 -44.444974 360 361 450.594193 360 362 0.028174 360 363 -0.058152 360 436 21.540386 360 437 -19.031721 361 284 0.000048 361 358 0.000000 361 360 -0.007259 361 361 -499.127139 361 362 0.000000 361 363 0.000573 361 436 0.000042 361 437 0.130901 362 286 23.059953 362 360 0.028174 362 362 -44.876559 362 363 457.539987 362 364 0.029517 362 365 -0.064066 362 438 21.694826 362 439 -18.240888 363 286 0.000041 363 360 0.000000 363 362 -0.007373 363 363 -508.115392 363 364 0.000000 363 365 0.000638 363 438 0.000035 363 439 0.122731 364 288 23.307145 364 362 0.029517 364 364 -45.230920 364 365 464.585949 364 366 0.030885 364 367 -0.071141 364 440 21.798143 364 441 -17.547673 365 288 0.000033 365 362 0.000000 365 364 -0.007486 365 365 -517.108418 365 366 0.000000 365 367 0.000717 365 440 0.000028 365 441 0.115940 366 290 23.556793 366 364 0.030885 366 366 -45.549990 366 367 471.796409 366 368 0.032287 366 369 -0.079799 366 442 21.863651 366 443 -17.014420 367 290 0.000024 367 364 0.000000 367 366 -0.007597 367 367 -526.107364 367 368 0.000000 367 369 0.000815 367 442 0.000019 367 443 0.111206 368 292 23.794713 368 366 0.032287 368 368 -45.786805 368 369 479.216695 368 370 0.033705 368 371 -0.090562 368 444 21.858582 368 445 -16.683680 369 292 0.000014 369 366 0.000000 369 368 -0.007707 369 369 -535.113562 369 370 0.000000 369 371 0.000938 369 444 0.000010 369 445 0.109167 370 294 24.007555 370 368 0.033705 370 370 -45.879931 370 371 486.900191 370 372 0.035144 370 446 21.734865 370 447 -16.604544 371 294 0.000003 371 368 0.000000 371 370 -0.007815 371 371 -544.128695 371 446 0.000000 371 447 0.110595 372 296 24.221094 372 370 0.035144 372 372 -45.800258 372 373 477.029373 372 374 0.036613 372 448 21.437598 373 372 -0.007941 373 373 -553.076032 374 298 24.421239 374 372 0.036613 374 374 -45.336391 374 375 484.879246 374 376 0.038091 374 450 20.769488 375 374 -0.008069 375 375 -562.114664 376 300 24.594787 376 374 0.038091 376 376 -43.865179 376 377 492.743584 376 378 0.039576 376 452 19.120614 377 376 -0.008198 377 377 -571.160771 378 302 24.760485 378 376 0.039576 378 378 -37.717528 378 379 500.644518 378 454 12.844199 379 302 0.048478 379 303 0.154136 379 378 -0.056805 379 379 -580.230449 380 304 5.972952 380 380 -773.236932 380 381 3027.958916 380 382 11.080394 380 383 -18.152243 380 456 755.755239 380 457 -4.450228 381 304 0.000054 381 380 -0.056942 381 381 -3476.688120 381 382 0.000098 381 383 0.165456 381 456 0.006883 382 306 7.158826 382 380 11.080394 382 382 -777.424808 382 383 2975.144362 382 384 10.566793 382 385 -16.491571 382 458 748.190030 382 459 -8.975522 383 306 0.000063 383 380 0.000098 383 382 -0.055848 383 383 -3412.059534 383 384 0.000091 383 385 0.148540 383 458 0.006619 384 308 8.231342 384 382 10.566793 384 384 -769.699828 384 385 2921.505494 384 386 10.065692 384 387 -15.126575 384 460 740.415325 384 461 -12.453011 385 308 0.000071 385 382 0.000091 385 384 -0.054659 385 385 -3347.458840 385 386 0.000084 385 387 0.134939 385 460 0.006366 386 310 9.254983 386 384 10.065692 386 386 -761.721988 386 387 2867.496784 386 388 9.576996 386 389 -14.005022 386 462 732.411736 386 463 -15.383478 387 310 0.000077 387 384 0.000084 387 386 -0.053478 387 387 -3282.842558 387 388 0.000078 387 389 0.124061 387 462 0.006122 388 312 10.208622 388 386 9.576996 388 388 -753.453222 388 389 2813.026009 388 390 9.100562 388 391 -13.069734 388 464 724.162556 388 465 -17.712913 389 312 0.000083 389 386 0.000078 389 388 -0.052303 389 389 -3218.220621 389 390 0.000072 389 391 0.115262 389 464 0.005884 390 314 11.074452 390 388 9.100562 390 390 -744.850946 390 391 2758.021591 390 392 8.636264 390 393 -12.267498 390 466 715.643282 390 467 -19.427518 391 314 0.000087 391 388 0.000072 391 390 -0.051133 391 391 -3153.577612 391 392 0.000066 391 393 0.107929 391 466 0.005650 392 316 11.908104 392 390 8.636264 392 392 -735.953749 392 393 2702.690508 392 394 8.184080 392 395 -11.569487 392 468 706.837019 392 469 -20.748244 393 316 0.000091 393 390 0.000066 393 392 -0.049965 393 393 -3088.922304 393 394 0.000061 393 395 0.101740 393 468 0.005420 394 318 12.689104 394 392 8.184080 394 394 -726.720995 394 395 2647.002488 394 396 7.743977 394 397 -10.947038 394 470 697.723657 394 471 -21.666893 395 318 0.000094 395 392 0.000061 395 394 -0.048799 395 395 -3024.255381 395 396 0.000056 395 397 0.096363 395 470 0.005191 396 320 13.399557 396 394 7.743977 396 396 -717.118510 396 397 2590.947272 396 398 7.315883 396 399 -10.373992 396 472 688.287023 396 473 -22.194202 397 320 0.000097 397 394 0.000056 397 396 -0.047635 397 397 -2959.577281 397 398 0.000051 397 399 0.091501 397 472 0.004965 398 322 14.088694 398 396 7.315883 398 398 -707.164153 398 399 2534.701016 398 400 6.899743 398 401 -9.840577 398 474 678.495874 398 475 -22.512314 399 322 0.000098 399 396 0.000051 399 398 -0.046471 399 399 -2894.887820 399 400 0.000047 399 401 0.087040 399 474 0.004739 400 324 14.715772 400 398 6.899743 400 400 -696.796476 400 401 2478.202907 400 402 6.495541 400 403 -9.331330 400 476 668.329571 400 477 -22.565535 401 324 0.000099 401 398 0.000047 401 400 -0.045308 401 401 -2830.195545 401 402 0.000042 401 403 0.082806 401 476 0.004514 402 326 15.326832 402 400 6.495541 402 402 -686.040406 402 403 2421.586671 402 404 6.103232 402 405 -8.842820 402 478 657.767067 402 479 -22.503155 403 326 0.000100 403 400 0.000042 403 402 -0.044146 403 403 -2765.483608 403 404 0.000038 403 405 0.078756 403 478 0.004290 404 328 15.902805 404 402 6.103232 404 404 -674.847792 404 405 2364.843052 404 406 5.722824 404 407 -8.370003 404 480 646.779314 404 481 -22.311978 405 328 0.000100 405 402 0.000038 405 404 -0.042984 405 405 -2700.760272 405 406 0.000035 405 407 0.074834 405 480 0.004066 406 330 16.426888 406 404 5.722824 406 406 -663.177743 406 407 2307.963164 406 408 5.354259 406 409 -7.907460 406 482 635.342273 406 483 -21.987130 407 330 0.000099 407 404 0.000035 407 406 -0.041822 407 407 -2636.025449 407 408 0.000031 407 409 0.070977 407 482 0.003843 408 332 16.940281 408 406 5.354259 408 408 -651.029180 408 409 2251.053718 408 410 4.997489 408 411 -7.456465 408 484 623.413772 408 485 -21.633069 409 332 0.000098 409 406 0.000031 409 408 -0.040662 409 409 -2571.278591 409 410 0.000028 409 411 0.067200 409 484 0.003621 410 334 17.425113 410 408 4.997489 410 410 -638.354239 410 411 2194.094465 410 412 4.652516 410 413 -7.016435 410 486 610.963866 410 487 -21.229237 411 334 0.000097 411 408 0.000028 411 410 -0.039502 411 411 -2506.519581 411 412 0.000025 411 413 0.063498 411 486 0.003400 412 336 17.865162 412 410 4.652516 412 412 -625.096198 412 413 2137.077551 412 414 4.319304 412 415 -6.585809 412 488 597.952084 412 489 -20.761400 413 336 0.000095 413 410 0.000025 413 412 -0.038344 413 413 -2441.756461 413 414 0.000022 413 415 0.059851 413 488 0.003180 414 338 18.298240 414 412 4.319304 414 414 -611.254292 414 415 2080.064693 414 416 3.997816 414 417 -6.166994 414 490 584.339927 414 491 -20.302542 415 338 0.000093 415 412 0.000022 415 414 -0.037187 415 415 -2376.972189 415 416 0.000019 415 417 0.056289 415 490 0.002961 416 340 18.707233 416 414 3.997816 416 416 -596.762447 416 417 2023.040281 416 418 3.688053 416 419 -5.760661 416 492 570.078469 416 493 -19.828506 417 340 0.000090 417 414 0.000019 417 416 -0.036032 417 417 -2312.174786 417 418 0.000017 417 419 0.052819 417 492 0.002745 418 342 19.076830 418 416 3.688053 418 418 -581.558891 418 419 1965.987259 418 420 3.389959 418 421 -5.366433 418 494 555.121304 418 495 -19.321859 419 342 0.000087 419 416 0.000017 419 418 -0.034878 419 419 -2247.364030 419 420 0.000015 419 421 0.049437 419 494 0.002530 420 344 19.441155 420 418 3.389959 420 420 -565.607682 420 421 1908.959711 420 422 3.103489 420 423 -4.986287 420 496 539.398467 420 497 -18.833931 421 344 0.000083 421 418 0.000015 421 420 -0.033727 421 421 -2182.539272 421 422 0.000012 421 423 0.046168 421 496 0.002317 422 346 19.784062 422 420 3.103489 422 422 -548.833339 422 423 1851.936696 422 424 2.828636 422 425 -4.620831 422 498 522.850675 422 499 -18.342274 423 346 0.000080 423 420 0.000012 423 422 -0.032578 423 423 -2117.700248 423 424 0.000011 423 425 0.043018 423 498 0.002107 424 348 20.090606 424 422 2.828636 424 424 -531.145813 424 425 1794.909710 424 426 2.565362 424 427 -4.269798 424 500 505.402869 424 501 -17.830485 425 348 0.000075 425 422 0.000011 425 424 -0.031433 425 425 -2052.854869 425 426 0.000009 425 427 0.039986 425 500 0.001900 426 350 20.392163 426 424 2.565362 426 426 -512.497894 426 427 1737.906646 426 428 2.313650 426 429 -3.934330 426 502 486.976519 426 503 -17.338536 427 350 0.000071 427 424 0.000009 427 426 -0.030290 427 427 -1987.985984 427 428 0.000007 427 429 0.037084 427 502 0.001696 428 352 20.672834 428 426 2.313650 428 428 -492.785182 428 429 1680.918938 428 430 2.073449 428 431 -3.614416 428 504 467.483190 428 505 -16.849452 429 352 0.000066 429 426 0.000007 429 428 -0.029151 429 429 -1923.101491 429 430 0.000006 429 431 0.034313 429 504 0.001496 430 354 20.917955 430 428 2.073449 430 430 -471.872970 430 431 1623.937354 430 432 1.844714 430 433 -3.309391 430 506 446.802936 430 507 -16.353264 431 354 0.000061 431 428 0.000006 431 430 -0.028016 431 431 -1858.200790 431 432 0.000005 431 433 0.031667 431 506 0.001300 432 356 21.155070 432 430 1.844714 432 432 -449.673727 432 433 1566.999650 432 434 1.627426 432 435 -3.019349 432 508 424.820746 432 509 -15.886051 433 356 0.000055 433 430 0.000005 433 432 -0.026885 433 433 -1793.283174 433 434 0.000004 433 435 0.029146 433 508 0.001109 434 358 21.367908 434 432 1.627426 434 434 -426.030483 434 435 1510.101632 434 436 1.421553 434 437 -2.743474 434 510 401.395972 434 511 -15.442635 435 358 0.000049 435 432 0.000004 435 434 -0.025760 435 435 -1728.348026 435 436 0.000003 435 437 0.026742 435 510 0.000923 436 360 21.540386 436 434 1.421553 436 436 -400.762051 436 437 1453.254741 436 438 1.227067 436 439 -2.480316 436 512 376.363570 436 513 -15.026690 437 360 0.000042 437 434 0.000003 437 436 -0.024640 437 437 -1663.402879 437 438 0.000002 437 439 0.024438 437 512 0.000743 438 362 21.694826 438 436 1.227067 438 438 -373.710711 438 439 1396.490784 438 440 1.043899 438 441 -2.228482 438 514 349.543594 438 515 -14.683316 439 362 0.000035 439 436 0.000002 439 438 -0.023528 439 439 -1598.430219 439 440 0.000001 439 441 0.022218 439 514 0.000571 440 364 21.798143 440 438 1.043899 440 440 -344.597864 440 441 1339.825140 440 442 0.871994 440 443 -1.985261 440 516 320.690656 440 517 -14.420582 441 364 0.000028 441 438 0.000001 441 440 -0.022425 441 441 -1533.437247 441 442 0.000001 441 443 0.020051 441 516 0.000408 442 366 21.863651 442 440 0.871994 442 442 -313.170479 442 443 1283.318426 442 444 0.711292 442 445 -1.747391 442 518 289.538523 442 519 -14.298838 443 366 0.000019 443 440 0.000001 443 442 -0.021333 443 443 -1468.422666 443 444 0.000000 443 445 0.017898 443 518 0.000257 444 368 21.858582 444 442 0.711292 444 444 -279.059668 444 445 1227.011221 444 446 0.561691 444 447 -1.509643 444 520 255.751240 444 521 -14.359510 445 368 0.000010 445 442 0.000000 445 444 -0.020255 445 445 -1403.385039 445 446 0.000000 445 447 0.015697 445 520 0.000120 446 370 21.734865 446 444 0.561691 446 446 -241.795843 446 447 1170.949049 446 448 0.423000 446 522 218.907580 446 523 -14.650612 447 370 0.000000 447 444 0.000000 447 446 -0.019195 447 447 -1338.322575 447 522 0.000003 448 372 21.437598 448 446 0.423000 448 448 -200.780494 448 449 1097.092197 448 450 0.294814 448 524 178.464530 449 448 -0.018261 449 449 -1271.930831 450 374 20.769488 450 448 0.294814 450 450 -155.074808 450 451 1041.340607 450 452 0.175899 450 526 133.682212 451 450 -0.017329 451 451 -1207.159015 452 376 19.120614 452 450 0.175899 452 452 -103.027535 452 453 985.590190 452 454 0.059692 452 528 83.527092 453 452 -0.016397 453 453 -1142.387934 454 378 12.844199 454 452 0.059692 454 454 -38.564751 454 455 929.854436 454 530 25.524787 454 531 -8.248618 455 454 -0.015469 455 455 -1077.626278 456 380 755.755239 456 456 -915.558888 456 457 3697.273476 456 458 159.424081 456 459 -262.170697 457 380 0.006883 457 381 6.553478 457 456 -0.065337 457 457 -3968.850638 457 458 0.001414 457 459 2.400498 458 382 748.190030 458 456 159.424081 458 458 -1066.796744 458 459 3753.554063 458 460 158.673114 458 461 -248.428145 459 382 0.006619 459 383 6.411633 459 456 0.001414 459 458 -0.067599 459 459 -4048.761128 459 460 0.001367 459 461 2.247859 460 384 740.415325 460 458 158.673114 460 460 -1057.386141 460 461 3812.996459 460 462 157.777980 460 463 -237.787777 461 384 0.006366 461 385 6.280177 461 458 0.001367 461 460 -0.068412 461 461 -4129.336964 461 462 0.001322 461 463 2.131158 462 386 732.411736 462 460 157.777980 462 462 -1047.457139 462 463 3875.001994 462 464 156.737499 462 465 -229.768634 463 386 0.006122 463 387 6.153288 463 460 0.001322 463 462 -0.069235 463 463 -4209.953870 463 464 0.001276 463 465 2.044910 464 388 724.162556 464 462 156.737499 464 464 -1036.991842 464 465 3939.024513 464 466 155.551660 464 467 -223.832411 465 388 0.005884 465 389 6.031531 465 462 0.001276 465 464 -0.070063 465 465 -4290.591797 465 466 0.001230 465 467 1.983111 466 390 715.643282 466 464 155.551660 466 466 -1025.965694 466 467 4004.542951 466 468 154.220417 466 469 -219.423869 467 390 0.005650 467 391 5.914932 467 464 0.001230 467 466 -0.070896 467 467 -4371.279465 467 468 0.001185 467 469 1.939332 468 392 706.837019 468 466 154.220417 468 468 -1014.361321 468 469 4071.210897 468 470 152.743342 468 471 -216.205154 469 392 0.005420 469 393 5.800871 469 466 0.001185 469 468 -0.071732 469 469 -4451.995277 469 470 0.001138 469 471 1.909809 470 394 697.723657 470 468 152.743342 470 470 -1002.158171 470 471 4138.684101 470 472 151.120417 470 473 -213.825278 471 394 0.005191 471 395 5.689330 471 468 0.001138 471 470 -0.072570 471 471 -4532.736630 471 472 0.001092 471 473 1.890464 472 396 688.287023 472 470 151.120417 472 472 -989.340258 472 473 4206.623801 472 474 149.351848 472 475 -211.939979 473 396 0.004965 473 397 5.580109 473 470 0.001092 473 472 -0.073408 473 473 -4613.500409 473 474 0.001045 473 475 1.877392 474 398 678.495874 474 472 149.351848 474 474 -975.876582 474 475 4274.868969 474 476 147.437671 474 477 -210.383133 475 398 0.004739 475 399 5.470888 475 472 0.001045 475 474 -0.074246 475 475 -4694.283410 475 476 0.000997 475 477 1.868644 476 400 668.329571 476 474 147.437671 476 476 -961.746706 476 477 4343.198742 476 478 145.378054 476 479 -208.929140 477 400 0.004514 477 401 5.362198 477 474 0.000997 477 476 -0.075084 477 477 -4775.084301 477 478 0.000949 477 479 1.861673 478 402 657.767067 478 476 145.378054 478 478 -946.930315 478 479 4411.523230 478 480 143.173562 478 481 -207.498912 479 402 0.004290 479 403 5.252154 479 476 0.000949 479 478 -0.075922 479 479 -4855.884422 479 480 0.000901 479 481 1.855503 480 404 646.779314 480 478 143.173562 480 480 -931.399430 480 481 4479.779245 480 482 140.824695 480 483 -205.997971 481 404 0.004066 481 405 5.140742 481 478 0.000901 481 480 -0.076761 481 481 -4936.716267 481 482 0.000853 481 483 1.849078 482 406 635.342273 482 480 140.824695 482 482 -915.130709 482 483 4547.853691 482 484 138.331651 482 485 -204.325717 483 406 0.003843 483 407 5.027858 483 480 0.000853 483 482 -0.077600 483 483 -5017.562561 483 484 0.000804 483 485 1.841212 484 408 623.413772 484 482 138.331651 484 484 -898.082617 484 485 4615.750789 484 486 135.694869 484 487 -202.485500 485 408 0.003621 485 409 4.911988 485 482 0.000804 485 484 -0.078440 485 485 -5098.422352 485 486 0.000756 485 487 1.831931 486 410 610.963866 486 484 135.694869 486 486 -880.225913 486 487 4683.453738 486 488 132.914615 486 489 -200.460846 487 410 0.003400 487 411 4.793176 487 484 0.000756 487 486 -0.079281 487 487 -5179.295928 487 488 0.000707 487 489 1.821042 488 412 597.952084 488 486 132.914615 488 488 -861.520896 488 489 4750.932245 488 490 129.991392 488 491 -198.222163 489 412 0.003180 489 413 4.671319 489 486 0.000707 489 488 -0.080124 489 489 -5260.183361 489 490 0.000659 489 491 1.808210 490 414 584.339927 490 488 129.991392 490 490 -841.929808 490 491 4818.230088 490 492 126.925439 490 493 -195.814708 491 414 0.002961 491 415 4.545292 491 488 0.000659 491 490 -0.080968 491 491 -5341.084563 491 492 0.000612 491 493 1.793938 492 416 570.078469 492 490 126.925439 492 492 -821.404484 492 493 4885.354641 492 494 123.717279 492 495 -193.262476 493 416 0.002745 493 417 4.415041 493 490 0.000612 493 492 -0.081815 493 493 -5421.983831 493 494 0.000564 493 495 1.778503 494 418 555.121304 494 492 123.717279 494 494 -799.899586 494 495 4952.341617 494 496 120.367452 494 497 -190.574808 495 418 0.002530 495 419 4.280477 495 492 0.000564 495 494 -0.082666 495 495 -5502.914947 495 496 0.000517 495 497 1.762011 496 420 539.398467 496 494 120.367452 496 496 -777.345854 496 497 5019.238175 496 498 116.876126 496 499 -187.815831 497 420 0.002317 497 421 4.140497 497 494 0.000517 497 496 -0.083520 497 497 -5583.861947 497 498 0.000471 497 499 1.745218 498 422 522.850675 498 496 116.876126 498 498 -753.684521 498 499 5086.086973 498 500 113.243650 498 501 -185.030930 499 422 0.002107 499 423 3.994965 499 496 0.000471 499 498 -0.084378 499 499 -5664.826219 499 500 0.000426 499 501 1.728644 500 424 505.402869 500 498 113.243650 500 500 -728.841219 500 501 5152.918237 500 502 109.470364 500 503 -182.252870 501 424 0.001900 501 425 3.843566 501 498 0.000426 501 500 -0.085240 501 501 -5745.809082 501 502 0.000381 501 503 1.712688 502 426 486.976519 502 500 109.470364 502 502 -702.738051 502 503 5219.806201 502 504 105.556562 502 505 -179.557931 503 426 0.001696 503 427 3.685282 503 500 0.000381 503 502 -0.086108 503 503 -5826.811896 503 504 0.000338 503 505 1.698241 504 428 467.483190 504 502 105.556562 504 504 -675.287157 504 505 5286.812111 504 506 101.502523 504 507 -177.008698 505 428 0.001496 505 429 3.519719 505 502 0.000338 505 504 -0.086981 505 505 -5907.836806 505 506 0.000295 505 507 1.686052 506 430 446.802936 506 504 101.502523 506 506 -646.369017 506 507 5353.991024 506 508 97.308396 506 509 -174.660799 507 430 0.001300 507 431 3.346154 507 504 0.000295 507 506 -0.087861 507 507 -5988.886130 507 508 0.000254 507 509 1.676780 508 432 424.820746 508 506 97.308396 508 508 -615.869152 508 509 5421.423407 508 510 92.974563 508 511 -172.608406 509 432 0.001109 509 433 3.163372 509 506 0.000254 509 508 -0.088747 509 509 -6069.945923 509 510 0.000213 509 511 1.671562 510 434 401.395972 510 508 92.974563 510 510 -583.647577 510 511 5489.230682 510 512 88.501302 510 513 -170.941660 511 434 0.000923 511 435 2.970474 511 508 0.000213 511 510 -0.089642 511 511 -6151.052940 511 512 0.000174 511 513 1.671471 512 436 376.363570 512 510 88.501302 512 512 -549.539489 512 513 5557.497359 512 514 83.888577 512 515 -169.754710 513 436 0.000743 513 437 2.766273 513 510 0.000174 513 512 -0.090545 513 513 -6232.194891 513 514 0.000137 513 515 1.677673 514 438 349.543594 514 512 83.888577 514 514 -513.365084 514 515 5626.368998 514 516 79.136565 514 517 -169.185242 515 438 0.000571 515 439 2.548982 515 512 0.000137 515 514 -0.091459 515 515 -6313.377012 515 516 0.000100 515 517 1.691807 516 440 320.690656 516 514 79.136565 516 516 -474.879299 516 517 5695.999644 516 518 74.245412 516 519 -169.374721 517 440 0.000408 517 441 2.316783 517 514 0.000100 517 516 -0.092385 517 517 -6394.606279 517 518 0.000065 517 519 1.715626 518 442 289.538523 518 516 74.245412 518 518 -433.815829 518 519 5766.601966 518 520 69.214900 518 521 -170.517111 519 442 0.000257 519 443 2.067096 519 516 0.000065 519 518 -0.093326 519 519 -6475.891434 519 520 0.000032 519 521 1.751478 520 444 255.751240 520 518 69.214900 520 520 -389.838417 520 521 5838.425940 520 522 64.044940 520 523 -172.835362 521 444 0.000120 521 445 1.797055 521 518 0.000032 521 520 -0.094284 521 521 -6557.244224 521 522 0.000000 521 523 1.802134 522 446 218.907580 522 520 64.044940 522 522 -342.523088 522 523 5911.748061 522 524 58.732874 523 446 0.000003 523 447 1.503084 523 520 0.000000 523 522 -0.095295 523 523 -6638.663612 524 448 178.464530 524 522 58.732874 524 524 -291.326334 524 525 5795.122761 524 526 53.280857 525 524 -0.096452 525 525 -6718.332833 526 450 133.682212 526 524 53.280857 526 526 -235.509721 526 527 5866.155628 526 528 47.688173 527 526 -0.097613 527 527 -6799.915084 528 452 83.527092 528 526 47.688173 528 528 -172.656956 528 529 5937.415063 528 530 40.572772 528 531 -204.274932 529 528 -0.115295 529 529 -6881.643236 529 530 0.016520 529 531 2.280973 530 454 25.524787 530 528 40.572772 530 530 -66.965417 530 531 6221.553050 531 528 0.016520 531 530 -0.120408 531 531 -6965.880969