diff --git a/fem/src/SParIterSolver.F90 b/fem/src/SParIterSolver.F90 index 22344596f0..8f55fb2c86 100644 --- a/fem/src/SParIterSolver.F90 +++ b/fem/src/SParIterSolver.F90 @@ -942,10 +942,14 @@ SUBROUTINE SetHypreParameters(Params, hypremethod, Ilun, hypre_dppara, hypre_int DO i=0,1 j = 0 - IF(i==0) THEN - IterativeMethod = ListGetString( Params,'Linear System Iterative Method' ) + IF(i==0) THEN + hypre_sol = ListGetInteger( Params,'Linear System Method Hypre Index',Found ) + IF(Found ) CYCLE Method => IterativeMethod + IterativeMethod = ListGetString( Params,'Linear System Iterative Method' ) ELSE + hypre_pre = ListGetInteger( Params,'Linear System Preconditioning Hypre Index',Found ) + IF(Found ) CYCLE PrecMethod = ListGetString(Params,'Linear System Preconditioning',Found) IF(.NOT. Found) THEN CALL Info(Caller,'"Linear System Preconditioning" not given, assuming "none"') @@ -986,27 +990,27 @@ SUBROUTINE SetHypreParameters(Params, hypremethod, Ilun, hypre_dppara, hypre_int END IF IF(i==0) THEN + CALL Info(Caller,'Using HYPRE iterative method: '//TRIM(IterativeMethod),Level=7) hypre_sol = j ELSE + CALL Info(Caller,'Using HYPRE preconditioning method: '//TRIM(PrecMethod),Level=7) hypre_pre = j END IF END DO ! Some methods (Krylov methods) can not act as preconditioners! - CALL Info(Caller,'Using HYPRE preconditioning method: '//TRIM(PrecMethod),Level=7) IF( ANY( hypre_pre == [6,7,8,9,10,11] ) ) THEN CALL Fatal(Caller,'Invalid preconditioner for Hypre: '//TRIM(PrecMethod)) END IF ! Some methods cannot act as solvers! - CALL Info(Caller,'Using HYPRE iterative method: '//TRIM(IterativeMethod),Level=7) IF( ANY( hypre_sol == [0,4,5] ) ) THEN CALL Fatal(Caller,'Invalid solver for Hypre: '//TRIM(IterativeMethod)) END IF ! We map the precondtioner + solver to one figure. hypremethod = 100 * hypre_sol + hypre_pre - CALL Info(Caller,'Hypre method index: '//I2S(hypremethod),Level=8) + CALL Info(Caller,'Hypre method index: '//I2S(hypremethod),Level=6) DO i=0,1 IF(i==0) THEN @@ -1058,8 +1062,15 @@ SUBROUTINE SetHypreParameters(Params, hypremethod, Ilun, hypre_dppara, hypre_int 'BoomerAMG Strong Threshold', Found, DefValue = 0.25_dp) CASE(2) ! AMS - hypre_intpara(1) = ListGetInteger( Params,& - 'AMS Cycle Type', Found, DefValue = 1 ) + ! The numbering follows the old convention. + hypre_intpara(6) = ListGetInteger( Params,& + 'AMS Smoothing Option 1', Found, DefValue = 2 ) + + hypre_intpara(3) = ListGetInteger( Params,& + 'AMS Smoothing Option 2', Found, DefValue = 1 ) + + hypre_intpara(7) = ListGetInteger( Params,& + 'AMS Cycle Type', Found, DefValue = 1) CASE(3) ! ILU @@ -1725,7 +1736,7 @@ SUBROUTINE SParIterSolver( SourceMatrix, ParallelInfo, XVec, & TYPE (GlueTableT), POINTER :: GT CHARACTER(:), ALLOCATABLE :: XmlFile - REAL(KIND=dp) :: hypre_dppara(10) = 0 + REAL(KIND=dp) :: hypre_dppara(10) = 0, TOL INTEGER :: ILUn, BILU, Rounds, buf(2), src, status(MPI_STATUS_SIZE), ssz,nob, & hypremethod, gind, hypre_intpara(20) = 0 @@ -2171,7 +2182,7 @@ SUBROUTINE CreateHypreAMS(nrows,rows,cols,vals,n,grows,gcols,gvals, & hypre_dppara(10), Gvals(*), xx_d(*), yy_d(*), zz_d(*) INTEGER(KIND=C_INTPTR_T) :: hypreContainer END SUBROUTINE CreateHypreAMS - + SUBROUTINE UpdateHypre(TOL, hypremethod, hypreContainer) BIND(C,name="updatehypre") USE, INTRINSIC :: iso_c_binding REAL(KIND=c_double) :: TOL @@ -2207,8 +2218,6 @@ END SUBROUTINE UpdateHypre CALL ContinuousNumbering(ParallelInfo,Matrix % Perm,APerm,Owner) ! Newer hypre libraries require zero based indexing Aperm = Aperm-1 - - CALL SParIterActiveBarrier() ELSE n = Matrix % NumberOfRows ALLOCATE( Owner(n), Aperm(n) ) @@ -2217,7 +2226,10 @@ END SUBROUTINE UpdateHypre END DO Owner = 1 END IF - + + CALL SParIterActiveBarrier() + + !------------------------------------------------------------ verbosity = ListGetInteger( CurrentModel % Simulation,'Max Output Level',Found ) IF( .NOT. Found ) verbosity = 10 @@ -2255,15 +2267,6 @@ END SUBROUTINE UpdateHypre IF( DoAMS ) THEN CALL PrepareHypreAMS() nnd = Solver % Mesh % NumberOfNodes - IF( ListGetLogical(Solver % Values,'Hypre test',Found ) ) THEN - PRINT *,'Using old hypre for debugging!' - CALL CreateHYPREAMS( Matrix % NumberOfRows, Rows, Cols, Vals, & - nnd,GM % Rows,GM % Cols,GM % Values,Aperm,Aperm,Aperm,Owner, & - Bperm,NodeOwner,Xvec,RHSvec,ParEnv % myPE, ILUn, Rounds,TOL, & - xx_d,yy_d,zz_d,hypremethod,hypre_intpara, hypre_dppara,verbosity, & - Matrix % Hypre, Matrix % Comm) - RETURN - END IF CALL CreateHYPREAMS( Matrix % NumberOfRows, Rows, Cols, Vals, & nnd,GM % Rows,GM % Cols,GM % Values,Aperm,Aperm,Aperm,Owner, & Bperm,NodeOwner,Xvec,RHSvec,ParEnv % myPE, ILUn, Rounds,TOL, & @@ -2309,8 +2312,12 @@ END SUBROUTINE UpdateHypre CONTAINS SUBROUTINE PrepareHypreAMS() + + TYPE(Mesh_t), POINTER :: Mesh + + Mesh => Solver % Mesh - nnd = Solver % Mesh % NumberOfNodes + nnd = Mesh % NumberOfNodes ALLOCATE( NodeOwner(nnd), NodePerm(nnd), Bperm(nnd)) DO i=1,nnd @@ -2319,8 +2326,8 @@ SUBROUTINE PrepareHypreAMS() IF( Parallel ) THEN NodeOwner = 0 - CALL ContinuousNumbering( Solver % Mesh % ParallelInfo, & - NodePerm, BPerm, NodeOwner, nnd, Solver % Mesh) + CALL ContinuousNumbering( Mesh % ParallelInfo, & + NodePerm, BPerm, NodeOwner, nnd, Mesh) bPerm = bPerm-1 ELSE NodeOwner = 1 @@ -2332,24 +2339,24 @@ SUBROUTINE PrepareHypreAMS() GM => AllocateMatrix() GM % FORMAT = MATRIX_LIST - DO i=Solver % Mesh % NumberofEdges,1,-1 - ind = Solver % Mesh % Edges(i) % NodeIndexes - IF (Solver % Mesh % ParallelInfo % GlobalDOFs(ind(1))> & - Solver % Mesh % ParallelInfo % GlobalDOFs(ind(2))) THEN + DO i=Mesh % NumberofEdges,1,-1 + ind = Mesh % Edges(i) % NodeIndexes + IF (Mesh % ParallelInfo % GlobalDOFs(ind(1))> & + Mesh % ParallelInfo % GlobalDOFs(ind(2))) THEN k=ind(1); ind(1)=ind(2);ind(2)=k END IF - CALL List_AddToMatrixElement(gm%listmatrix,i,ind(1),-1._dp) - CALL List_AddToMatrixElement(gm%listmatrix,i,ind(2), 1._dp) + CALL List_AddToMatrixElement(gm % listmatrix,i,ind(1),-1._dp) + CALL List_AddToMatrixElement(gm % listmatrix,i,ind(2), 1._dp) END DO CALL List_tocrsMatrix(gm) - nnd = Solver % Mesh % NumberOfEdges + nnd = Mesh % NumberOfEdges ALLOCATE(xx_d(nnd),yy_d(nnd),zz_d(nnd) ) - CALL CRS_MatrixVectorMultiply(gm,Solver % Mesh % Nodes % x,xx_d) - CALL CRS_MatrixVectorMultiply(gm,Solver % Mesh % Nodes % y,yy_d) - CALL CRS_MatrixVectorMultiply(gm,Solver % Mesh % Nodes % z,zz_d) + CALL CRS_MatrixVectorMultiply(gm,Mesh % Nodes % x,xx_d) + CALL CRS_MatrixVectorMultiply(gm,Mesh % Nodes % y,yy_d) + CALL CRS_MatrixVectorMultiply(gm,Mesh % Nodes % z,zz_d) - nnd = Solver % Mesh % NumberOfNodes + nnd = Mesh % NumberOfNodes END SUBROUTINE PrepareHypreAMS diff --git a/fem/src/SolveHypre.c b/fem/src/SolveHypre.c index 9d26c1ee3c..cf7a692dbb 100644 --- a/fem/src/SolveHypre.c +++ b/fem/src/SolveHypre.c @@ -135,7 +135,7 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) else myverb = 0; - if (myverb > 4) fprintf(stdout,"Performing HYPRE Setup\n"); + if (myverb > 6) fprintf(stdout,"Performing HYPRE Setup\n"); st = realtime_(); @@ -319,7 +319,7 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) and later changes the pointer to solvers. */ if ( hypre_pre == 1 || hypre_sol == 1 ) { - if( myverb > 5 ) { + if( myverb > 6 ) { fprintf( stdout,"SolveHypre: using BoomerAMG\n"); } if( myverb > 10 ) { @@ -354,7 +354,7 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) for 3D Laplace, 0.9 for elasticity) */ HYPRE_BoomerAMGSetStrongThreshold(precond, hypre_dppara[0]); - printf("Created BoomerAMG preconditioner!\n"); + fprintf(stdout,"Created BoomerAMG preconditioner!\n"); } else if ( hypre_pre == 2 || hypre_sol == 2 ) { fprintf( stdout, "SolveHypre: using AMS\n"); @@ -409,7 +409,7 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) } else if ( hypre_pre == 4 ) { - if (myverb > 4) fprintf( stdout,"SolveHypre: using ParaSails as preconditioner\n"); + if (myverb > 5) fprintf( stdout,"SolveHypre: using ParaSails as preconditioner\n"); /* Now set up the ParaSails preconditioner and specify any parameters */ HYPRE_ParaSailsCreate(comm, &precond); @@ -429,7 +429,7 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) int max_steps=5,max_step_size=3; double kap_tolerance=1.0e-3; #if 0 - if (myverb > 4) fprintf( stdout,"SolveHypre: using SPAI as preconditioner\n"); + if (myverb > 5) fprintf( stdout,"SolveHypre: using SPAI as preconditioner\n"); HYPRE_FSAICreate(&precond); HYPRE_FSAISetMaxSteps(precond, max_steps); HYPRE_FSAISetMaxStepSize(precond, max_step_size); @@ -446,13 +446,13 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) } - /* create solver */ + /* Create Hypre solver */ if ( hypre_sol == 1 ) { /* boomer AMG */ solver = precond; precond = NULL; /* Now setup - note that the input vectors are ignored so we can pass in NULLs */ - if (myverb > 5 ) fprintf(stdout,"construct BoomerAMG solver"); + if (myverb > 10 ) fprintf(stdout,"construct BoomerAMG solver"); HYPRE_BoomerAMGSetTol(solver, *TOL); /* conv. tolerance */ HYPRE_BoomerAMGSetMaxIter(solver, *Rounds); /* iteration rounds */ @@ -465,7 +465,7 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) precond = NULL; /* Now setup - note that the input vectors are ignored so we can pass in NULLs */ - if (myverb > 5 ) fprintf(stdout,"construct AMS solver"); + if (myverb > 10 ) fprintf(stdout,"construct AMS solver"); HYPRE_AMSSetMaxIter(solver,*Rounds); HYPRE_AMSSetTol(solver, *TOL); @@ -504,7 +504,7 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) } /* compute the preconditioner */ - if (myverb > 6 ) fprintf(stdout,"create preconditioner..."); + if (myverb > 10 ) fprintf(stdout,"create preconditioner..."); HYPRE_ParCSRPCGSetup(solver, parcsr_A, par_b, par_x); @@ -529,7 +529,6 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) HYPRE_BiCGSTABSetPrecond(solver, (HYPRE_PtrToSolverFcn) HYPRE_BoomerAMGSolve, (HYPRE_PtrToSolverFcn) HYPRE_BoomerAMGSetup, precond); } else if(hypre_pre == 2 ) { - printf("a1 *************\n"); HYPRE_BiCGSTABSetPrecond(solver, (HYPRE_PtrToSolverFcn) HYPRE_AMSSolve, (HYPRE_PtrToSolverFcn) HYPRE_AMSSetup, precond); } else if ( hypre_pre == 3) { @@ -540,7 +539,7 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) (HYPRE_PtrToSolverFcn) HYPRE_ParaSailsSetup, precond); } /* compute the preconditioner */ - if (myverb > 5 ) fprintf(stdout,"create preconditioner..."); + if (myverb > 10 ) fprintf(stdout,"create preconditioner..."); HYPRE_ParCSRBiCGSTABSetup(solver, parcsr_A, par_b, par_x); @@ -578,7 +577,7 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) } /* Pass the matrix and rhs into the solver */ - if (myverb > 6 ) fprintf(stdout,"Passing matrix and rhs into GMRES solver..."); + if (myverb > 10 ) fprintf(stdout,"Passing matrix and rhs into GMRES solver..."); HYPRE_ParCSRGMRESSetup(solver, parcsr_A, par_b, par_x); @@ -613,7 +612,7 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) (HYPRE_PtrToSolverFcn) HYPRE_ParaSailsSetup, precond); } /* Pass the matrix and rhs into the solver */ - if (myverb > 6 ) fprintf(stdout,"Passing matrix and rhs into FlexGMRES solver..."); + if (myverb > 10 ) fprintf(stdout,"Passing matrix and rhs into FlexGMRES solver..."); HYPRE_ParCSRFlexGMRESSetup(solver, parcsr_A, par_b, par_x); @@ -652,7 +651,7 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) } /* compute the preconditioner */ - if (myverb > 6 ) fprintf(stdout,"Passing matrix and rhs into LGMRES solver..."); + if (myverb > 10 ) fprintf(stdout,"Passing matrix and rhs into LGMRES solver..."); HYPRE_ParCSRLGMRESSetup(solver, parcsr_A, par_b, par_x); @@ -684,7 +683,7 @@ void STDCALLBULL FC_FUNC(solvehypre1,SOLVEHYPRE1) } /* compute the preconditioner */ - if (myverb > 5 ) fprintf(stdout,"create preconditioner..."); + if (myverb > 10 ) fprintf(stdout,"create preconditioner..."); HYPRE_ParCSRCOGMRESSetup(solver, parcsr_A, par_b, par_x); @@ -802,7 +801,7 @@ void STDCALLBULL FC_FUNC(solvehypre2,SOLVEHYPRE2) else myverb = 0; - if (myverb > 6) fprintf(stdout,"HYPRE Solve\n"); + if (myverb > 10) fprintf(stdout,"HYPRE Solve\n"); if (Container==NULL) { if(myverb) fprintf( stdout, "ID no. %i: pointer passed into SolveHypre2 is NULL, not solving",myid); return; @@ -859,7 +858,7 @@ void STDCALLBULL FC_FUNC(solvehypre2,SOLVEHYPRE2) if (myverb > 6 ) { HYPRE_BoomerAMGGetNumIterations(Container->solver, &num_iterations); HYPRE_BoomerAMGGetFinalRelativeResidualNorm(solver, &final_res_norm); - fprintf(stdout,"Hypre BoomerAMG: %d %.6le\n",num_iterations,final_res_norm); + fprintf(stdout,"Hypre BoomerAMG: %d %lg\n",num_iterations,final_res_norm); } } @@ -869,7 +868,7 @@ void STDCALLBULL FC_FUNC(solvehypre2,SOLVEHYPRE2) if (myverb > 6 ) { HYPRE_AMSGetNumIterations(Container->solver, &num_iterations); HYPRE_AMSGetFinalRelativeResidualNorm(solver, &final_res_norm); - fprintf(stdout,"Hypre AMS: %d %.6le\n",num_iterations,final_res_norm); + fprintf(stdout,"Hypre AMS: %d %lg\n",num_iterations,final_res_norm); } } @@ -880,7 +879,7 @@ void STDCALLBULL FC_FUNC(solvehypre2,SOLVEHYPRE2) if (myverb > 6 ) { HYPRE_PCGGetNumIterations(Container->solver, &num_iterations); HYPRE_PCGGetFinalRelativeResidualNorm(solver, &final_res_norm); - fprintf(stdout,"Hypre PCG: %d %.6le\n",num_iterations,final_res_norm); + fprintf(stdout,"Hypre PCG: %d %lg\n",num_iterations,final_res_norm); } } @@ -902,7 +901,7 @@ void STDCALLBULL FC_FUNC(solvehypre2,SOLVEHYPRE2) if (myverb > 6 ) { HYPRE_GMRESGetNumIterations(Container->solver, &num_iterations); HYPRE_GMRESGetFinalRelativeResidualNorm(solver, &final_res_norm); - fprintf(stdout,"Hypre GMRES: %d %.6le\n",num_iterations,final_res_norm); + fprintf(stdout,"Hypre GMRES: %d %lg\n",num_iterations,final_res_norm); } } @@ -913,7 +912,7 @@ void STDCALLBULL FC_FUNC(solvehypre2,SOLVEHYPRE2) if (myverb > 6 ) { HYPRE_FlexGMRESGetNumIterations(Container->solver, &num_iterations); HYPRE_FlexGMRESGetFinalRelativeResidualNorm(solver, &final_res_norm); - fprintf(stdout,"Hypre FlexGMRES: %d %.6le\n",num_iterations,final_res_norm); + fprintf(stdout,"Hypre FlexGMRES: %d %lg\n",num_iterations,final_res_norm); } } @@ -925,18 +924,17 @@ void STDCALLBULL FC_FUNC(solvehypre2,SOLVEHYPRE2) if (myverb > 6 ) { HYPRE_LGMRESGetNumIterations(Container->solver, &num_iterations); HYPRE_LGMRESGetFinalRelativeResidualNorm(solver, &final_res_norm); - fprintf(stdout,"Hypre LGMRES: %d %.6le\n",num_iterations,final_res_norm); + fprintf(stdout,"Hypre LGMRES: %d %lg\n",num_iterations,final_res_norm); } } else if ( hypre_sol == 11) { // HYPRE_ParCSRLGMRESSetMaxIter(solver, *Rounds); /* max iterations */ - printf("COGmRes\n"); HYPRE_ParCSRCOGMRESSolve(Container->solver, parcsr_A, par_b, par_x); if (myverb > 6 ) { HYPRE_COGMRESGetNumIterations(Container->solver, &num_iterations); HYPRE_COGMRESGetFinalRelativeResidualNorm(solver, &final_res_norm); - fprintf(stdout,"Hypre COGMRES: %d %.6le\n",num_iterations,final_res_norm); + fprintf(stdout,"Hypre COGMRES: %d %lg\n",num_iterations,final_res_norm); } } @@ -967,21 +965,25 @@ void STDCALLBULL FC_FUNC(solvehypre4,SOLVEHYPRE4)(int** ContainerPtr) { ElmerHypreContainer* Container = (ElmerHypreContainer*)(*ContainerPtr); - int hypre_sol, hypre_pre; + int hypre_sol, hypre_pre, myid, myverb; if (Container==0) return; - + + myverb = 6; hypre_sol = Container->hypre_method / 100; hypre_pre = Container->hypre_method % 100; + if(myverb > 5 ) fprintf(stdout,"Detroying Hypre solver structures!\n"); + /* Destroy Hypre preconditioner */ if ( hypre_pre == 1 ) { + if(myverb > 6) fprintf(stdout,"Detroying BoomerAMG preconditioner\n"); HYPRE_BoomerAMGDestroy(Container->precond); } else if ( hypre_pre == 2 ) { - printf("Detroying AMS solver\n"); + if(myverb > 6) fprintf(stdout,"Detroying AMS preconditioner\n"); HYPRE_AMSDestroy(Container->precond); if (Container->G) { // This leas to core dump... @@ -995,12 +997,13 @@ void STDCALLBULL FC_FUNC(solvehypre4,SOLVEHYPRE4)(int** ContainerPtr) { } + /* Destroy Hypre solver */ if ( hypre_sol == 1) { /* boomer AMG */ - /* Destroy solver */ + if(myverb > 6) fprintf(stdout,"Detroying BoomerAMG solver\n"); HYPRE_BoomerAMGDestroy(Container->solver); } else if ( hypre_sol == 2 ) { - printf("Detroying AMS solver\n"); + if(myverb > 6) fprintf(stdout,"Detroying AMS solver\n"); HYPRE_AMSDestroy(Container->solver); if (Container->G) { // This leas to core dump... @@ -1040,273 +1043,6 @@ void STDCALLBULL FC_FUNC(solvehypre4,SOLVEHYPRE4)(int** ContainerPtr) { *ContainerPtr = NULL; } -void STDCALLBULL FC_FUNC(solvehypreams,SOLVEHYPREAMS) - ( - int *nrows,int *rows, int *cols, double *vals, int *nnodes, - int *grows, int *gcols, double *gvals, int *perm, - int *invperm, int *globaldofs, int *owner, int *globalnodes, - int *nodeowner, double *xvec, - double *rhsvec, int *pe, int *ILUn, int *Rounds, double *TOL, - double *xx_d, double *yy_d, double *zz_d, - int *hypre_method, int *hypre_intpara, double *hypre_dppara, - int *verbosityPtr, int** ContainerPtr, int *fcomm - ) -{ - int i, j, k, *rcols; - int myid, num_procs; - int N, n; - - int ilower, iupper, nlower, nupper; - int local_size, local_nodes, extra; - - int solver_id; - int print_solution, print_system; - - double *txvec, st, realtime_(); - - HYPRE_ParCSRMatrix parcsr_A,parcsr_G; - HYPRE_IJMatrix A,G; - HYPRE_IJVector b; - HYPRE_ParVector par_b; - HYPRE_IJVector x; - HYPRE_ParVector par_x; - HYPRE_IJVector xx,yy,zz; - HYPRE_ParVector par_xx,par_yy,par_zz; - - HYPRE_Solver solver, precond; - MPI_Comm comm=MPI_Comm_f2c(*fcomm); - - int verbosity = *verbosityPtr, myverb; - - st = realtime_(); - /* which process number am I? */ - MPI_Comm_rank(comm, &myid); - - if(myid==0) - myverb = 0; - else - myverb = verbosity; - - /* How many rows do I have? */ - local_size = *nrows; - local_nodes = *nnodes; - - ilower=1000000000; - iupper=0; - for( i=0; i globaldofs[i] ) ilower=globaldofs[i]; - } - } - - nlower=1000000000; - nupper=0; - for( i=0; i globalnodes[i] ) nlower=globalnodes[i]; - } - } - - /* Create the matrix. - Note that this is a square matrix, so we indicate the row partition - size twice (since number of rows = number of cols) */ - HYPRE_IJMatrixCreate(comm, ilower, iupper, ilower, iupper, &A); - - /* Choose a parallel csr format storage (see the User's Manual) */ - HYPRE_IJMatrixSetObjectType(A, HYPRE_PARCSR); - - /* Initialize before setting coefficients */ - HYPRE_IJMatrixInitialize(A); - - /* Now go through my local rows and set the matrix entries. - Note that here we are setting one row at a time, though - one could set all the rows together (see the User's Manual). - */ - { - int nnz,irow,i,j,k,*rcols,csize=32; - - rcols = (int *)malloc( csize*sizeof(int) ); - for (i = 0; i < local_size; i++) - { - nnz = rows[i+1]-rows[i]; - if ( nnz>csize ) { - rcols = (int *)realloc( rcols, nnz*sizeof(int) ); - csize = nnz; - } - irow=globaldofs[i]; - for( k=0,j=rows[i]; jcsize ) { - rcols = (int *)realloc( rcols, nnz*sizeof(int) ); - csize = nnz; - } - irow = globaldofs[i]; - for( k=0,j=grows[i]; j 12 ) fprintf( stdout, "ID no. %i: setup time: %g\n", myid, realtime_()-st ); - st = realtime_(); - - if (myverb > 5 ) fprintf( stdout,"SolveHypre: Setting up AMS\n"); - - HYPRE_AMSCreate(&precond); - HYPRE_AMSSetMaxIter(precond,1); - HYPRE_AMSSetDiscreteGradient(precond,parcsr_G); - HYPRE_AMSSetEdgeConstantVectors(precond,par_xx,par_yy,par_zz); -// HYPRE_AMSSetCoordinateVectors(precond,par_xx,par_yy,par_zz); - - HYPRE_AMSSetCycleType(precond, hypre_intpara[6]);// 1-8 - HYPRE_AMSSetSmoothingOptions(precond, hypre_intpara[5], hypre_intpara[2], 1.0, 1.0); -// HYPRE_AMSSetAlphaAMGOptions(precond, 10, 1, 3, 0.25); - -// HYPRE_AMSSetBetaAMGOptions(precond, 10, 1, 3, 0.25); -// HYPRE_AMSSetBetaPoissonMatrix(precond,NULL); - - /* Create solver */ - HYPRE_ParCSRBiCGSTABCreate(comm, &solver); - - /* Set some parameters (See Reference Manual for more parameters) */ - HYPRE_ParCSRBiCGSTABSetMaxIter(solver, *Rounds); /* max iterations */ - HYPRE_ParCSRBiCGSTABSetTol(solver, *TOL); /* conv. tolerance */ - HYPRE_ParCSRBiCGSTABSetStopCrit(solver, 0); /* use the two norm as the stopping criteria */ - HYPRE_ParCSRBiCGSTABSetPrintLevel(solver, 2); /* print solve info */ - HYPRE_ParCSRBiCGSTABSetLogging(solver, 1); /* needed to get run info later */ - - /* Set the BiCGSTAB preconditioner */ - HYPRE_BiCGSTABSetPrecond(solver, (HYPRE_PtrToSolverFcn) HYPRE_AMSSolve, - (HYPRE_PtrToSolverFcn) HYPRE_AMSSetup, precond); - - /* Now setup and solve! */ - HYPRE_ParCSRBiCGSTABSetup(solver, parcsr_A, par_b, par_x); - HYPRE_ParCSRBiCGSTABSolve(solver, parcsr_A, par_b, par_x); - - /* Destroy solver and preconditioner */ - HYPRE_AMSDestroy(precond); - HYPRE_ParCSRBiCGSTABDestroy(solver); - - for( k=0,i=0; i 5 ) { - fprintf( stdout, "Hypre AMS setup time: %g\n", realtime_()-st ); - } - free( txvec ); - free( rcols ); - - /* Clean up */ - HYPRE_IJMatrixDestroy(A); - HYPRE_IJMatrixDestroy(G); - HYPRE_IJVectorDestroy(b); - HYPRE_IJVectorDestroy(x); -} - void STDCALLBULL FC_FUNC(createhypreams,CREATEHYPREAMS) @@ -1351,7 +1087,6 @@ void STDCALLBULL FC_FUNC(createhypreams,CREATEHYPREAMS) *ContainerPtr=(int*)(Container); st = realtime_(); - /* which process number am I? */ MPI_Comm_rank(comm, &myid); if(myid==0) diff --git a/fem/tests/mgdyn_hypre_ams/case.sif b/fem/tests/mgdyn_hypre_ams/case.sif index 77b87f50c8..8ff78e9d86 100644 --- a/fem/tests/mgdyn_hypre_ams/case.sif +++ b/fem/tests/mgdyn_hypre_ams/case.sif @@ -1,4 +1,5 @@ ! Test case for Hypre AMS - Auxiliary-space Maxwell Solver +! This test case with BiCGStab as solver, AMS as precondtioner. $ mu_pm = 1.05 $ mu0 = 4e-7*pi @@ -9,7 +10,7 @@ Header End Simulation - Max Output Level = 12 + Max Output Level = 7 Coordinate System = Cartesian Simulation Type = steady state Use Mesh Names = False @@ -103,7 +104,19 @@ Solver 1 ! whitneyavsolver Linear System Max Iterations = 5000 Linear System Residual Output = 10 Linear System preconditioning = ams - Linear System Iterative Method = cg + +! AMS 2 +! PCG 6 +! BiCGStab 7 +! GMRes 8 +! FlexGMRes 9 +! LGMRes 10 +! COGMRes 11 + + Linear System Method Hypre Index = Integer 7 + +! Linear System Iterative Method = bicgstab + Edge Basis = Logical True NonLinear System Consistent Norm = True @@ -161,8 +174,8 @@ Equation 1 End ! At some stage the norm has changed. -!Solver 1:: Reference Norm = 1.47377614E-07 -!Solver 3:: Show Norm Index = 2 +!Solver 1:: Reference Norm = 1.45087009E-07 ! Electromagnetic field energy +Solver 3:: Show Norm Index = 2 Solver 3:: Reference Norm = 8.32659888E-06 diff --git a/fem/tests/mgdyn_hypre_ams2/CMakeLists.txt b/fem/tests/mgdyn_hypre_ams2/CMakeLists.txt new file mode 100644 index 0000000000..3e5302cc38 --- /dev/null +++ b/fem/tests/mgdyn_hypre_ams2/CMakeLists.txt @@ -0,0 +1,9 @@ +IF(WITH_Hypre) + INCLUDE(test_macros) + + CONFIGURE_FILE(case.sif case.sif COPYONLY) + + file(COPY ELMERSOLVER_STARTINFO cylinders DESTINATION "${CMAKE_CURRENT_BINARY_DIR}/") + + ADD_ELMER_TEST(mgdyn_hypre_ams2 NPROCS 1 2 LABELS hypre mgdyn) +ENDIF() diff --git a/fem/tests/mgdyn_hypre_ams2/ELMERSOLVER_STARTINFO b/fem/tests/mgdyn_hypre_ams2/ELMERSOLVER_STARTINFO new file mode 100644 index 0000000000..d21bd7ee27 --- /dev/null +++ b/fem/tests/mgdyn_hypre_ams2/ELMERSOLVER_STARTINFO @@ -0,0 +1 @@ +case.sif diff --git a/fem/tests/mgdyn_hypre_ams2/case.sif b/fem/tests/mgdyn_hypre_ams2/case.sif new file mode 100644 index 0000000000..73b9f170e0 --- /dev/null +++ b/fem/tests/mgdyn_hypre_ams2/case.sif @@ -0,0 +1,183 @@ +! Test case for Hypre AMS - Auxiliary-space Maxwell Solver +! This one using AMS as solver, not preconditioner. +! +! P.R. 19.11.2024 + +$ mu_pm = 1.05 +$ mu0 = 4e-7*pi +$ Jcurr = 1e3 + +Header + Mesh DB "." "cylinders" +End + +Simulation + Max Output Level = 7 + Coordinate System = Cartesian + Simulation Type = steady state + Use Mesh Names = False +End + +Material 1 ! Air + name = "air" + Relative Permittivity = 1 + relative permeability = 1 +end + +Material 2 ! magnetic material + Name = "Iron" + Relative Permittivity = 1 + relative permeability = 1000 + Electric conductivity = real 3000 +End + +Material 3 ! slightly magnetic material + name = "PM" + relative permeability = $ mu_pm + relative permittivity = 1 +End + +body force 1 ! current + magnetization 3 = 1 + magnetization 2 = 1 +end + +Body 1 ! air + name = "air" + target bodies(1) = 1 + material = integer 1 + Equation = 1 + initial condition = 1 +end + +Body 2 ! iron + name = "iron" + target bodies(1) = 2 + material = integer 2 + Equation = 1 + initial condition = 1 +end + +body 3 ! wire + name = "magnets" + target bodies(1) = 3 + material = integer 3 + Equation = 1 + body force = 1 +end + +Boundary condition 1 ! ext + name = "ext" + target boundaries(5) = 3 4 5 7 11 + A {e} = real 0 +End + +Boundary condition 2 + name = "wire_a" + target boundaries(1) = 10 + current density = $ -Jcurr + A {e} = real 0 +end + +Boundary condition 3 + name = "wire_b" + target boundaries(1) = 9 + current density = $ Jcurr + A {e} = real 0 +end + +Solver 1 ! whitneyavsolver + Equation = "Mag" + + Variable = "A" + Procedure = "MagnetoDynamics" "WhitneyAVSolver" + + Fix Input Current Density = true +! Use Piola Transform = Logical true +! quadratic approximation = logical false + use tree gauge = logical false + + linear system use hypre = logical true + Newton-Raphson Iteration = logical false + + Linear System Solver = iterative + Linear System Symmetric = true + Linear System Convergence Tolerance = 1.e-6 + Linear System Max Iterations = 5000 + Linear System Residual Output = 10 +! Linear System preconditioning = ams + +! AMS 2 +! PCG 6 +! BiCGStab 7 +! GMRes 8 +! FlexGMRes 9 +! LGMRes 10 +! COGMRes 11 + + Linear System Method Hypre Index = Integer 2 + +! Linear System Iterative Method = bicgstab + + Edge Basis = Logical True + + NonLinear System Consistent Norm = True +End + +Solver 2 ! MagnetoDynamicsCalcFields + Equation = ComputeB + + Potential Variable="A" + Procedure = "MagnetoDynamics" "MagnetoDynamicsCalcFields" + Use Piola Transform = Logical true + quadratic approximation = logical false + + Calculate Current Density = Logical True + Calculate Electric Field = Logical True + Calculate Magnetic Field Strength = Logical True + Calculate Magnetic Vector Potential = Logical True + !Calculate Nodal Forces = Logical True + Calculate Elemental Fields = Logical True + !Calculate Maxwell Stress = Logical True + Apply Mortar BCs = Logical false + !Optimize Bandwidth = False + + Linear System Solver = iterative + Linear System Iterative Method = bicgstab + Linear System Symmetric = True + Linear System Max Iterations = 100 + Linear System Residual Output=10 + Linear System Preconditioning = none + Linear System Convergence Tolerance = 1.0e-8 + + NonLinear System Consistent Norm = True +End + +Solver 3 +! Exec Solver = never + Procedure = "SaveData" "SaveScalars" + output directory = "." +! Filename = mgdyn_hypreams.dat +End + +Solver 4 + exec solver = never + Equation = "result output" + Procedure = "ResultOutputSolve" "ResultOutputSolver" + Output File Name = mgdyn_hypreams + Output Directory = wires + Save Geometry IDs = Logical True + Vtu Format = Logical True + discontinuous bodies = true +End + +Equation 1 + active solvers(4) = 1 2 3 4 +End + +! At some stage the norm has changed. +!Solver 1:: Reference Norm = 1.45087009E-07 + +! Electromagnetic field energy +Solver 3:: Show Norm Index = 2 +Solver 3:: Reference Norm = 8.32659888E-06 diff --git a/fem/tests/mgdyn_hypre_ams2/cylinders/mesh.boundary b/fem/tests/mgdyn_hypre_ams2/cylinders/mesh.boundary new file mode 100644 index 0000000000..d4d637d77f --- /dev/null +++ b/fem/tests/mgdyn_hypre_ams2/cylinders/mesh.boundary @@ -0,0 +1,920 @@ +1 4 436 0 303 1 9 86 +2 4 892 0 303 9 10 131 +3 4 1036 0 303 11 12 132 +4 4 1523 0 303 13 14 133 +5 4 1690 0 303 15 16 134 +6 4 653 0 303 5 47 17 +7 4 474 0 303 7 30 39 +8 4 1577 0 303 30 31 135 +9 4 1819 0 303 32 33 136 +10 4 1335 0 303 34 35 137 +11 4 475 0 303 36 37 138 +12 4 1609 0 303 3 78 38 +13 4 1004 0 303 39 139 40 +14 4 982 0 303 40 140 41 +15 4 981 0 303 40 139 140 +16 4 295 0 303 41 141 42 +17 4 989 0 303 41 140 141 +18 4 953 0 303 42 142 43 +19 4 1828 0 303 42 141 142 +20 4 1658 0 303 43 143 44 +21 4 1381 0 303 43 142 143 +22 4 1240 0 303 44 144 45 +23 4 1341 0 303 44 143 144 +24 4 580 0 303 45 145 46 +25 4 1276 0 303 45 144 145 +26 4 292 0 303 46 146 47 +27 4 1494 0 303 46 145 146 +28 4 1646 0 303 78 79 147 +29 4 567 0 303 80 81 148 +30 4 1806 0 303 81 82 93 +31 4 349 0 303 82 83 93 +32 4 579 0 303 83 84 149 +33 4 793 0 303 85 86 150 +34 4 1310 0 303 94 95 151 +35 4 1748 0 303 95 96 152 +36 4 1356 0 303 96 97 153 +37 4 995 0 303 97 98 154 +38 4 703 0 303 112 153 113 +39 4 748 0 303 113 155 114 +40 4 655 0 303 114 156 115 +41 4 1552 0 303 115 157 116 +42 4 387 0 303 116 158 117 +43 4 425 0 303 117 159 118 +44 4 399 0 303 118 142 119 +45 4 1351 0 303 120 160 121 +46 4 1389 0 303 121 161 122 +47 4 548 0 303 122 162 123 +48 4 356 0 303 123 163 124 +49 4 411 0 303 112 124 152 +50 4 496 0 303 17 47 146 +51 4 1002 0 303 38 78 147 +52 4 514 0 303 10 164 131 +53 4 938 0 303 10 11 164 +54 4 1365 0 303 11 132 164 +55 4 1560 0 303 12 13 165 +56 4 809 0 303 14 15 166 +57 4 1137 0 303 16 17 167 +58 4 591 0 303 33 168 136 +59 4 1696 0 303 33 34 168 +60 4 840 0 303 31 32 169 +61 4 1781 0 303 34 137 168 +62 4 461 0 303 31 169 135 +63 4 1800 0 303 35 36 170 +64 4 1197 0 303 12 165 132 +65 4 341 0 303 37 38 171 +66 4 1732 0 303 30 135 39 +67 4 1565 0 303 79 80 172 +68 4 1532 0 303 81 93 94 +69 4 248 0 303 83 149 93 +70 4 854 0 303 84 85 173 +71 4 1130 0 303 96 153 112 +72 4 707 0 303 113 153 155 +73 4 647 0 303 93 149 98 +74 4 594 0 303 114 155 156 +75 4 1509 0 303 115 156 179 +76 4 1557 0 303 116 157 158 +77 4 894 0 303 117 158 159 +78 4 861 0 303 119 142 174 +79 4 281 0 303 119 174 120 +80 4 1867 0 303 141 174 142 +81 4 1678 0 303 121 160 161 +82 4 623 0 303 122 161 168 +83 4 383 0 303 123 162 163 +84 4 1534 0 303 124 163 152 +85 4 1455 0 303 96 112 152 +86 4 790 0 303 9 131 86 +87 4 1171 0 303 37 171 138 +88 4 1558 0 303 14 166 133 +89 4 799 0 303 16 167 134 +90 4 1744 0 303 35 170 137 +91 4 554 0 303 84 173 149 +92 4 1461 0 303 97 175 153 +93 4 1359 0 303 153 175 155 +94 4 994 0 303 97 154 175 +95 4 1804 0 303 98 149 154 +96 4 611 0 303 120 174 160 +97 4 1659 0 303 15 134 166 +98 4 794 0 303 13 133 165 +99 4 1045 0 303 32 136 169 +100 4 1053 0 303 36 138 170 +101 4 1479 0 303 79 172 147 +102 4 521 0 303 80 148 172 +103 4 1724 0 303 81 94 148 +104 4 930 0 303 85 150 173 +105 4 687 0 303 94 151 148 +106 4 1125 0 303 132 176 164 +107 4 1299 0 303 136 177 169 +108 4 484 0 303 134 167 178 +109 4 661 0 303 133 179 165 +110 4 482 0 303 137 170 180 +111 4 839 0 303 17 146 167 +112 4 1175 0 303 136 168 161 +113 4 525 0 303 149 173 154 +114 4 1700 0 303 137 162 168 +115 4 1830 0 303 147 172 181 +116 4 763 0 303 132 165 182 +117 4 692 0 303 165 179 182 +118 4 322 0 303 38 147 171 +119 4 1128 0 303 39 135 139 +120 4 1896 0 303 135 183 139 +121 4 615 0 303 140 174 141 +122 4 893 0 303 143 159 144 +123 4 1283 0 303 144 184 145 +124 4 883 0 303 144 159 184 +125 4 686 0 303 148 151 172 +126 4 294 0 303 131 164 185 +127 4 1111 0 303 164 176 185 +128 4 1527 0 303 86 131 150 +129 4 844 0 303 131 185 150 +130 4 845 0 303 95 152 186 +131 4 631 0 303 122 168 162 +132 4 1353 0 303 151 181 172 +133 4 886 0 303 118 159 143 +134 4 1360 0 303 133 166 157 +135 4 1478 0 303 139 183 140 +136 4 929 0 303 150 185 173 +137 4 1060 0 303 95 186 151 +138 4 467 0 303 140 160 174 +139 4 949 0 303 157 178 158 +140 4 895 0 303 158 184 159 +141 4 614 0 303 118 143 142 +142 4 1743 0 303 152 163 186 +143 4 750 0 303 135 169 183 +144 4 1792 0 303 147 181 171 +145 4 503 0 303 146 178 167 +146 4 454 0 303 154 173 185 +147 4 831 0 303 137 180 162 +148 4 838 0 303 163 187 186 +149 4 1424 0 303 140 183 160 +150 4 1225 0 303 151 186 188 +151 4 1334 0 303 151 188 181 +152 4 555 0 303 186 187 188 +153 4 1691 0 303 169 177 183 +154 4 1907 0 303 162 187 163 +155 4 1783 0 303 138 189 170 +156 4 507 0 303 145 178 146 +157 4 1366 0 303 132 182 176 +158 4 791 0 303 138 171 181 +159 4 1211 0 303 170 189 180 +160 4 1572 0 303 133 157 179 +161 4 1764 0 303 160 183 177 +162 4 753 0 303 154 185 190 +163 4 402 0 303 154 190 175 +164 4 332 0 303 176 190 185 +165 4 464 0 303 155 175 190 +166 4 1662 0 303 155 182 156 +167 4 1554 0 303 157 166 178 +168 4 406 0 303 115 179 157 +169 4 694 0 303 156 182 179 +170 4 1695 0 303 138 181 189 +171 4 1371 0 303 145 184 178 +172 4 1158 0 303 162 180 187 +173 4 1506 0 303 158 178 184 +174 4 900 0 303 176 182 190 +175 4 314 0 303 180 189 187 +176 4 1338 0 303 155 190 182 +177 4 1587 0 303 134 178 166 +178 4 1342 0 303 187 189 188 +179 4 1116 0 303 136 161 177 +180 4 1903 0 303 160 177 161 +181 4 1677 0 303 181 188 189 +182 3 200 0 303 1 89 9 +183 3 847 0 303 9 191 10 +184 3 938 0 303 10 192 11 +185 3 978 0 303 10 191 192 +186 3 1036 0 303 11 193 12 +187 3 937 0 303 11 192 193 +188 3 1560 0 303 12 194 13 +189 3 479 0 303 12 193 194 +190 3 1173 0 303 13 195 14 +191 3 1378 0 303 13 194 195 +192 3 1526 0 303 14 196 15 +193 3 1207 0 303 14 195 196 +194 3 1690 0 303 15 197 16 +195 3 1682 0 303 15 196 197 +196 3 1137 0 303 16 198 17 +197 3 1613 0 303 16 197 198 +198 3 653 0 303 5 17 199 +199 3 1847 0 303 5 199 77 +200 3 1538 0 303 17 198 199 +201 3 40 0 303 6 75 57 +202 3 63 0 303 57 200 58 +203 3 773 0 303 58 201 59 +204 3 801 0 303 58 200 201 +205 3 1710 0 303 59 202 60 +206 3 1836 0 303 59 201 202 +207 3 1711 0 303 60 203 61 +208 3 806 0 303 60 202 203 +209 3 662 0 303 61 204 62 +210 3 610 0 303 61 203 204 +211 3 1525 0 303 62 205 63 +212 3 1639 0 303 62 204 205 +213 3 1231 0 303 63 206 64 +214 3 583 0 303 63 205 206 +215 3 480 0 303 64 207 65 +216 3 979 0 303 64 206 207 +217 3 701 0 303 2 65 208 +218 3 968 0 303 2 208 87 +219 3 1023 0 303 65 207 208 +220 3 1706 0 303 75 76 209 +221 3 1854 0 303 76 77 210 +222 3 1000 0 303 76 210 209 +223 3 235 0 303 77 199 210 +224 3 1445 0 303 87 211 88 +225 3 415 0 303 87 208 211 +226 3 1824 0 303 88 211 191 +227 3 590 0 303 9 89 191 +228 3 442 0 303 57 75 209 +229 3 835 0 303 88 191 89 +230 3 986 0 303 57 209 200 +231 3 1027 0 303 192 212 193 +232 3 1688 0 303 193 213 194 +233 3 1608 0 303 193 212 213 +234 3 1524 0 303 194 214 195 +235 3 1584 0 303 194 213 214 +236 3 426 0 303 195 215 196 +237 3 939 0 303 195 214 215 +238 3 1017 0 303 196 216 197 +239 3 531 0 303 196 215 216 +240 3 493 0 303 197 217 198 +241 3 1091 0 303 197 216 217 +242 3 369 0 303 198 210 199 +243 3 983 0 303 191 211 218 +244 3 867 0 303 201 216 202 +245 3 1888 0 303 202 215 203 +246 3 942 0 303 203 214 204 +247 3 1372 0 303 204 213 205 +248 3 1636 0 303 205 212 206 +249 3 1705 0 303 206 218 207 +250 3 971 0 303 207 211 208 +251 3 896 0 303 200 217 201 +252 3 769 0 303 200 209 217 +253 3 1272 0 303 191 218 192 +254 3 1108 0 303 207 218 211 +255 3 901 0 303 192 218 212 +256 3 710 0 303 202 216 215 +257 3 494 0 303 198 217 210 +258 3 879 0 303 201 217 216 +259 3 1889 0 303 203 215 214 +260 3 1196 0 303 204 214 213 +261 3 650 0 303 205 213 212 +262 3 1100 0 303 206 212 218 +263 3 771 0 303 209 210 217 +264 3 1601 0 303 8 18 219 +265 3 1736 0 303 18 19 219 +266 3 871 0 303 7 39 20 +267 3 290 0 303 21 220 22 +268 3 1064 0 303 22 221 23 +269 3 731 0 303 22 220 221 +270 3 1750 0 303 23 222 24 +271 3 737 0 303 23 221 222 +272 3 1624 0 303 24 223 25 +273 3 699 0 303 24 222 223 +274 3 783 0 303 25 224 26 +275 3 1859 0 303 25 223 224 +276 3 403 0 303 26 225 27 +277 3 633 0 303 26 224 225 +278 3 511 0 303 27 226 28 +279 3 973 0 303 27 225 226 +280 3 1488 0 303 28 227 29 +281 3 1773 0 303 28 226 227 +282 3 498 0 303 6 29 228 +283 3 40 0 303 6 228 75 +284 3 658 0 303 29 227 228 +285 3 1004 0 303 39 40 229 +286 3 295 0 303 41 42 230 +287 3 1658 0 303 43 44 231 +288 3 580 0 303 45 46 232 +289 3 1847 0 303 5 77 47 +290 11 2 0 303 129 443 130 +291 3 1706 0 303 75 228 76 +292 3 1854 0 303 76 233 77 +293 3 358 0 303 47 77 233 +294 11 13 0 303 128 443 129 +295 3 660 0 303 20 39 229 +296 3 874 0 303 19 20 234 +297 3 1717 0 303 19 234 219 +298 3 459 0 303 42 235 230 +299 3 953 0 303 42 43 235 +300 3 292 0 303 46 47 233 +301 3 982 0 303 40 41 236 +302 3 1093 0 303 43 231 235 +303 3 352 0 303 46 233 232 +304 3 1240 0 303 44 45 237 +305 3 538 0 303 40 236 229 +306 3 1289 0 303 8 219 21 +307 3 1400 0 303 44 237 231 +308 3 394 0 303 41 230 236 +309 3 972 0 303 45 232 237 +310 3 1348 0 303 230 235 238 +311 3 1077 0 303 20 229 234 +312 3 955 0 303 220 234 239 +313 3 501 0 303 21 219 220 +314 3 1095 0 303 231 237 240 +315 3 872 0 303 221 241 222 +316 3 1765 0 303 222 238 223 +317 3 1464 0 303 224 240 225 +318 3 626 0 303 226 242 227 +319 3 1849 0 303 227 243 228 +320 3 51 0 303 76 228 243 +321 3 1848 0 303 227 242 243 +322 3 1379 0 303 231 244 235 +323 3 1154 0 303 231 240 244 +324 3 1725 0 303 230 241 236 +325 3 934 0 303 229 239 234 +326 3 1392 0 303 219 234 220 +327 3 1829 0 303 220 239 221 +328 3 1901 0 303 237 245 240 +329 3 374 0 303 232 245 237 +330 3 1826 0 303 222 241 238 +331 3 77 0 303 232 233 243 +332 3 519 0 303 223 238 244 +333 3 954 0 303 225 240 245 +334 3 1655 0 303 223 244 224 +335 3 1728 0 303 235 244 238 +336 3 1511 0 303 225 245 226 +337 3 1286 0 303 221 239 241 +338 3 1694 0 303 230 238 241 +339 3 1012 0 303 226 245 242 +340 3 1078 0 303 229 236 239 +341 3 1073 0 303 236 241 239 +342 3 1906 0 303 76 243 233 +343 3 520 0 303 224 244 240 +344 3 477 0 303 232 242 245 +345 3 1074 0 303 232 243 242 +346 3 1601 0 303 8 48 18 +347 3 1736 0 303 18 246 19 +348 3 874 0 303 19 247 20 +349 3 1733 0 303 19 246 247 +350 3 871 0 303 7 20 248 +351 3 474 0 303 7 248 30 +352 3 1006 0 303 20 247 248 +353 3 1577 0 303 30 249 31 +354 3 817 0 303 30 248 249 +355 3 840 0 303 31 250 32 +356 3 1874 0 303 31 249 250 +357 3 1819 0 303 32 251 33 +358 3 1151 0 303 32 250 251 +359 3 1696 0 303 33 252 34 +360 3 443 0 303 33 251 252 +361 3 1335 0 303 34 253 35 +362 3 1336 0 303 34 252 253 +363 3 925 0 303 35 254 36 +364 3 860 0 303 35 253 254 +365 3 475 0 303 36 255 37 +366 3 473 0 303 36 254 255 +367 3 341 0 303 37 256 38 +368 3 1051 0 303 37 255 256 +369 3 1609 0 303 3 38 90 +370 3 344 0 303 48 49 257 +371 3 1632 0 303 50 51 258 +372 3 1264 0 303 52 53 259 +373 3 1876 0 303 54 55 260 +374 3 963 0 303 4 92 56 +375 3 414 0 303 90 261 91 +376 3 502 0 303 91 262 92 +377 3 390 0 303 91 261 262 +378 3 792 0 303 56 92 262 +379 3 441 0 303 38 256 90 +380 3 775 0 303 51 263 258 +381 3 602 0 303 51 52 263 +382 3 532 0 303 49 50 264 +383 3 603 0 303 52 259 263 +384 3 752 0 303 49 264 257 +385 3 492 0 303 53 54 265 +386 3 1755 0 303 55 56 266 +387 3 316 0 303 90 256 261 +388 3 1396 0 303 18 48 257 +389 3 296 0 303 55 266 260 +390 3 1605 0 303 50 258 264 +391 3 970 0 303 53 265 259 +392 3 1882 0 303 54 260 265 +393 3 407 0 303 18 257 246 +394 3 1105 0 303 257 264 267 +395 3 1449 0 303 247 249 248 +396 3 1466 0 303 260 268 265 +397 3 947 0 303 249 269 250 +398 3 1146 0 303 250 270 251 +399 3 1462 0 303 250 269 270 +400 3 1787 0 303 251 271 252 +401 3 450 0 303 251 270 271 +402 3 1285 0 303 252 272 253 +403 3 1209 0 303 252 271 272 +404 3 1217 0 303 254 273 255 +405 3 690 0 303 255 274 256 +406 3 1503 0 303 256 274 261 +407 3 376 0 303 255 273 274 +408 3 1719 0 303 258 263 275 +409 3 608 0 303 259 272 263 +410 3 1269 0 303 56 262 266 +411 3 873 0 303 246 257 267 +412 3 1220 0 303 258 276 264 +413 3 958 0 303 264 276 267 +414 3 1630 0 303 258 275 276 +415 3 1611 0 303 260 266 277 +416 3 417 0 303 260 277 268 +417 3 1614 0 303 262 277 266 +418 3 1121 0 303 246 267 247 +419 3 1513 0 303 261 277 262 +420 3 1559 0 303 247 267 269 +421 3 1697 0 303 253 272 278 +422 3 1205 0 303 253 278 254 +423 3 1395 0 303 259 278 272 +424 3 1218 0 303 254 278 273 +425 3 1399 0 303 259 265 278 +426 3 1802 0 303 265 268 278 +427 3 1147 0 303 270 275 271 +428 3 1226 0 303 261 274 277 +429 3 1206 0 303 268 273 278 +430 3 455 0 303 268 274 273 +431 3 952 0 303 269 276 270 +432 3 589 0 303 263 272 275 +433 3 1185 0 303 268 277 274 +434 3 1214 0 303 270 276 275 +435 3 948 0 303 247 269 249 +436 3 964 0 303 267 276 269 +437 3 1893 0 303 271 275 272 +438 5 1289 0 303 8 21 48 +439 5 290 0 303 21 22 279 +440 5 1750 0 303 23 24 280 +441 5 783 0 303 25 26 281 +442 5 511 0 303 27 28 282 +443 5 498 0 303 6 57 29 +444 5 344 0 303 48 283 49 +445 5 532 0 303 49 284 50 +446 5 530 0 303 49 283 284 +447 5 1632 0 303 50 285 51 +448 5 999 0 303 50 284 285 +449 5 602 0 303 51 286 52 +450 5 1625 0 303 51 285 286 +451 5 1264 0 303 52 287 53 +452 5 598 0 303 52 286 287 +453 5 492 0 303 53 288 54 +454 5 957 0 303 53 287 288 +455 5 1876 0 303 54 289 55 +456 5 1640 0 303 54 288 289 +457 5 1755 0 303 55 290 56 +458 5 841 0 303 55 289 290 +459 5 963 0 303 4 56 291 +460 5 616 0 303 4 291 66 +461 5 1067 0 303 56 290 291 +462 5 63 0 303 57 58 292 +463 5 1710 0 303 59 60 293 +464 5 662 0 303 61 62 294 +465 5 1231 0 303 63 64 295 +466 5 701 0 303 2 74 65 +467 5 1627 0 303 66 296 67 +468 5 1161 0 303 66 291 296 +469 5 62 0 303 67 297 68 +470 5 1001 0 303 67 296 297 +471 5 1293 0 303 68 297 69 +472 5 891 0 303 69 128 70 +473 5 857 0 303 70 128 71 +474 5 762 0 303 71 298 72 +475 5 798 0 303 72 299 73 +476 5 1297 0 303 72 298 299 +477 5 1419 0 303 73 300 74 +478 5 1418 0 303 73 299 300 +479 5 1767 0 303 99 100 301 +480 5 1323 0 303 100 101 302 +481 5 779 0 303 101 102 303 +482 5 1629 0 303 102 103 304 +483 5 1702 0 303 103 104 305 +484 5 385 0 303 104 105 306 +485 5 430 0 303 105 106 125 +486 5 1007 0 303 106 107 307 +487 5 384 0 303 107 108 308 +488 5 725 0 303 108 109 309 +489 5 340 0 303 109 110 310 +490 5 863 0 303 110 111 311 +491 5 1426 0 303 99 312 111 +492 5 1754 0 303 125 126 306 +493 5 649 0 303 126 127 313 +494 5 350 0 303 69 127 128 +495 5 1034 0 303 129 130 314 +496 5 730 0 303 125 307 130 +497 5 1132 0 303 106 307 125 +498 5 304 0 303 29 57 292 +499 5 1262 0 303 65 74 300 +500 5 1109 0 303 105 125 306 +501 5 865 0 303 69 297 127 +502 5 1064 0 303 22 23 315 +503 5 1657 0 303 25 281 301 +504 5 1624 0 303 24 25 301 +505 5 403 0 303 26 27 316 +506 5 1488 0 303 28 29 317 +507 5 582 0 303 60 318 293 +508 5 1711 0 303 60 61 318 +509 5 1542 0 303 61 294 318 +510 5 773 0 303 58 59 319 +511 5 460 0 303 58 319 292 +512 5 1525 0 303 62 63 320 +513 5 480 0 303 64 65 321 +514 5 918 0 303 62 320 294 +515 5 1433 0 303 129 314 298 +516 5 1294 0 303 71 128 129 +517 5 945 0 303 100 302 301 +518 5 1751 0 303 22 315 279 +519 5 1376 0 303 101 303 302 +520 5 678 0 303 102 304 327 +521 5 600 0 303 103 305 304 +522 5 1595 0 303 104 306 305 +523 5 1816 0 303 107 308 307 +524 5 625 0 303 108 309 333 +525 5 1622 0 303 109 310 309 +526 5 337 0 303 110 311 310 +527 5 1909 0 303 111 312 311 +528 5 736 0 303 126 313 306 +529 5 542 0 303 23 280 315 +530 5 1254 0 303 130 322 314 +531 5 691 0 303 130 307 322 +532 5 1065 0 303 21 279 48 +533 5 672 0 303 26 316 281 +534 5 1249 0 303 28 317 282 +535 5 1224 0 303 64 321 295 +536 5 837 0 303 127 297 313 +537 5 510 0 303 27 282 316 +538 5 1842 0 303 59 293 319 +539 5 1651 0 303 63 295 320 +540 5 1252 0 303 71 129 298 +541 5 1346 0 303 302 303 323 +542 5 1253 0 303 282 317 324 +543 5 1322 0 303 24 301 280 +544 5 715 0 303 293 325 319 +545 5 523 0 303 295 321 326 +546 5 368 0 303 293 318 309 +547 5 962 0 303 48 279 283 +548 5 1263 0 303 65 300 321 +549 5 1180 0 303 284 327 285 +550 5 1512 0 303 285 304 286 +551 5 1261 0 303 287 328 288 +552 5 1282 0 303 288 329 289 +553 5 1258 0 303 288 328 329 +554 5 777 0 303 289 330 290 +555 5 1535 0 303 289 329 330 +556 5 1759 0 303 290 331 291 +557 5 1486 0 303 291 331 296 +558 5 776 0 303 290 330 331 +559 5 29 0 303 295 332 320 +560 5 458 0 303 295 326 332 +561 5 1610 0 303 309 318 333 +562 5 1367 0 303 108 333 308 +563 5 1522 0 303 294 333 318 +564 5 1129 0 303 294 320 333 +565 5 1473 0 303 298 314 299 +566 5 575 0 303 99 301 281 +567 5 665 0 303 279 315 323 +568 5 397 0 303 29 292 317 +569 5 1061 0 303 280 301 302 +570 5 331 0 303 300 326 321 +571 5 1718 0 303 304 305 328 +572 5 1514 0 303 305 306 334 +573 5 786 0 303 305 334 328 +574 5 1241 0 303 306 313 334 +575 5 1846 0 303 307 308 322 +576 5 1383 0 303 310 311 324 +577 5 285 0 303 280 302 315 +578 5 609 0 303 279 323 283 +579 5 1412 0 303 292 324 317 +580 5 1438 0 303 302 323 315 +581 5 1363 0 303 282 324 311 +582 5 465 0 303 299 326 300 +583 5 1029 0 303 293 309 325 +584 5 1593 0 303 285 327 304 +585 5 552 0 303 286 304 328 +586 5 382 0 303 320 332 333 +587 5 1114 0 303 299 314 326 +588 5 1160 0 303 292 319 324 +589 5 1256 0 303 314 322 326 +590 5 1098 0 303 297 335 313 +591 5 1858 0 303 296 335 297 +592 5 1102 0 303 313 335 334 +593 5 518 0 303 282 311 316 +594 5 1343 0 303 311 312 316 +595 5 581 0 303 283 323 284 +596 5 1345 0 303 102 327 303 +597 5 1769 0 303 309 310 325 +598 5 1591 0 303 303 327 323 +599 5 1808 0 303 310 324 325 +600 5 1052 0 303 328 334 329 +601 5 486 0 303 308 333 332 +602 5 984 0 303 281 316 312 +603 5 328 0 303 284 323 327 +604 5 1398 0 303 286 328 287 +605 5 1791 0 303 329 334 330 +606 5 1843 0 303 322 332 326 +607 5 1476 0 303 99 281 312 +608 5 1809 0 303 308 332 322 +609 5 1149 0 303 319 325 324 +610 5 1520 0 303 296 331 335 +611 5 778 0 303 330 335 331 +612 5 515 0 303 330 334 335 +613 3 616 0 303 4 66 92 +614 3 1627 0 303 66 67 336 +615 3 1293 0 303 68 69 337 +616 3 857 0 303 70 71 338 +617 3 798 0 303 72 73 339 +618 3 968 0 303 2 87 74 +619 3 1609 0 303 3 90 78 +620 3 1646 0 303 78 340 79 +621 3 878 0 303 79 341 80 +622 3 664 0 303 79 340 341 +623 3 567 0 303 80 342 81 +624 3 15 0 303 80 341 342 +625 3 1806 0 303 81 343 82 +626 3 675 0 303 81 342 343 +627 3 349 0 303 82 344 83 +628 3 439 0 303 82 343 344 +629 3 1668 0 303 83 345 84 +630 3 634 0 303 83 344 345 +631 3 854 0 303 84 346 85 +632 3 1277 0 303 84 345 346 +633 3 1775 0 303 85 347 86 +634 3 1413 0 303 85 346 347 +635 3 1189 0 303 1 86 348 +636 3 56 0 303 1 348 89 +637 3 408 0 303 86 347 348 +638 3 571 0 303 78 90 340 +639 3 1445 0 303 87 88 349 +640 3 1193 0 303 88 89 350 +641 3 159 0 303 88 350 349 +642 3 1446 0 303 89 348 350 +643 3 502 0 303 91 92 351 +644 3 444 0 303 74 87 349 +645 3 62 0 303 67 68 352 +646 3 891 0 303 69 70 353 +647 3 762 0 303 71 72 354 +648 3 559 0 303 68 337 352 +649 3 1419 0 303 73 74 355 +650 3 1564 0 303 67 352 336 +651 3 1839 0 303 90 356 340 +652 3 414 0 303 90 91 356 +653 3 1296 0 303 72 339 354 +654 3 666 0 303 70 338 353 +655 3 1162 0 303 66 336 92 +656 3 743 0 303 69 353 337 +657 3 685 0 303 71 354 338 +658 3 1273 0 303 73 355 339 +659 3 318 0 303 340 356 341 +660 3 1566 0 303 341 356 357 +661 3 1813 0 303 338 354 358 +662 3 1790 0 303 92 336 351 +663 3 1187 0 303 339 355 359 +664 3 1471 0 303 338 360 353 +665 3 1469 0 303 338 358 360 +666 3 329 0 303 337 357 352 +667 3 1319 0 303 74 349 355 +668 3 889 0 303 351 352 356 +669 3 1753 0 303 91 351 356 +670 3 313 0 303 341 357 342 +671 3 671 0 303 342 361 343 +672 3 1118 0 303 343 360 344 +673 3 1811 0 303 344 358 345 +674 3 1530 0 303 346 359 347 +675 3 1777 0 303 347 350 348 +676 3 856 0 303 339 362 354 +677 3 53 0 303 339 359 362 +678 3 754 0 303 336 352 351 +679 3 1246 0 303 337 353 361 +680 3 307 0 303 349 359 355 +681 3 706 0 303 352 357 356 +682 3 1248 0 303 353 360 361 +683 3 1833 0 303 343 361 360 +684 3 670 0 303 342 357 361 +685 3 679 0 303 344 360 358 +686 3 326 0 303 345 358 362 +687 3 1243 0 303 345 362 346 +688 3 1275 0 303 349 350 359 +689 3 1305 0 303 354 362 358 +690 3 1598 0 303 346 362 359 +691 3 299 0 303 337 361 357 +692 3 784 0 303 347 359 350 +693 6 1532 0 303 93 94 363 +694 6 1748 0 303 95 96 364 +695 6 995 0 303 97 98 365 +696 6 647 0 303 93 366 98 +697 6 1497 0 303 93 363 366 +698 6 1754 0 303 125 126 367 +699 6 350 0 303 127 128 368 +700 6 1034 0 303 129 130 369 +701 6 730 0 303 125 370 130 +702 6 1032 0 303 125 367 370 +703 6 1310 0 303 94 95 371 +704 6 1356 0 303 96 97 372 +705 6 652 0 303 98 366 365 +706 6 286 0 303 126 373 367 +707 6 649 0 303 126 127 373 +708 6 1212 0 303 127 368 373 +709 6 1294 0 303 128 129 374 +710 6 1198 0 303 130 370 369 +711 6 996 0 303 95 364 371 +712 6 1190 0 303 94 371 363 +713 6 1586 0 303 96 372 364 +714 6 787 0 303 128 374 368 +715 6 1404 0 303 97 365 372 +716 6 1638 0 303 129 369 374 +717 6 1447 0 303 363 371 375 +718 6 780 0 303 368 374 376 +719 6 1457 0 303 365 366 377 +720 6 884 0 303 365 378 372 +721 6 1805 0 303 365 377 378 +722 6 1758 0 303 368 375 373 +723 6 1868 0 303 369 370 379 +724 6 1265 0 303 364 372 380 +725 6 654 0 303 363 381 366 +726 6 556 0 303 366 381 377 +727 6 435 0 303 363 375 381 +728 6 1801 0 303 364 382 371 +729 6 802 0 303 371 382 375 +730 6 726 0 303 364 380 382 +731 6 52 0 303 367 380 370 +732 6 764 0 303 373 375 382 +733 6 628 0 303 369 383 374 +734 6 1475 0 303 372 378 380 +735 6 1793 0 303 367 382 380 +736 6 1320 0 303 369 379 383 +737 6 395 0 303 374 383 376 +738 6 1239 0 303 367 373 382 +739 6 1827 0 303 377 383 378 +740 6 1757 0 303 378 383 379 +741 6 618 0 303 368 376 375 +742 6 1303 0 303 376 383 377 +743 6 1835 0 303 378 379 380 +744 6 1672 0 303 370 380 379 +745 6 1778 0 303 376 377 381 +746 6 682 0 303 375 376 381 +747 7 39 0 303 93 384 94 +748 7 35 0 303 94 384 95 +749 7 32 0 303 93 98 384 +750 7 74 0 303 95 384 96 +751 7 569 0 303 96 384 97 +752 7 8 0 303 97 384 98 +753 8 1767 0 303 99 100 385 +754 8 779 0 303 101 102 386 +755 8 1702 0 303 103 104 387 +756 8 430 0 303 105 106 388 +757 8 384 0 303 107 108 389 +758 8 340 0 303 109 110 390 +759 8 1426 0 303 99 391 111 +760 8 1776 0 303 99 385 391 +761 8 703 0 303 112 392 113 +762 8 748 0 303 113 393 114 +763 8 911 0 303 113 392 393 +764 8 655 0 303 114 394 115 +765 8 1521 0 303 114 393 394 +766 8 1552 0 303 115 395 116 +767 8 1722 0 303 115 394 395 +768 8 387 0 303 116 396 117 +769 8 822 0 303 116 395 396 +770 8 425 0 303 117 397 118 +771 8 401 0 303 117 396 397 +772 8 399 0 303 118 398 119 +773 8 342 0 303 118 397 398 +774 8 281 0 303 119 399 120 +775 8 1749 0 303 119 398 399 +776 8 1351 0 303 120 400 121 +777 8 961 0 303 120 399 400 +778 8 1389 0 303 121 401 122 +779 8 508 0 303 121 400 401 +780 8 548 0 303 122 402 123 +781 8 712 0 303 122 401 402 +782 8 356 0 303 123 403 124 +783 8 440 0 303 123 402 403 +784 8 411 0 303 112 124 404 +785 8 1448 0 303 112 404 392 +786 8 1230 0 303 124 403 404 +787 8 1323 0 303 100 101 405 +788 8 1629 0 303 102 103 406 +789 8 385 0 303 104 105 407 +790 8 1007 0 303 106 107 408 +791 8 725 0 303 108 109 409 +792 8 863 0 303 110 111 410 +793 8 1825 0 303 101 386 405 +794 8 1033 0 303 100 405 385 +795 8 481 0 303 103 387 406 +796 8 578 0 303 102 406 386 +797 8 1666 0 303 104 407 387 +798 8 1852 0 303 106 408 388 +799 8 617 0 303 108 409 389 +800 8 327 0 303 110 410 390 +801 8 1031 0 303 105 388 407 +802 8 564 0 303 107 389 408 +803 8 1138 0 303 109 390 409 +804 8 1339 0 303 111 391 410 +805 8 537 0 303 385 405 411 +806 8 1498 0 303 387 407 412 +807 8 1597 0 303 386 406 413 +808 8 1030 0 303 388 408 414 +809 8 1884 0 303 389 409 415 +810 8 1357 0 303 390 410 416 +811 8 1709 0 303 388 417 407 +812 8 1436 0 303 407 417 412 +813 8 1482 0 303 388 414 417 +814 8 700 0 303 386 418 405 +815 8 1233 0 303 405 418 411 +816 8 1721 0 303 386 413 418 +817 8 1429 0 303 393 419 394 +818 8 1139 0 303 394 415 395 +819 8 813 0 303 396 420 397 +820 8 1815 0 303 397 421 398 +821 8 1648 0 303 397 420 421 +822 8 1546 0 303 399 411 400 +823 8 1467 0 303 400 418 401 +824 8 1840 0 303 401 413 402 +825 8 1654 0 303 387 422 406 +826 8 1547 0 303 406 422 413 +827 8 1831 0 303 387 412 422 +828 8 1431 0 303 392 414 419 +829 8 966 0 303 392 419 393 +830 8 1796 0 303 389 423 408 +831 8 1774 0 303 390 424 409 +832 8 1894 0 303 391 425 410 +833 8 1714 0 303 396 424 416 +834 8 1726 0 303 385 411 426 +835 8 528 0 303 385 426 391 +836 8 1057 0 303 399 426 411 +837 8 1143 0 303 391 426 425 +838 8 1472 0 303 400 411 418 +839 8 1292 0 303 395 424 396 +840 8 1084 0 303 398 426 399 +841 8 1458 0 303 401 418 413 +842 8 1720 0 303 402 413 422 +843 8 363 0 303 402 422 403 +844 8 1391 0 303 403 412 404 +845 8 431 0 303 392 404 417 +846 8 1266 0 303 410 425 416 +847 8 1202 0 303 409 424 415 +848 8 673 0 303 392 417 414 +849 8 1452 0 303 389 415 423 +850 8 1768 0 303 403 422 412 +851 8 1377 0 303 395 415 424 +852 8 683 0 303 404 412 417 +853 8 1892 0 303 398 421 426 +854 8 1333 0 303 394 419 415 +855 8 1772 0 303 390 416 424 +856 8 421 0 303 421 425 426 +857 8 546 0 303 416 425 420 +858 8 1040 0 303 420 425 421 +859 8 1038 0 303 415 419 423 +860 8 922 0 303 408 423 414 +861 8 320 0 303 396 416 420 +862 8 1247 0 303 414 423 419 +863 9 104 0 303 99 427 100 +864 9 256 0 303 100 428 101 +865 9 257 0 303 100 427 428 +866 9 79 0 303 101 428 102 +867 9 164 0 303 102 429 103 +868 9 277 0 303 102 428 429 +869 9 224 0 303 103 429 104 +870 9 202 0 303 104 430 105 +871 9 216 0 303 105 430 106 +872 9 233 0 303 104 429 430 +873 9 112 0 303 106 431 107 +874 9 276 0 303 106 430 431 +875 9 264 0 303 107 431 108 +876 9 120 0 303 108 432 109 +877 9 236 0 303 109 432 110 +878 9 101 0 303 108 431 432 +879 9 184 0 303 110 433 111 +880 9 180 0 303 99 111 433 +881 9 239 0 303 110 432 433 +882 9 94 0 303 99 433 427 +883 9 207 0 303 428 434 429 +884 9 119 0 303 427 434 428 +885 9 84 0 303 429 434 430 +886 9 123 0 303 430 434 431 +887 9 171 0 303 431 434 432 +888 9 173 0 303 427 433 434 +889 9 98 0 303 432 434 433 +890 10 131 0 303 112 113 435 +891 10 82 0 303 113 114 436 +892 10 130 0 303 113 436 435 +893 10 263 0 303 114 115 436 +894 10 125 0 303 115 116 437 +895 10 188 0 303 115 437 436 +896 10 247 0 303 116 117 437 +897 10 177 0 303 117 118 438 +898 10 132 0 303 117 438 437 +899 10 115 0 303 118 119 438 +900 10 160 0 303 119 120 439 +901 10 118 0 303 119 439 438 +902 10 270 0 303 120 121 439 +903 10 205 0 303 121 122 440 +904 10 274 0 303 121 440 439 +905 10 266 0 303 122 123 440 +906 10 108 0 303 123 124 441 +907 10 146 0 303 123 441 440 +908 10 272 0 303 112 441 124 +909 10 273 0 303 112 435 441 +910 10 147 0 303 435 436 442 +911 10 55 0 303 436 437 442 +912 10 87 0 303 437 438 442 +913 10 136 0 303 438 439 442 +914 10 242 0 303 439 440 442 +915 10 97 0 303 435 442 441 +916 10 126 0 303 440 441 442 +917 11 45 0 303 125 443 126 +918 11 58 0 303 126 443 127 +919 11 67 0 303 125 130 443 +920 11 70 0 303 127 443 128 diff --git a/fem/tests/mgdyn_hypre_ams2/cylinders/mesh.elements b/fem/tests/mgdyn_hypre_ams2/cylinders/mesh.elements new file mode 100644 index 0000000000..51e94159cc --- /dev/null +++ b/fem/tests/mgdyn_hypre_ams2/cylinders/mesh.elements @@ -0,0 +1,1909 @@ +1 1 504 364 372 380 530 +2 1 504 129 130 369 443 +3 1 504 376 377 381 530 +4 1 504 94 363 384 371 +5 1 504 366 377 530 381 +6 1 504 129 369 374 443 +7 1 504 367 370 443 531 +8 1 504 97 98 365 384 +9 3 504 447 491 492 493 +10 1 504 367 373 531 443 +11 3 504 451 491 493 492 +12 1 504 363 371 530 384 +13 1 504 128 129 374 443 +14 3 504 367 370 380 388 +15 3 504 80 341 342 524 +16 3 504 297 337 352 525 +17 3 504 296 336 471 352 +18 1 504 368 373 531 375 +19 1 504 98 365 384 366 +20 3 504 356 469 471 525 +21 3 504 444 472 494 475 +22 1 504 375 382 531 530 +23 1 504 378 379 380 535 +24 1 504 126 367 443 373 +25 1 504 127 368 373 443 +26 1 504 378 380 530 535 +27 1 504 128 368 443 374 +28 1 504 130 369 443 370 +29 3 504 295 320 453 332 +30 1 504 363 366 530 381 +31 3 504 83 149 366 480 +32 1 504 93 98 384 366 +33 1 504 371 375 530 382 +34 3 504 448 490 492 491 +35 1 504 94 95 371 384 +36 1 504 365 372 530 378 +37 3 504 296 297 352 471 +38 1 504 379 380 535 531 +39 1 504 93 94 363 384 +40 3 504 6 57 228 75 +41 3 504 451 490 491 492 +42 1 504 380 530 535 531 +43 1 504 125 367 370 443 +44 1 504 364 371 530 382 +45 1 504 125 126 367 443 +46 1 504 375 376 381 530 +47 1 504 368 374 376 531 +48 1 504 364 371 384 530 +49 1 504 370 379 531 380 +50 3 504 194 448 491 490 +51 3 504 76 209 228 243 +52 1 504 367 370 531 380 +53 3 504 339 359 362 528 +54 3 504 382 412 518 519 +55 2 504 436 437 442 534 +56 3 504 1 89 446 348 +57 1 504 363 371 375 530 +58 1 504 126 127 373 443 +59 1 504 364 372 530 384 +60 1 504 365 372 384 530 +61 1 504 373 375 382 531 +62 3 504 67 68 352 297 +63 3 504 57 58 292 200 +64 1 504 364 380 382 530 +65 2 504 403 442 533 532 +66 1 504 367 373 382 531 +67 1 504 125 130 443 370 +68 1 504 93 363 366 384 +69 3 504 213 451 490 491 +70 1 504 127 128 368 443 +71 1 504 374 376 531 383 +72 1 504 369 374 443 531 +73 1 504 377 378 530 535 +74 1 504 95 96 364 384 +75 3 504 232 420 536 497 +76 2 504 403 412 533 422 +77 3 504 232 233 243 455 +78 1 504 375 376 530 531 +79 2 504 101 102 386 428 +80 2 504 403 440 533 442 +81 2 504 385 391 427 434 +82 2 504 113 114 436 393 +83 2 504 102 386 429 406 +84 2 504 429 430 532 434 +85 2 504 124 403 404 441 +86 1 504 380 382 530 531 +87 2 504 437 438 442 534 +88 2 504 385 405 533 434 +89 2 504 385 405 411 533 +90 2 504 429 434 532 533 +91 2 504 403 412 532 533 +92 2 504 392 393 435 419 +93 2 504 387 407 532 430 +94 2 504 99 391 433 427 +95 3 504 232 237 536 420 +96 2 504 100 385 427 405 +97 2 504 435 441 532 442 +98 2 504 432 433 534 434 +99 2 504 386 429 533 434 +100 1 504 376 377 530 535 +101 2 504 108 389 431 432 +102 2 504 432 434 534 532 +103 2 504 416 420 534 425 +104 2 504 99 100 385 427 +105 2 504 388 407 430 532 +106 2 504 438 442 534 533 +107 2 504 387 407 412 532 +108 2 504 123 124 441 403 +109 2 504 434 532 533 534 +110 2 504 403 404 532 412 +111 2 504 385 405 434 427 +112 2 504 106 107 408 431 +113 2 504 120 399 400 439 +114 2 504 402 403 533 422 +115 2 504 118 119 438 398 +116 2 504 402 403 440 533 +117 2 504 402 413 422 533 +118 2 504 119 398 439 438 +119 2 504 405 427 428 434 +120 2 504 108 109 409 432 +121 2 504 119 398 399 439 +122 2 504 118 397 398 438 +123 2 504 430 431 532 434 +124 1 504 379 383 531 535 +125 2 504 115 116 437 395 +126 2 504 403 440 442 441 +127 2 504 421 426 533 534 +128 2 504 397 398 438 421 +129 2 504 390 432 433 534 +130 2 504 113 393 436 435 +131 2 504 112 113 435 392 +132 2 504 117 397 438 437 +133 2 504 397 421 438 534 +134 1 504 376 383 535 531 +135 2 504 393 419 436 435 +136 2 504 438 439 442 533 +137 2 504 399 400 439 533 +138 2 504 421 438 534 533 +139 2 504 389 408 431 532 +140 1 504 376 377 535 383 +141 2 504 404 435 441 532 +142 2 504 396 416 534 424 +143 3 504 184 420 497 536 +144 2 504 114 393 394 436 +145 2 504 393 394 436 419 +146 2 504 123 403 441 440 +147 2 504 435 436 442 532 +148 2 504 112 392 435 404 +149 2 504 113 392 393 435 +150 2 504 403 404 441 532 +151 1 504 378 379 535 383 +152 2 504 398 421 426 533 +153 2 504 397 437 534 438 +154 2 504 395 396 534 424 +155 2 504 442 532 534 533 +156 2 504 395 415 424 534 +157 2 504 111 391 410 433 +158 2 504 115 394 395 436 +159 3 504 88 349 486 350 +160 2 504 119 120 439 399 +161 2 504 387 429 532 533 +162 2 504 390 409 432 534 +163 2 504 419 435 532 436 +164 2 504 102 103 406 429 +165 2 504 123 402 403 440 +166 3 504 145 184 497 536 +167 2 504 387 406 429 533 +168 2 504 396 397 437 534 +169 2 504 394 419 532 436 +170 2 504 409 432 534 532 +171 2 504 431 432 532 434 +172 2 504 392 414 532 417 +173 2 504 391 427 434 433 +174 2 504 414 419 532 423 +175 2 504 110 390 433 410 +176 2 504 99 385 391 427 +177 2 504 117 118 438 397 +178 2 504 401 402 533 413 +179 2 504 386 406 533 429 +180 2 504 99 111 433 391 +181 3 504 145 232 536 497 +182 2 504 397 420 421 534 +183 2 504 104 387 430 407 +184 2 504 110 111 410 433 +185 2 504 385 434 533 534 +186 2 504 121 400 401 439 +187 2 504 391 425 534 426 +188 2 504 115 395 437 436 +189 2 504 388 430 431 532 +190 2 504 385 391 434 534 +191 2 504 388 408 532 431 +192 2 504 390 410 534 433 +193 2 504 400 401 439 533 +194 2 504 385 426 534 533 +195 2 504 410 416 534 425 +196 3 504 199 210 233 455 +197 2 504 391 433 434 534 +198 2 504 396 397 534 420 +199 2 504 387 412 533 532 +200 3 504 1 9 446 89 +201 2 504 395 436 534 437 +202 2 504 104 105 407 430 +203 2 504 106 388 431 408 +204 2 504 103 387 406 429 +205 2 504 121 122 440 401 +206 2 504 386 405 428 434 +207 2 504 386 428 429 434 +208 2 504 398 421 533 438 +209 2 504 101 386 405 428 +210 2 504 398 399 439 533 +211 2 504 406 413 533 422 +212 2 504 395 436 532 534 +213 2 504 394 395 436 532 +214 2 504 394 395 532 415 +215 2 504 389 408 532 423 +216 2 504 105 106 388 430 +217 2 504 105 388 407 430 +218 2 504 409 415 534 424 +219 2 504 409 415 532 534 +220 2 504 390 416 424 534 +221 2 504 395 396 437 534 +222 2 504 387 412 422 533 +223 2 504 404 412 417 532 +224 2 504 103 104 387 429 +225 2 504 436 442 532 534 +226 2 504 389 409 415 532 +227 2 504 390 410 416 534 +228 2 504 391 410 534 425 +229 2 504 389 415 423 532 +230 2 504 399 411 533 426 +231 2 504 389 409 532 432 +232 2 504 107 389 408 431 +233 2 504 104 387 429 430 +234 2 504 398 399 533 426 +235 3 504 77 199 210 233 +236 2 504 109 110 390 432 +237 2 504 392 404 417 532 +238 2 504 386 413 418 533 +239 2 504 110 390 432 433 +240 2 504 387 429 430 532 +241 2 504 396 416 420 534 +242 2 504 439 440 442 533 +243 2 504 395 415 534 532 +244 2 504 394 415 532 419 +245 2 504 408 414 532 423 +246 2 504 407 412 532 417 +247 2 504 116 117 437 396 +248 3 504 83 93 366 149 +249 2 504 388 408 414 532 +250 2 504 388 407 532 417 +251 2 504 390 409 534 424 +252 2 504 391 410 433 534 +253 1 504 365 366 377 530 +254 2 504 386 406 413 533 +255 2 504 403 441 442 532 +256 2 504 100 101 405 428 +257 2 504 100 405 427 428 +258 2 504 386 405 533 418 +259 2 504 109 390 409 432 +260 2 504 387 406 533 422 +261 2 504 108 389 432 409 +262 2 504 117 396 397 437 +263 2 504 114 115 436 394 +264 2 504 107 108 389 431 +265 2 504 386 405 434 533 +266 2 504 122 123 440 402 +267 2 504 122 401 402 440 +268 2 504 385 411 426 533 +269 2 504 392 419 435 532 +270 2 504 120 121 439 400 +271 2 504 116 395 396 437 +272 2 504 112 124 404 441 +273 2 504 112 404 435 441 +274 2 504 121 401 440 439 +275 2 504 388 414 417 532 +276 2 504 106 388 430 431 +277 2 504 102 386 428 429 +278 3 504 356 357 524 525 +279 1 504 365 377 378 530 +280 3 504 220 315 460 504 +281 3 504 119 120 399 174 +282 2 504 405 411 533 418 +283 3 504 203 204 458 490 +284 3 504 186 364 518 371 +285 3 504 280 302 315 504 +286 3 504 126 306 367 373 +287 1 504 367 380 531 382 +288 3 504 138 181 467 522 +289 3 504 501 502 509 505 +290 3 504 21 22 279 220 +291 3 504 333 451 492 458 +292 3 504 46 47 233 146 +293 3 504 122 161 510 401 +294 3 504 131 164 185 484 +295 3 504 41 42 230 141 +296 3 504 55 260 290 266 +297 3 504 239 461 507 504 +298 3 504 511 513 514 515 +299 3 504 337 357 375 361 +300 3 504 268 468 470 526 +301 3 504 273 467 522 517 +302 3 504 148 151 524 371 +303 3 504 138 467 517 522 +304 3 504 29 57 292 228 +305 2 504 415 419 423 532 +306 2 504 389 431 432 532 +307 3 504 349 355 487 359 +308 2 504 385 391 534 426 +309 3 504 268 465 468 526 +310 3 504 136 250 251 462 +311 3 504 291 296 336 471 +312 3 504 146 232 497 455 +313 3 504 341 342 524 357 +314 3 504 180 187 516 189 +315 3 504 260 266 526 470 +316 3 504 90 256 261 469 +317 3 504 140 236 461 507 +318 3 504 340 341 524 356 +319 3 504 238 411 504 507 +320 3 504 396 416 497 420 +321 3 504 282 324 416 459 +322 3 504 38 147 171 469 +323 3 504 361 363 375 381 +324 3 504 518 519 523 527 +325 2 504 398 438 533 439 +326 3 504 345 358 362 529 +327 3 504 110 310 390 410 +328 3 504 284 323 327 464 +329 3 504 337 352 525 357 +330 3 504 345 377 529 445 +331 3 504 300 321 449 326 +332 3 504 176 185 494 190 +333 3 504 210 233 455 243 +334 3 504 154 173 481 445 +335 2 504 421 425 426 534 +336 2 504 420 421 534 425 +337 3 504 110 310 410 311 +338 3 504 33 168 462 252 +339 3 504 326 332 453 472 +340 3 504 109 110 310 390 +341 3 504 37 38 171 256 +342 3 504 118 143 398 397 +343 1 504 369 370 531 443 +344 3 504 48 49 257 283 +345 3 504 191 446 486 488 +346 3 504 474 476 487 482 +347 3 504 164 176 484 447 +348 3 504 201 293 319 456 +349 3 504 82 83 93 344 +350 3 504 69 127 128 368 +351 1 504 369 370 379 531 +352 3 504 46 146 233 232 +353 1 504 369 379 383 531 +354 3 504 139 229 461 236 +355 3 504 284 323 464 460 +356 3 504 123 124 403 163 +357 2 504 400 411 418 533 +358 3 504 47 77 233 199 +359 3 504 201 456 459 499 +360 2 504 399 400 533 411 +361 3 504 157 395 450 454 +362 3 504 320 332 451 453 +363 3 504 402 403 422 512 +364 3 504 474 475 482 487 +365 3 504 146 199 233 455 +366 3 504 17 146 455 199 +367 2 504 400 401 533 418 +368 3 504 293 309 458 318 +369 3 504 198 199 455 210 +370 3 504 472 473 529 475 +371 3 504 57 209 292 228 +372 3 504 132 193 448 447 +373 3 504 395 396 456 454 +374 3 504 232 237 420 245 +375 1 504 376 530 531 535 +376 3 504 255 273 274 522 +377 3 504 138 189 517 467 +378 3 504 162 463 465 512 +379 3 504 238 385 504 411 +380 3 504 145 146 232 497 +381 3 504 221 222 280 504 +382 3 504 320 332 333 451 +383 3 504 123 162 163 403 +384 3 504 107 108 308 389 +385 3 504 104 105 306 407 +386 3 504 378 472 529 475 +387 3 504 116 117 396 158 +388 3 504 45 144 536 237 +389 3 504 450 457 500 489 +390 3 504 91 261 262 351 +391 3 504 143 231 421 237 +392 2 504 401 439 533 440 +393 1 504 368 375 531 376 +394 3 504 41 230 236 507 +395 3 504 374 376 383 529 +396 3 504 143 144 421 397 +397 3 504 29 228 292 317 +398 3 504 327 386 406 464 +399 3 504 118 119 398 142 +400 3 504 175 190 452 494 +401 3 504 117 158 397 396 +402 3 504 154 175 494 190 +403 3 504 26 27 316 225 +404 3 504 288 329 470 468 +405 3 504 332 451 453 492 +406 3 504 115 157 395 179 +407 3 504 18 219 257 246 +408 3 504 86 347 348 446 +409 3 504 371 518 523 527 +410 3 504 89 350 486 446 +411 3 504 112 124 152 404 +412 3 504 347 446 479 476 +413 1 504 365 366 530 384 +414 3 504 90 91 356 261 +415 3 504 87 208 211 349 +416 3 504 154 175 365 494 +417 3 504 260 268 526 277 +418 3 504 204 294 458 451 +419 3 504 180 189 516 517 +420 3 504 231 244 398 421 +421 3 504 244 421 425 426 +422 3 504 183 461 509 507 +423 3 504 202 293 456 458 +424 3 504 134 197 496 498 +425 3 504 117 118 397 159 +426 3 504 195 196 500 215 +427 3 504 154 365 445 494 +428 3 504 152 163 518 404 +429 3 504 189 467 516 517 +430 3 504 105 106 125 388 +431 3 504 364 392 404 417 +432 3 504 176 447 452 494 +433 3 504 372 393 419 452 +434 3 504 350 476 487 486 +435 1 504 363 375 381 530 +436 3 504 1 9 86 446 +437 2 504 401 413 533 418 +438 3 504 176 447 448 452 +439 3 504 82 93 343 344 +440 3 504 123 162 403 402 +441 3 504 38 90 469 256 +442 3 504 57 75 209 228 +443 3 504 33 251 252 462 +444 3 504 74 87 349 208 +445 3 504 154 173 445 480 +446 3 504 462 463 511 514 +447 3 504 136 177 506 462 +448 3 504 156 179 394 450 +449 3 504 212 447 493 491 +450 3 504 251 270 271 462 +451 3 504 161 168 510 462 +452 3 504 33 136 251 462 +453 3 504 352 356 471 525 +454 3 504 154 173 185 481 +455 3 504 268 273 526 274 +456 3 504 378 472 494 492 +457 3 504 267 460 502 503 +458 3 504 295 326 332 453 +459 3 504 42 141 235 230 +460 3 504 58 200 319 292 +461 3 504 31 135 249 169 +462 3 504 137 162 463 465 +463 3 504 168 252 463 462 +464 3 504 155 175 190 452 +465 3 504 299 300 473 326 +466 3 504 223 281 301 391 +467 3 504 140 160 174 507 +468 3 504 167 198 455 496 +469 3 504 395 415 450 456 +470 3 504 496 497 498 499 +471 3 504 188 189 467 516 +472 3 504 409 415 456 458 +473 3 504 36 254 255 517 +474 3 504 7 30 39 248 +475 3 504 36 37 138 255 +476 2 504 401 402 440 533 +477 3 504 232 242 245 420 +478 3 504 232 455 459 497 +479 3 504 12 193 194 448 +480 3 504 64 65 321 207 +481 3 504 103 305 406 387 +482 3 504 137 170 180 517 +483 3 504 475 477 528 487 +484 3 504 134 167 178 497 +485 3 504 477 485 493 495 +486 3 504 308 332 492 333 +487 3 504 15 134 498 197 +488 3 504 198 217 455 499 +489 3 504 153 155 393 452 +490 1 504 363 366 384 530 +491 3 504 282 324 410 416 +492 3 504 53 54 265 288 +493 3 504 197 198 499 217 +494 3 504 198 210 455 217 +495 3 504 448 450 452 492 +496 3 504 17 47 146 199 +497 3 504 224 244 425 426 +498 3 504 6 29 228 57 +499 3 504 339 354 473 529 +500 3 504 512 515 521 520 +501 3 504 21 219 220 279 +502 3 504 91 92 351 262 +503 3 504 146 167 497 178 +504 3 504 262 336 351 471 +505 3 504 92 262 291 336 +506 3 504 188 467 523 518 +507 3 504 145 146 497 178 +508 3 504 121 400 508 401 +509 3 504 267 269 503 502 +510 3 504 27 225 282 316 +511 3 504 27 28 282 226 +512 3 504 470 471 523 527 +513 3 504 300 326 449 473 +514 3 504 10 131 483 164 +515 3 504 330 334 335 470 +516 3 504 206 295 453 321 +517 1 504 97 365 372 384 +518 3 504 282 311 316 410 +519 3 504 223 238 244 426 +520 3 504 224 240 425 244 +521 3 504 80 148 172 524 +522 3 504 147 181 522 524 +523 3 504 295 321 326 453 +524 3 504 469 523 525 524 +525 3 504 149 154 480 173 +526 2 504 392 414 419 532 +527 3 504 17 167 198 455 +528 3 504 223 385 426 391 +529 2 504 392 404 532 435 +530 3 504 49 264 283 284 +531 3 504 196 215 216 500 +532 3 504 49 50 264 284 +533 3 504 359 476 482 487 +534 3 504 327 406 466 464 +535 3 504 405 411 501 504 +536 3 504 242 245 420 416 +537 3 504 385 405 504 411 +538 3 504 40 139 236 229 +539 3 504 411 418 501 509 +540 3 504 359 482 528 487 +541 3 504 386 418 513 505 +542 3 504 23 221 280 315 +543 3 504 157 450 457 454 +544 3 504 219 257 503 460 +545 3 504 240 244 421 425 +546 3 504 245 416 425 420 +547 3 504 273 467 526 522 +548 3 504 122 123 402 162 +549 3 504 372 380 414 392 +550 3 504 133 157 450 457 +551 3 504 132 176 447 448 +552 3 504 286 304 328 466 +553 3 504 274 469 522 526 +554 3 504 84 149 480 173 +555 3 504 186 187 188 518 +556 3 504 344 366 381 377 +557 3 504 255 273 522 517 +558 3 504 314 326 473 472 +559 3 504 68 297 337 352 +560 3 504 306 313 527 373 +561 3 504 229 247 248 461 +562 3 504 237 240 421 420 +563 3 504 105 125 367 388 +564 3 504 107 308 408 389 +565 3 504 285 464 466 514 +566 3 504 220 279 460 315 +567 3 504 80 81 148 342 +568 3 504 203 204 294 458 +569 1 504 96 97 372 384 +570 3 504 234 247 461 503 +571 3 504 78 90 340 469 +572 3 504 198 455 496 499 +573 3 504 234 239 503 461 +574 3 504 264 283 284 460 +575 3 504 99 281 391 301 +576 3 504 343 361 381 363 +577 3 504 378 379 472 492 +578 3 504 102 327 386 406 +579 3 504 83 84 149 480 +580 3 504 45 46 232 145 +581 3 504 283 284 460 323 +582 3 504 60 203 318 293 +583 3 504 63 205 206 295 +584 3 504 444 481 494 484 +585 3 504 165 182 448 450 +586 3 504 369 374 383 473 +587 3 504 133 165 489 450 +588 1 504 96 364 384 372 +589 3 504 263 272 275 521 +590 3 504 9 89 191 446 +591 3 504 33 136 462 168 +592 3 504 466 468 521 520 +593 3 504 13 165 194 489 +594 3 504 114 155 156 393 +595 3 504 84 173 445 346 +596 3 504 502 505 511 509 +597 3 504 137 168 252 463 +598 3 504 52 259 286 287 +599 3 504 210 243 455 459 +600 3 504 103 304 406 305 +601 3 504 286 328 468 466 +602 3 504 51 52 263 286 +603 3 504 52 259 263 286 +604 3 504 48 219 279 257 +605 3 504 259 263 286 521 +606 3 504 378 379 492 423 +607 3 504 232 243 459 455 +608 3 504 259 263 521 272 +609 3 504 279 283 460 323 +610 3 504 61 203 204 294 +611 3 504 120 160 400 174 +612 3 504 203 294 318 458 +613 3 504 469 471 523 526 +614 3 504 118 142 398 143 +615 3 504 140 141 507 174 +616 3 504 4 66 92 291 +617 3 504 108 333 389 409 +618 3 504 361 368 376 375 +619 3 504 305 468 520 519 +620 3 504 268 273 465 526 +621 3 504 347 350 446 476 +622 3 504 444 472 475 477 +623 3 504 122 161 168 510 +624 3 504 338 358 376 529 +625 3 504 108 309 333 409 +626 3 504 226 227 282 242 +627 3 504 293 309 456 458 +628 1 504 369 374 531 383 +629 3 504 196 454 498 457 +630 3 504 216 454 456 499 +631 3 504 122 162 510 168 +632 3 504 12 132 193 448 +633 3 504 26 224 225 316 +634 3 504 83 344 345 480 +635 3 504 444 474 477 475 +636 3 504 81 93 363 343 +637 3 504 475 482 487 528 +638 3 504 207 449 495 488 +639 3 504 474 478 482 481 +640 3 504 396 416 456 497 +641 1 504 368 373 443 531 +642 3 504 470 519 523 526 +643 3 504 478 479 482 481 +644 3 504 364 382 412 518 +645 3 504 86 347 446 479 +646 3 504 306 367 527 519 +647 3 504 93 98 366 149 +648 3 504 83 93 344 366 +649 3 504 126 127 313 373 +650 3 504 205 212 491 213 +651 3 504 216 454 499 498 +652 3 504 98 365 366 480 +653 3 504 5 17 199 47 +654 3 504 343 363 381 366 +655 3 504 114 115 394 156 +656 3 504 378 419 492 452 +657 3 504 142 235 399 398 +658 3 504 29 227 228 317 +659 1 504 368 374 531 443 +660 3 504 20 39 229 248 +661 3 504 133 165 450 179 +662 3 504 61 62 294 204 +663 1 504 377 378 535 383 +664 3 504 79 340 341 524 +665 3 504 279 315 323 460 +666 3 504 70 128 338 353 +667 3 504 225 245 410 425 +668 1 504 372 378 380 530 +669 3 504 461 502 506 509 +670 3 504 342 357 361 375 +671 3 504 342 343 363 361 +672 3 504 26 224 316 281 +673 3 504 380 392 417 414 +674 3 504 448 450 492 490 +675 3 504 81 342 343 363 +676 3 504 377 378 529 445 +677 3 504 153 372 452 393 +678 3 504 102 304 327 406 +679 3 504 344 358 381 360 +680 3 504 182 448 450 452 +681 3 504 211 349 449 486 +682 3 504 361 375 376 381 +683 3 504 364 404 412 417 +684 3 504 93 343 344 366 +685 3 504 71 338 374 354 +686 3 504 148 151 172 524 +687 3 504 94 148 371 151 +688 3 504 173 445 479 481 +689 3 504 303 386 464 505 +690 3 504 255 256 522 274 +691 3 504 130 307 322 369 +692 3 504 165 179 182 450 +693 3 504 465 467 519 526 +694 3 504 156 179 450 182 +695 3 504 71 128 374 338 +696 3 504 294 333 458 451 +697 3 504 319 324 459 456 +698 3 504 386 406 464 513 +699 3 504 24 222 223 301 +700 3 504 386 405 418 505 +701 3 504 2 65 208 74 +702 3 504 165 448 489 450 +703 3 504 112 113 392 153 +704 3 504 205 295 320 453 +705 3 504 194 213 490 491 +706 3 504 352 356 525 357 +707 3 504 113 153 155 393 +708 3 504 302 385 405 504 +709 3 504 135 183 461 506 +710 3 504 202 215 500 216 +711 3 504 405 418 505 501 +712 3 504 122 401 510 402 +713 3 504 270 271 462 514 +714 3 504 188 467 518 516 +715 3 504 293 319 456 325 +716 3 504 453 477 493 495 +717 3 504 461 501 509 504 +718 3 504 375 524 525 527 +719 3 504 242 416 420 459 +720 3 504 224 281 391 312 +721 3 504 460 464 502 501 +722 3 504 306 387 407 519 +723 3 504 322 379 492 472 +724 3 504 364 380 392 417 +725 3 504 108 109 309 409 +726 3 504 364 380 417 382 +727 3 504 465 467 516 519 +728 3 504 367 407 412 519 +729 3 504 122 162 402 510 +730 3 504 125 130 370 307 +731 3 504 22 220 221 315 +732 3 504 162 402 510 512 +733 3 504 106 125 388 370 +734 3 504 142 143 231 398 +735 1 504 95 364 371 384 +736 3 504 126 306 373 313 +737 3 504 23 221 222 280 +738 3 504 418 505 509 511 +739 3 504 78 147 469 340 +740 3 504 468 470 526 519 +741 3 504 258 285 514 464 +742 3 504 418 501 509 505 +743 3 504 69 337 368 353 +744 3 504 222 238 385 504 +745 3 504 470 471 526 523 +746 3 504 152 186 364 518 +747 3 504 219 234 503 246 +748 3 504 113 114 393 155 +749 3 504 273 465 526 467 +750 3 504 135 169 183 506 +751 3 504 270 462 502 514 +752 3 504 49 257 283 264 +753 3 504 154 185 190 494 +754 3 504 336 351 471 352 +755 3 504 164 192 447 483 +756 3 504 165 194 489 448 +757 3 504 203 214 490 500 +758 3 504 133 450 489 457 +759 3 504 401 508 511 509 +760 3 504 342 357 375 524 +761 3 504 453 472 492 493 +762 3 504 71 72 354 298 +763 3 504 132 165 182 448 +764 3 504 373 375 527 382 +765 3 504 214 489 490 500 +766 3 504 303 323 501 464 +767 3 504 200 209 459 292 +768 3 504 466 515 520 521 +769 3 504 200 209 217 459 +770 3 504 209 210 459 243 +771 3 504 209 210 217 459 +772 3 504 218 485 488 495 +773 3 504 58 59 319 201 +774 3 504 273 274 522 526 +775 3 504 51 258 285 263 +776 3 504 290 330 331 470 +777 3 504 289 290 470 330 +778 3 504 330 331 470 335 +779 3 504 101 102 303 386 +780 3 504 338 368 374 376 +781 3 504 197 216 499 498 +782 3 504 345 358 529 377 +783 3 504 25 26 281 224 +784 3 504 347 350 476 359 +785 3 504 171 256 469 522 +786 3 504 305 328 468 334 +787 3 504 128 338 368 374 +788 3 504 86 150 479 446 +789 3 504 360 361 376 381 +790 3 504 9 86 446 131 +791 3 504 138 171 181 522 +792 3 504 56 92 262 291 +793 3 504 85 86 150 479 +794 3 504 13 133 165 489 +795 3 504 14 133 489 457 +796 3 504 191 218 485 488 +797 3 504 192 447 485 493 +798 3 504 72 73 339 299 +799 3 504 16 134 496 167 +800 3 504 378 452 492 494 +801 3 504 58 200 201 319 +802 3 504 371 375 382 527 +803 3 504 411 504 507 509 +804 3 504 134 166 498 497 +805 3 504 166 454 498 497 +806 3 504 60 202 203 293 +807 3 504 203 293 458 318 +808 3 504 450 456 458 500 +809 3 504 14 15 166 457 +810 3 504 261 469 526 471 +811 3 504 112 364 372 392 +812 3 504 413 422 515 512 +813 3 504 184 396 420 397 +814 3 504 357 375 524 525 +815 3 504 160 174 507 509 +816 3 504 160 400 509 508 +817 3 504 30 135 248 249 +818 3 504 355 449 487 528 +819 3 504 464 501 505 502 +820 3 504 286 466 468 521 +821 3 504 135 249 506 461 +822 3 504 116 157 396 395 +823 3 504 372 378 494 452 +824 3 504 273 278 465 517 +825 3 504 259 287 288 468 +826 3 504 474 477 487 488 +827 3 504 329 334 470 468 +828 3 504 135 229 248 461 +829 3 504 298 299 339 473 +830 3 504 465 512 521 520 +831 3 504 137 162 465 180 +832 3 504 304 305 466 406 +833 3 504 371 382 518 527 +834 3 504 378 379 423 414 +835 3 504 88 89 486 191 +836 3 504 47 146 199 233 +837 3 504 127 297 313 373 +838 3 504 163 186 518 187 +839 3 504 17 146 167 455 +840 3 504 31 32 169 250 +841 3 504 55 260 289 290 +842 3 504 225 245 282 410 +843 3 504 38 78 469 90 +844 3 504 131 150 478 185 +845 3 504 95 152 186 364 +846 3 504 299 300 355 473 +847 3 504 9 10 483 191 +848 3 504 298 339 354 473 +849 3 504 176 185 484 494 +850 3 504 211 449 488 486 +851 3 504 473 475 477 528 +852 3 504 374 383 473 529 +853 3 504 298 354 374 473 +854 3 504 84 85 173 346 +855 3 504 314 322 472 369 +856 3 504 339 354 529 362 +857 3 504 70 71 338 128 +858 3 504 137 180 465 517 +859 3 504 449 453 495 477 +860 3 504 35 253 254 517 +861 3 504 119 142 174 399 +862 3 504 137 253 465 463 +863 3 504 110 111 311 410 +864 3 504 137 253 517 465 +865 3 504 69 127 368 297 +866 3 504 81 148 342 363 +867 3 504 201 202 456 216 +868 3 504 183 506 508 509 +869 3 504 146 232 455 233 +870 3 504 378 445 494 475 +871 3 504 7 20 248 39 +872 3 504 221 222 504 241 +873 3 504 246 257 267 503 +874 3 504 19 20 234 247 +875 3 504 258 464 514 502 +876 3 504 323 460 501 464 +877 3 504 201 216 456 499 +878 3 504 79 80 524 341 +879 3 504 201 216 499 217 +880 3 504 163 403 518 404 +881 3 504 36 138 517 255 +882 3 504 162 180 516 465 +883 3 504 144 159 184 397 +884 3 504 365 372 378 494 +885 3 504 264 284 502 460 +886 3 504 118 143 397 159 +887 3 504 154 365 480 445 +888 3 504 337 357 525 375 +889 3 504 351 352 356 471 +890 3 504 305 387 519 520 +891 3 504 69 70 353 128 +892 3 504 9 10 131 483 +893 3 504 143 144 397 159 +894 3 504 117 158 159 397 +895 3 504 158 159 397 184 +896 3 504 200 201 459 217 +897 3 504 135 248 249 461 +898 3 504 98 149 480 366 +899 3 504 271 272 463 521 +900 3 504 176 182 190 452 +901 3 504 192 212 495 218 +902 3 504 206 212 495 493 +903 3 504 378 383 529 472 +904 3 504 359 362 528 482 +905 3 504 365 378 445 494 +906 3 504 176 190 494 452 +907 3 504 221 280 315 504 +908 3 504 88 211 486 349 +909 3 504 354 374 473 529 +910 3 504 128 338 353 368 +911 3 504 113 153 393 392 +912 3 504 156 393 452 394 +913 3 504 10 164 483 192 +914 3 504 161 401 511 510 +915 3 504 150 173 479 481 +916 3 504 121 160 508 400 +917 3 504 192 485 495 493 +918 3 504 62 294 451 320 +919 3 504 192 212 493 495 +920 3 504 181 522 524 523 +921 3 504 69 128 353 368 +922 3 504 379 408 423 414 +923 3 504 223 224 391 426 +924 3 504 223 301 385 391 +925 3 504 35 36 517 254 +926 3 504 148 363 371 524 +927 3 504 467 516 519 518 +928 3 504 223 224 281 391 +929 3 504 150 173 481 185 +930 3 504 85 150 173 479 +931 3 504 208 211 349 449 +932 3 504 192 447 483 485 +933 3 504 208 300 321 449 +934 3 504 229 234 461 239 +935 3 504 263 285 286 466 +936 3 504 131 446 483 478 +937 3 504 11 192 193 447 +938 3 504 10 11 164 192 +939 3 504 195 214 215 500 +940 3 504 399 411 507 509 +941 3 504 134 167 497 496 +942 3 504 203 204 490 214 +943 3 504 219 246 503 257 +944 3 504 247 269 461 503 +945 3 504 100 301 385 302 +946 3 504 144 237 420 536 +947 3 504 249 250 506 269 +948 3 504 247 249 461 269 +949 3 504 157 158 497 178 +950 3 504 167 455 497 496 +951 3 504 142 235 507 399 +952 3 504 269 270 502 276 +953 3 504 42 43 235 142 +954 3 504 225 240 245 425 +955 3 504 220 234 239 503 +956 3 504 461 504 509 507 +957 3 504 53 259 287 288 +958 3 504 264 267 502 276 +959 3 504 272 278 465 521 +960 3 504 249 269 506 461 +961 3 504 120 174 400 399 +962 3 504 48 257 279 283 +963 3 504 4 56 291 92 +964 3 504 267 269 502 276 +965 3 504 411 501 504 509 +966 3 504 372 392 419 393 +967 3 504 346 362 482 445 +968 3 504 2 74 208 87 +969 3 504 350 446 476 486 +970 3 504 53 259 288 265 +971 3 504 207 208 449 211 +972 3 504 45 232 237 536 +973 3 504 27 225 226 282 +974 3 504 224 312 391 425 +975 3 504 224 225 312 425 +976 3 504 84 173 480 445 +977 3 504 364 404 518 412 +978 3 504 10 191 192 483 +979 3 504 64 206 207 321 +980 3 504 207 321 453 449 +981 3 504 40 139 140 236 +982 3 504 40 41 236 140 +983 3 504 191 211 218 488 +984 3 504 224 281 312 316 +985 3 504 41 141 230 507 +986 3 504 57 200 292 209 +987 3 504 140 183 507 461 +988 3 504 150 478 481 479 +989 3 504 41 140 141 507 +990 3 504 378 419 423 492 +991 3 504 41 140 507 236 +992 3 504 192 212 447 493 +993 3 504 207 211 449 488 +994 3 504 97 154 175 365 +995 3 504 97 98 154 365 +996 3 504 95 186 371 364 +997 3 504 220 239 504 503 +998 3 504 302 303 501 405 +999 3 504 50 258 284 285 +1000 3 504 76 209 243 210 +1001 3 504 67 296 297 352 +1002 3 504 38 78 147 469 +1003 3 504 234 246 247 503 +1004 3 504 39 40 229 139 +1005 3 504 106 307 370 408 +1006 3 504 20 229 247 248 +1007 3 504 106 107 307 408 +1008 3 504 160 183 508 509 +1009 3 504 461 501 502 509 +1010 3 504 225 282 316 410 +1011 3 504 242 245 416 282 +1012 3 504 226 242 282 245 +1013 3 504 37 138 255 522 +1014 3 504 269 270 506 502 +1015 3 504 321 326 453 449 +1016 3 504 219 257 460 279 +1017 3 504 196 197 498 216 +1018 3 504 460 501 502 503 +1019 3 504 337 375 525 527 +1020 3 504 201 319 459 456 +1021 3 504 158 184 397 396 +1022 3 504 239 461 504 503 +1023 3 504 65 207 208 321 +1024 3 504 460 501 503 504 +1025 3 504 161 401 508 511 +1026 3 504 451 453 492 493 +1027 3 504 192 193 447 212 +1028 3 504 416 456 497 459 +1029 3 504 293 309 325 456 +1030 3 504 370 388 408 414 +1031 3 504 105 367 407 388 +1032 3 504 125 367 388 370 +1033 3 504 100 302 385 405 +1034 3 504 129 130 314 369 +1035 3 504 161 177 462 508 +1036 3 504 11 12 132 193 +1037 3 504 239 241 504 507 +1038 3 504 415 419 492 423 +1039 3 504 39 135 229 248 +1040 3 504 240 420 425 421 +1041 3 504 174 399 509 400 +1042 3 504 160 183 509 507 +1043 3 504 142 174 399 507 +1044 3 504 502 506 509 511 +1045 3 504 32 136 169 250 +1046 3 504 161 462 511 508 +1047 3 504 305 466 520 468 +1048 3 504 137 252 253 463 +1049 3 504 136 250 462 506 +1050 3 504 201 202 293 456 +1051 3 504 37 255 256 522 +1052 3 504 328 329 468 334 +1053 3 504 36 138 170 517 +1054 3 504 37 171 522 256 +1055 3 504 112 152 364 404 +1056 3 504 11 164 192 447 +1057 3 504 399 411 426 507 +1058 3 504 271 463 514 521 +1059 3 504 301 302 504 385 +1060 3 504 95 151 371 186 +1061 3 504 280 301 302 504 +1062 3 504 332 333 451 492 +1063 3 504 257 279 283 460 +1064 3 504 22 23 315 221 +1065 3 504 21 48 219 279 +1066 3 504 403 512 518 519 +1067 3 504 56 266 290 291 +1068 3 504 262 266 291 471 +1069 3 504 257 264 460 283 +1070 3 504 266 290 291 471 +1071 3 504 229 234 247 461 +1072 3 504 260 268 470 526 +1073 3 504 236 239 507 241 +1074 3 504 232 242 459 243 +1075 3 504 305 328 466 468 +1076 3 504 332 453 472 492 +1077 3 504 20 229 234 247 +1078 3 504 229 236 239 461 +1079 3 504 338 374 529 376 +1080 3 504 506 508 509 511 +1081 3 504 258 276 502 514 +1082 3 504 200 292 459 319 +1083 3 504 235 399 426 507 +1084 3 504 235 398 426 399 +1085 3 504 131 185 478 484 +1086 3 504 326 449 477 453 +1087 3 504 444 447 484 494 +1088 3 504 9 191 483 446 +1089 3 504 150 446 478 479 +1090 3 504 195 196 457 500 +1091 3 504 197 216 217 499 +1092 3 504 297 313 373 527 +1093 3 504 43 142 231 235 +1094 3 504 259 286 468 521 +1095 3 504 231 237 240 421 +1096 3 504 14 195 457 489 +1097 3 504 264 267 460 502 +1098 3 504 297 313 527 335 +1099 3 504 158 184 396 497 +1100 3 504 206 212 218 495 +1101 3 504 473 475 528 529 +1102 3 504 313 334 527 335 +1103 3 504 334 335 470 527 +1104 3 504 205 212 493 491 +1105 3 504 257 264 267 460 +1106 3 504 444 474 481 484 +1107 3 504 444 477 485 493 +1108 3 504 207 211 488 218 +1109 3 504 105 125 306 367 +1110 3 504 207 218 488 495 +1111 3 504 164 176 185 484 +1112 3 504 449 486 487 488 +1113 3 504 358 360 376 381 +1114 3 504 299 314 326 473 +1115 3 504 444 447 493 485 +1116 3 504 136 161 177 462 +1117 3 504 297 337 527 373 +1118 3 504 343 344 381 360 +1119 3 504 270 462 506 502 +1120 3 504 273 465 467 517 +1121 3 504 246 247 503 267 +1122 3 504 181 188 467 523 +1123 3 504 261 274 526 469 +1124 3 504 371 523 524 527 +1125 3 504 132 164 447 176 +1126 3 504 227 228 317 459 +1127 3 504 240 245 425 420 +1128 3 504 39 135 139 229 +1129 3 504 294 320 333 451 +1130 3 504 96 112 372 153 +1131 3 504 185 481 484 494 +1132 3 504 106 125 370 307 +1133 3 504 219 220 279 460 +1134 3 504 143 231 398 421 +1135 3 504 235 244 426 398 +1136 3 504 309 390 456 409 +1137 3 504 16 17 167 198 +1138 3 504 109 309 409 390 +1139 3 504 394 395 415 450 +1140 3 504 156 394 452 450 +1141 3 504 175 365 494 372 +1142 3 504 209 228 243 459 +1143 3 504 224 391 426 425 +1144 3 504 445 475 528 482 +1145 3 504 415 450 456 458 +1146 3 504 250 251 462 270 +1147 3 504 270 271 514 275 +1148 3 504 205 206 453 493 +1149 3 504 319 324 456 325 +1150 3 504 462 506 511 508 +1151 3 504 32 136 250 251 +1152 3 504 310 390 416 456 +1153 3 504 450 489 500 490 +1154 3 504 231 240 244 421 +1155 3 504 162 463 512 510 +1156 3 504 387 422 519 520 +1157 3 504 505 511 513 514 +1158 3 504 162 180 187 516 +1159 3 504 502 505 514 511 +1160 3 504 292 319 324 459 +1161 3 504 66 291 296 336 +1162 3 504 66 92 291 336 +1163 3 504 445 475 482 481 +1164 3 504 474 476 482 478 +1165 3 504 205 451 493 453 +1166 3 504 193 212 491 447 +1167 3 504 346 347 479 482 +1168 3 504 474 478 481 484 +1169 3 504 207 449 453 495 +1170 3 504 185 478 484 481 +1171 3 504 37 138 522 171 +1172 3 504 305 334 468 519 +1173 3 504 13 14 489 195 +1174 3 504 362 445 529 528 +1175 3 504 136 161 462 168 +1176 3 504 465 468 519 520 +1177 3 504 195 214 500 489 +1178 3 504 386 464 505 513 +1179 3 504 305 406 520 466 +1180 3 504 284 285 464 327 +1181 3 504 406 422 520 515 +1182 3 504 406 466 515 520 +1183 3 504 403 412 519 518 +1184 3 504 35 137 253 517 +1185 3 504 268 274 526 277 +1186 3 504 89 191 446 486 +1187 3 504 339 355 359 528 +1188 3 504 284 460 464 502 +1189 3 504 1 86 348 446 +1190 3 504 94 148 363 371 +1191 3 504 308 389 492 408 +1192 3 504 191 211 488 486 +1193 3 504 88 89 350 486 +1194 3 504 206 207 453 495 +1195 3 504 303 327 464 386 +1196 3 504 204 213 490 214 +1197 3 504 12 132 448 165 +1198 3 504 130 307 369 370 +1199 3 504 253 278 517 465 +1200 3 504 144 184 420 397 +1201 3 504 447 448 492 491 +1202 3 504 409 415 424 456 +1203 3 504 389 415 458 492 +1204 3 504 143 144 237 421 +1205 3 504 253 254 517 278 +1206 3 504 268 273 278 465 +1207 3 504 14 195 196 457 +1208 3 504 297 337 373 368 +1209 3 504 252 271 272 463 +1210 3 504 258 263 514 285 +1211 3 504 170 180 517 189 +1212 3 504 127 297 373 368 +1213 3 504 406 413 515 513 +1214 3 504 270 275 514 276 +1215 3 504 270 276 514 502 +1216 3 504 250 270 462 506 +1217 3 504 254 255 517 273 +1218 3 504 254 273 517 278 +1219 3 504 144 184 536 420 +1220 3 504 258 264 502 276 +1221 3 504 465 468 526 519 +1222 3 504 259 286 287 468 +1223 3 504 232 420 497 459 +1224 3 504 64 206 321 295 +1225 3 504 151 186 188 518 +1226 3 504 261 274 277 526 +1227 3 504 261 277 471 526 +1228 3 504 422 512 520 515 +1229 3 504 262 291 336 471 +1230 3 504 124 163 404 403 +1231 3 504 63 64 295 206 +1232 3 504 334 470 519 527 +1233 3 504 405 411 418 501 +1234 3 504 337 361 375 368 +1235 3 504 306 367 519 407 +1236 3 504 370 380 388 414 +1237 3 504 367 382 527 519 +1238 3 504 306 334 519 527 +1239 3 504 367 373 527 382 +1240 3 504 44 45 237 144 +1241 3 504 306 313 334 527 +1242 3 504 152 364 404 518 +1243 3 504 345 346 445 362 +1244 3 504 153 175 452 372 +1245 3 504 306 367 373 527 +1246 3 504 337 353 361 368 +1247 3 504 378 414 423 419 +1248 3 504 353 360 361 376 +1249 3 504 28 227 317 282 +1250 3 504 162 168 463 510 +1251 3 504 222 280 504 301 +1252 3 504 71 129 298 374 +1253 3 504 282 317 324 459 +1254 3 504 130 314 369 322 +1255 3 504 305 387 520 406 +1256 3 504 314 322 326 472 +1257 3 504 265 288 470 468 +1258 3 504 288 328 329 468 +1259 3 504 466 514 515 521 +1260 3 504 334 468 519 470 +1261 3 504 287 288 468 328 +1262 3 504 65 74 300 208 +1263 3 504 65 208 300 321 +1264 3 504 52 53 259 287 +1265 3 504 364 372 392 380 +1266 3 504 245 410 425 416 +1267 3 504 184 396 497 420 +1268 3 504 265 288 289 470 +1269 3 504 56 262 266 291 +1270 3 504 266 470 471 526 +1271 3 504 260 265 289 470 +1272 3 504 191 192 485 218 +1273 3 504 73 299 355 339 +1274 3 504 216 454 500 456 +1275 3 504 349 350 359 487 +1276 3 504 45 144 145 536 +1277 3 504 84 345 346 445 +1278 3 504 338 353 368 376 +1279 3 504 45 145 232 536 +1280 3 504 209 228 459 292 +1281 3 504 11 132 447 193 +1282 3 504 288 289 470 329 +1283 3 504 144 145 536 184 +1284 3 504 297 471 527 525 +1285 3 504 252 253 463 272 +1286 3 504 221 239 241 504 +1287 3 504 297 337 525 527 +1288 3 504 315 323 460 501 +1289 3 504 8 21 48 219 +1290 3 504 355 359 528 487 +1291 3 504 297 352 471 525 +1292 3 504 395 396 424 456 +1293 3 504 68 69 337 297 +1294 3 504 71 128 129 374 +1295 3 504 196 216 498 454 +1296 3 504 72 298 339 354 +1297 3 504 72 298 299 339 +1298 3 504 383 472 473 529 +1299 3 504 136 169 506 177 +1300 3 504 298 369 473 374 +1301 3 504 326 453 477 472 +1302 3 504 181 467 522 523 +1303 3 504 376 377 383 529 +1304 3 504 356 469 525 524 +1305 3 504 354 358 529 362 +1306 3 504 175 372 494 452 +1307 3 504 469 471 525 523 +1308 3 504 523 524 527 525 +1309 3 504 512 516 518 519 +1310 3 504 94 95 151 371 +1311 3 504 15 166 457 498 +1312 3 504 446 474 485 483 +1313 3 504 349 355 449 487 +1314 3 504 299 339 473 355 +1315 3 504 370 379 414 408 +1316 3 504 260 289 290 470 +1317 3 504 151 186 518 371 +1318 3 504 307 370 408 379 +1319 3 504 74 349 355 449 +1320 3 504 369 379 472 383 +1321 3 504 300 355 473 449 +1322 3 504 24 222 301 280 +1323 3 504 100 101 302 405 +1324 3 504 155 156 393 452 +1325 3 504 339 362 529 528 +1326 3 504 345 377 445 480 +1327 3 504 415 450 492 452 +1328 3 504 415 419 452 492 +1329 3 504 342 361 363 375 +1330 3 504 272 463 521 465 +1331 3 504 337 373 375 527 +1332 3 504 69 297 368 337 +1333 3 504 394 415 419 452 +1334 3 504 151 181 523 188 +1335 3 504 34 35 137 253 +1336 3 504 34 137 252 253 +1337 3 504 394 415 452 450 +1338 3 504 155 182 452 190 +1339 3 504 111 312 410 391 +1340 3 504 339 473 528 529 +1341 3 504 44 143 144 237 +1342 3 504 187 188 516 189 +1343 3 504 311 312 316 410 +1344 3 504 147 340 524 469 +1345 3 504 102 303 386 327 +1346 3 504 302 303 323 501 +1347 3 504 467 518 519 523 +1348 3 504 230 235 238 507 +1349 3 504 324 416 459 456 +1350 3 504 263 466 521 514 +1351 3 504 120 121 400 160 +1352 3 504 138 255 522 517 +1353 3 504 151 172 524 181 +1354 3 504 16 167 496 198 +1355 3 504 309 310 456 390 +1356 3 504 96 97 153 372 +1357 3 504 310 390 410 416 +1358 3 504 154 185 494 481 +1359 3 504 153 155 452 175 +1360 3 504 133 157 457 166 +1361 3 504 310 324 416 410 +1362 3 504 225 312 425 410 +1363 3 504 282 311 410 324 +1364 3 504 191 446 485 483 +1365 3 504 11 132 164 447 +1366 3 504 132 176 448 182 +1367 3 504 108 308 389 333 +1368 3 504 176 182 452 448 +1369 3 504 444 472 493 492 +1370 3 504 62 204 451 294 +1371 3 504 145 178 497 184 +1372 3 504 204 205 451 213 +1373 3 504 367 380 417 388 +1374 3 504 315 460 504 501 +1375 3 504 207 208 321 449 +1376 3 504 101 302 405 303 +1377 3 504 395 415 456 424 +1378 3 504 13 194 195 489 +1379 3 504 231 235 398 244 +1380 3 504 454 456 499 497 +1381 3 504 43 142 143 231 +1382 3 504 204 213 451 490 +1383 3 504 310 311 324 410 +1384 3 504 415 450 458 492 +1385 3 504 202 203 458 500 +1386 3 504 268 278 468 465 +1387 3 504 90 261 356 469 +1388 3 504 265 268 468 470 +1389 3 504 121 122 401 161 +1390 3 504 278 465 521 468 +1391 3 504 403 404 412 518 +1392 3 504 219 220 503 234 +1393 3 504 253 272 465 463 +1394 3 504 160 174 509 400 +1395 3 504 259 272 521 278 +1396 3 504 18 48 257 219 +1397 3 504 259 278 521 468 +1398 3 504 286 287 468 328 +1399 3 504 259 265 278 468 +1400 3 504 44 143 237 231 +1401 3 504 449 477 495 488 +1402 3 504 462 502 511 506 +1403 3 504 157 179 450 395 +1404 3 504 97 175 372 365 +1405 3 504 446 474 483 478 +1406 3 504 449 473 477 528 +1407 3 504 303 464 501 505 +1408 3 504 349 449 486 487 +1409 3 504 449 477 488 487 +1410 3 504 195 457 489 500 +1411 3 504 444 474 475 481 +1412 3 504 292 317 459 324 +1413 3 504 85 346 347 479 +1414 3 504 148 342 363 524 +1415 3 504 224 225 316 312 +1416 3 504 154 445 481 494 +1417 3 504 85 173 346 479 +1418 3 504 73 299 300 355 +1419 3 504 73 74 355 300 +1420 3 504 400 401 509 508 +1421 3 504 369 383 472 473 +1422 3 504 191 192 483 485 +1423 3 504 474 475 481 482 +1424 3 504 140 160 507 183 +1425 3 504 444 447 485 484 +1426 3 504 99 111 391 312 +1427 3 504 131 478 483 484 +1428 3 504 474 478 484 483 +1429 3 504 393 394 419 452 +1430 3 504 210 217 459 455 +1431 3 504 372 392 414 419 +1432 3 504 338 354 529 374 +1433 3 504 129 298 369 314 +1434 3 504 367 382 519 412 +1435 3 504 245 282 410 416 +1436 3 504 367 407 417 412 +1437 3 504 367 382 412 417 +1438 3 504 302 315 501 323 +1439 3 504 340 356 524 469 +1440 3 504 342 363 524 375 +1441 3 504 464 505 513 514 +1442 3 504 164 447 484 483 +1443 3 504 449 477 487 528 +1444 3 504 220 460 503 504 +1445 3 504 87 88 349 211 +1446 3 504 89 348 350 446 +1447 3 504 363 371 524 375 +1448 3 504 112 364 392 404 +1449 3 504 247 248 461 249 +1450 3 504 474 475 487 477 +1451 3 504 269 461 502 506 +1452 3 504 389 415 492 423 +1453 3 504 162 403 512 518 +1454 3 504 71 298 354 374 +1455 3 504 96 112 152 364 +1456 3 504 344 366 377 480 +1457 3 504 365 366 480 377 +1458 3 504 401 413 418 511 +1459 3 504 418 505 511 513 +1460 3 504 455 459 497 499 +1461 3 504 97 153 372 175 +1462 3 504 250 269 270 506 +1463 3 504 161 462 510 511 +1464 3 504 224 225 425 240 +1465 3 504 228 292 317 459 +1466 3 504 260 265 470 268 +1467 3 504 400 401 418 509 +1468 3 504 378 472 475 494 +1469 3 504 338 358 360 376 +1470 3 504 238 241 507 504 +1471 3 504 338 353 376 360 +1472 3 504 400 411 509 418 +1473 3 504 298 299 473 314 +1474 3 504 302 405 501 504 +1475 3 504 372 378 414 380 +1476 3 504 99 281 312 391 +1477 3 504 201 217 499 459 +1478 3 504 139 140 461 183 +1479 3 504 79 147 524 172 +1480 3 504 258 284 464 502 +1481 3 504 350 359 487 476 +1482 3 504 380 388 414 417 +1483 3 504 162 402 512 403 +1484 3 504 12 165 448 194 +1485 3 504 151 181 524 523 +1486 3 504 291 296 471 331 +1487 3 504 469 522 523 524 +1488 3 504 28 29 317 227 +1489 3 504 162 163 403 518 +1490 3 504 196 216 454 500 +1491 3 504 467 519 526 523 +1492 3 504 266 290 471 470 +1493 3 504 290 331 471 470 +1494 3 504 46 145 146 232 +1495 3 504 451 458 490 492 +1496 3 504 74 208 349 449 +1497 3 504 93 343 366 363 +1498 3 504 387 407 519 412 +1499 3 504 150 185 481 478 +1500 3 504 467 522 523 526 +1501 3 504 232 242 420 459 +1502 3 504 454 497 499 498 +1503 3 504 256 261 469 274 +1504 3 504 477 485 495 488 +1505 3 504 469 522 526 523 +1506 3 504 158 178 184 497 +1507 3 504 187 188 518 516 +1508 3 504 364 382 417 412 +1509 3 504 115 156 179 394 +1510 3 504 335 470 527 471 +1511 3 504 225 226 282 245 +1512 3 504 285 286 466 304 +1513 3 504 261 262 471 277 +1514 3 504 305 306 334 519 +1515 3 504 307 379 408 492 +1516 3 504 450 458 492 490 +1517 3 504 227 282 459 317 +1518 3 504 314 369 472 473 +1519 3 504 379 408 492 423 +1520 3 504 296 331 335 471 +1521 3 504 114 156 394 393 +1522 3 504 294 318 458 333 +1523 3 504 13 14 133 489 +1524 3 504 194 195 489 214 +1525 3 504 62 63 320 205 +1526 3 504 14 15 457 196 +1527 3 504 86 131 150 446 +1528 3 504 204 451 458 490 +1529 3 504 74 208 449 300 +1530 3 504 346 347 482 359 +1531 3 504 347 359 476 482 +1532 3 504 81 93 94 363 +1533 3 504 472 473 475 477 +1534 3 504 124 152 404 163 +1535 3 504 289 329 330 470 +1536 3 504 146 167 455 497 +1537 3 504 450 454 500 457 +1538 3 504 17 198 199 455 +1539 3 504 476 478 479 482 +1540 3 504 326 472 477 473 +1541 3 504 447 483 485 484 +1542 3 504 61 203 294 318 +1543 3 504 83 344 480 366 +1544 3 504 462 502 514 511 +1545 3 504 463 514 521 515 +1546 3 504 399 400 411 509 +1547 3 504 406 413 422 515 +1548 3 504 331 335 471 470 +1549 3 504 151 188 523 518 +1550 3 504 345 362 445 529 +1551 3 504 446 474 478 476 +1552 3 504 115 116 395 157 +1553 3 504 413 511 515 513 +1554 3 504 157 166 178 497 +1555 3 504 362 445 528 482 +1556 3 504 465 512 520 519 +1557 3 504 116 157 158 396 +1558 3 504 14 133 457 166 +1559 3 504 247 267 269 503 +1560 3 504 12 13 165 194 +1561 3 504 142 231 235 398 +1562 3 504 157 395 454 396 +1563 3 504 176 447 494 484 +1564 3 504 67 296 352 336 +1565 3 504 79 80 172 524 +1566 3 504 341 356 357 524 +1567 3 504 371 375 527 524 +1568 3 504 471 523 527 525 +1569 3 504 261 351 356 471 +1570 3 504 261 356 469 471 +1571 3 504 179 394 450 395 +1572 3 504 133 157 179 450 +1573 3 504 203 458 500 490 +1574 3 504 396 454 497 456 +1575 3 504 217 455 499 459 +1576 3 504 191 446 488 485 +1577 3 504 30 31 135 249 +1578 3 504 196 454 457 500 +1579 3 504 395 450 454 456 +1580 3 504 157 158 396 497 +1581 3 504 157 396 454 497 +1582 3 504 304 327 406 466 +1583 3 504 344 345 480 377 +1584 3 504 194 213 214 490 +1585 3 504 466 513 515 514 +1586 3 504 96 112 364 372 +1587 3 504 134 166 497 178 +1588 3 504 464 466 514 513 +1589 3 504 406 464 513 466 +1590 3 504 297 335 527 471 +1591 3 504 303 323 464 327 +1592 3 504 406 466 513 515 +1593 3 504 285 304 466 327 +1594 3 504 285 327 466 464 +1595 3 504 104 305 387 306 +1596 3 504 455 496 499 497 +1597 3 504 386 406 513 413 +1598 3 504 346 359 482 362 +1599 3 504 476 486 488 487 +1600 3 504 135 169 506 249 +1601 3 504 8 18 219 48 +1602 3 504 258 264 284 502 +1603 3 504 446 476 486 488 +1604 3 504 445 475 481 494 +1605 3 504 50 258 264 284 +1606 3 504 444 474 484 485 +1607 3 504 474 483 484 485 +1608 3 504 193 212 213 491 +1609 3 504 3 38 90 78 +1610 3 504 309 318 333 458 +1611 3 504 260 266 277 526 +1612 3 504 260 266 470 290 +1613 3 504 16 197 198 496 +1614 3 504 262 266 471 277 +1615 3 504 220 221 315 504 +1616 3 504 166 454 457 498 +1617 3 504 235 238 507 426 +1618 3 504 157 166 454 457 +1619 3 504 309 409 456 458 +1620 3 504 447 448 452 492 +1621 3 504 372 378 419 414 +1622 3 504 109 309 390 310 +1623 3 504 141 230 507 235 +1624 3 504 24 25 301 223 +1625 3 504 51 263 285 286 +1626 3 504 225 312 410 316 +1627 3 504 66 67 336 296 +1628 3 504 38 171 256 469 +1629 3 504 102 103 304 406 +1630 3 504 258 275 276 514 +1631 3 504 263 285 466 514 +1632 3 504 50 51 258 285 +1633 3 504 302 315 504 501 +1634 3 504 200 201 319 459 +1635 3 504 444 447 492 493 +1636 3 504 205 206 493 212 +1637 3 504 444 474 485 477 +1638 3 504 129 298 374 369 +1639 3 504 62 204 205 451 +1640 3 504 54 265 288 289 +1641 3 504 205 451 491 493 +1642 3 504 205 206 295 453 +1643 3 504 147 171 469 522 +1644 3 504 80 148 524 342 +1645 3 504 446 474 476 488 +1646 3 504 78 79 147 340 +1647 3 504 205 320 451 453 +1648 3 504 144 397 420 421 +1649 3 504 151 371 523 524 +1650 3 504 256 274 469 522 +1651 3 504 63 205 295 320 +1652 3 504 444 472 477 493 +1653 3 504 444 447 494 492 +1654 3 504 387 406 422 520 +1655 3 504 223 224 426 244 +1656 3 504 444 472 492 494 +1657 3 504 25 223 281 301 +1658 3 504 43 44 231 143 +1659 3 504 15 134 166 498 +1660 3 504 303 386 505 405 +1661 3 504 74 300 449 355 +1662 3 504 155 156 452 182 +1663 3 504 173 346 479 445 +1664 3 504 156 182 450 452 +1665 3 504 84 345 445 480 +1666 3 504 104 306 387 407 +1667 3 504 134 496 497 498 +1668 3 504 83 84 480 345 +1669 3 504 378 445 475 529 +1670 3 504 444 475 494 481 +1671 3 504 305 306 519 387 +1672 3 504 370 379 380 414 +1673 3 504 105 306 407 367 +1674 3 504 15 196 498 457 +1675 3 504 465 468 520 521 +1676 3 504 227 242 459 282 +1677 3 504 181 188 189 467 +1678 3 504 121 160 161 508 +1679 3 504 413 418 511 513 +1680 3 504 151 371 518 523 +1681 3 504 445 475 529 528 +1682 3 504 15 196 197 498 +1683 3 504 343 344 366 381 +1684 3 504 355 449 528 473 +1685 3 504 197 496 498 499 +1686 3 504 157 166 497 454 +1687 3 504 153 372 393 392 +1688 3 504 193 194 491 213 +1689 3 504 450 454 456 500 +1690 3 504 15 16 134 197 +1691 3 504 169 177 183 506 +1692 3 504 238 411 507 426 +1693 3 504 16 134 197 496 +1694 3 504 230 238 241 507 +1695 3 504 138 181 189 467 +1696 3 504 33 34 168 252 +1697 3 504 253 272 278 465 +1698 3 504 461 501 503 502 +1699 3 504 202 456 500 458 +1700 3 504 137 162 168 463 +1701 3 504 372 378 452 419 +1702 3 504 103 104 305 387 +1703 3 504 112 153 392 372 +1704 3 504 322 332 472 492 +1705 3 504 206 207 495 218 +1706 3 504 75 76 209 228 +1707 3 504 197 198 496 499 +1708 3 504 461 501 504 503 +1709 3 504 367 388 417 407 +1710 3 504 59 60 293 202 +1711 3 504 60 61 318 203 +1712 3 504 257 267 503 460 +1713 3 504 62 205 320 451 +1714 3 504 396 416 424 456 +1715 3 504 205 213 491 451 +1716 3 504 177 462 508 506 +1717 3 504 19 219 246 234 +1718 3 504 304 305 328 466 +1719 3 504 258 263 275 514 +1720 3 504 402 413 512 422 +1721 3 504 386 413 513 418 +1722 3 504 115 179 395 394 +1723 3 504 401 402 511 510 +1724 3 504 81 94 148 363 +1725 3 504 230 236 507 241 +1726 3 504 238 385 411 426 +1727 3 504 463 511 515 512 +1728 3 504 235 238 426 244 +1729 3 504 223 238 426 385 +1730 3 504 121 161 401 508 +1731 3 504 219 220 460 503 +1732 3 504 30 39 248 135 +1733 3 504 19 234 246 247 +1734 3 504 463 510 511 512 +1735 3 504 464 502 505 514 +1736 3 504 18 19 219 246 +1737 3 504 402 413 511 512 +1738 3 504 402 510 512 511 +1739 3 504 236 239 461 507 +1740 3 504 202 216 500 456 +1741 3 504 358 376 529 377 +1742 3 504 162 187 518 516 +1743 3 504 152 163 186 518 +1744 3 504 35 137 517 170 +1745 3 504 180 465 517 516 +1746 3 504 465 512 519 516 +1747 3 504 162 465 516 512 +1748 3 504 95 96 152 364 +1749 3 504 119 142 399 398 +1750 3 504 23 24 280 222 +1751 3 504 22 220 315 279 +1752 3 504 266 277 526 471 +1753 3 504 91 261 351 356 +1754 3 504 125 126 306 367 +1755 3 504 55 56 266 290 +1756 3 504 470 519 527 523 +1757 3 504 378 379 383 472 +1758 3 504 337 368 375 373 +1759 3 504 290 291 471 331 +1760 3 504 162 512 516 518 +1761 3 504 135 139 229 461 +1762 3 504 139 140 236 461 +1763 3 504 269 461 503 502 +1764 3 504 160 177 508 183 +1765 3 504 222 223 385 238 +1766 3 504 177 183 506 508 +1767 3 504 99 100 301 385 +1768 3 504 403 412 422 519 +1769 3 504 309 310 325 456 +1770 3 504 416 420 459 497 +1771 3 504 9 131 446 483 +1772 3 504 390 416 456 424 +1773 3 504 28 226 227 282 +1774 3 504 390 409 424 456 +1775 3 504 85 86 479 347 +1776 3 504 99 301 391 385 +1777 3 504 347 348 446 350 +1778 3 504 358 376 377 381 +1779 3 504 303 405 505 501 +1780 3 504 258 284 285 464 +1781 3 504 34 137 168 252 +1782 3 504 271 462 514 463 +1783 3 504 138 170 517 189 +1784 3 504 445 479 481 482 +1785 3 504 263 275 514 521 +1786 3 504 298 314 473 369 +1787 3 504 251 252 462 271 +1788 3 504 147 469 524 522 +1789 3 504 261 262 351 471 +1790 3 504 92 262 336 351 +1791 3 504 329 330 470 334 +1792 3 504 147 171 522 181 +1793 3 504 367 380 382 417 +1794 3 504 422 512 519 520 +1795 3 504 259 265 468 288 +1796 3 504 389 408 423 492 +1797 3 504 131 150 446 478 +1798 3 504 131 164 484 483 +1799 3 504 98 154 365 480 +1800 3 504 35 36 170 517 +1801 3 504 364 371 382 518 +1802 3 504 265 268 278 468 +1803 3 504 446 474 488 485 +1804 3 504 98 149 154 480 +1805 3 504 365 377 445 378 +1806 3 504 81 82 93 343 +1807 3 504 202 203 293 458 +1808 3 504 310 324 325 456 +1809 3 504 308 322 492 332 +1810 3 504 307 322 379 492 +1811 3 504 344 345 377 358 +1812 3 504 193 194 448 491 +1813 3 504 338 354 358 529 +1814 3 504 339 355 528 473 +1815 3 504 143 397 421 398 +1816 3 504 107 307 408 308 +1817 3 504 448 450 490 489 +1818 3 504 450 458 490 500 +1819 3 504 32 33 136 251 +1820 3 504 168 462 463 510 +1821 3 504 194 448 490 489 +1822 3 504 344 358 377 381 +1823 3 504 194 214 489 490 +1824 3 504 88 191 486 211 +1825 3 504 101 303 405 386 +1826 3 504 222 238 504 241 +1827 3 504 377 378 383 529 +1828 3 504 42 141 142 235 +1829 3 504 220 221 504 239 +1830 3 504 147 172 181 524 +1831 3 504 387 412 519 422 +1832 3 504 79 147 340 524 +1833 3 504 343 360 381 361 +1834 3 504 136 169 250 506 +1835 3 504 378 379 414 380 +1836 3 504 59 201 202 293 +1837 3 504 456 459 499 497 +1838 3 504 222 301 504 385 +1839 3 504 90 340 469 356 +1840 3 504 401 402 413 511 +1841 3 504 310 324 456 416 +1842 3 504 59 201 293 319 +1843 3 504 322 326 472 332 +1844 3 504 365 377 480 445 +1845 3 504 144 237 421 420 +1846 3 504 307 308 322 492 +1847 3 504 5 47 199 77 +1848 3 504 227 242 243 459 +1849 3 504 227 228 459 243 +1850 3 504 349 350 487 486 +1851 3 504 206 453 493 495 +1852 3 504 106 370 388 408 +1853 3 504 347 476 479 482 +1854 3 504 76 77 210 233 +1855 3 504 474 476 488 487 +1856 3 504 446 476 478 479 +1857 3 504 346 445 482 479 +1858 3 504 296 297 471 335 +1859 3 504 25 223 224 281 +1860 3 504 322 369 379 472 +1861 3 504 222 223 301 385 +1862 3 504 326 449 473 477 +1863 3 504 382 518 527 519 +1864 3 504 252 271 463 462 +1865 3 504 307 308 492 408 +1866 3 504 463 465 512 521 +1867 3 504 141 142 507 174 +1868 3 504 307 369 370 379 +1869 3 504 353 361 368 376 +1870 3 504 307 322 369 379 +1871 3 504 174 399 507 509 +1872 3 504 447 452 494 492 +1873 3 504 206 207 321 453 +1874 3 504 31 169 249 250 +1875 3 504 169 249 250 506 +1876 3 504 54 55 260 289 +1877 3 504 192 218 495 485 +1878 3 504 309 333 409 458 +1879 3 504 333 389 409 458 +1880 3 504 465 467 517 516 +1881 3 504 308 333 492 389 +1882 3 504 54 260 265 289 +1883 3 504 453 472 493 477 +1884 3 504 389 409 458 415 +1885 3 504 474 477 488 485 +1886 3 504 193 447 491 448 +1887 3 504 333 389 458 492 +1888 3 504 202 203 500 215 +1889 3 504 203 214 500 215 +1890 3 504 141 142 235 507 +1891 3 504 271 275 521 514 +1892 3 504 244 398 421 426 +1893 3 504 271 272 521 275 +1894 3 504 312 391 425 410 +1895 3 504 242 282 416 459 +1896 3 504 135 139 461 183 +1897 3 504 413 511 512 515 +1898 3 504 463 512 515 521 +1899 3 504 463 511 514 515 +1900 3 504 263 286 521 466 +1901 3 504 237 240 420 245 +1902 3 504 183 461 506 509 +1903 3 504 160 161 508 177 +1904 3 504 462 463 510 511 +1905 3 504 401 418 509 511 +1906 3 504 76 210 243 233 +1907 3 504 162 163 518 187 +1908 3 504 403 422 512 519 +1909 3 504 111 311 410 312 diff --git a/fem/tests/mgdyn_hypre_ams2/cylinders/mesh.header b/fem/tests/mgdyn_hypre_ams2/cylinders/mesh.header new file mode 100644 index 0000000000..0d949c3e6f --- /dev/null +++ b/fem/tests/mgdyn_hypre_ams2/cylinders/mesh.header @@ -0,0 +1,4 @@ +536 1909 920 +2 +303 920 +504 1909 diff --git a/fem/tests/mgdyn_hypre_ams2/cylinders/mesh.nodes b/fem/tests/mgdyn_hypre_ams2/cylinders/mesh.nodes new file mode 100644 index 0000000000..f85be890e0 --- /dev/null +++ b/fem/tests/mgdyn_hypre_ams2/cylinders/mesh.nodes @@ -0,0 +1,536 @@ +1 -1 0 0 0 +2 -1 0 0 2 +3 -1 5 0 0 +4 -1 5 0 2 +5 -1 0 5 0 +6 -1 0 5 2 +7 -1 5 5 0 +8 -1 5 5 2 +9 -1 0 0.5 0 +10 -1 0 1 0 +11 -1 0 1.5 0 +12 -1 0 2 0 +13 -1 0 2.5 0 +14 -1 0 3 0 +15 -1 0 3.5 0 +16 -1 0 4 0 +17 -1 0 4.5 0 +18 -1 5 5 1.5 +19 -1 5 5 1 +20 -1 5 5 0.5 +21 -1 4.5 5 2 +22 -1 4 5 2 +23 -1 3.5 5 2 +24 -1 3 5 2 +25 -1 2.5 5 2 +26 -1 2 5 2 +27 -1 1.5 5 2 +28 -1 1 5 2 +29 -1 0.5 5 2 +30 -1 5 4.5 0 +31 -1 5 4 0 +32 -1 5 3.5 0 +33 -1 5 3 0 +34 -1 5 2.5 0 +35 -1 5 2 0 +36 -1 5 1.5 0 +37 -1 5 1 0 +38 -1 5 0.5 0 +39 -1 4.5 5 0 +40 -1 4 5 0 +41 -1 3.5 5 0 +42 -1 3 5 0 +43 -1 2.5 5 0 +44 -1 2 5 0 +45 -1 1.5 5 0 +46 -1 1 5 0 +47 -1 0.5 5 0 +48 -1 5 4.5 2 +49 -1 5 4 2 +50 -1 5 3.5 2 +51 -1 5 3 2 +52 -1 5 2.5 2 +53 -1 5 2 2 +54 -1 5 1.5 2 +55 -1 5 1 2 +56 -1 5 0.5 2 +57 -1 0 4.5 2 +58 -1 0 4 2 +59 -1 0 3.5 2 +60 -1 0 3 2 +61 -1 0 2.5 2 +62 -1 0 2 2 +63 -1 0 1.5 2 +64 -1 0 1 2 +65 -1 0 0.5 2 +66 -1 4.5 0 2 +67 -1 4 0 2 +68 -1 3.5 0 2 +69 -1 3 0 2 +70 -1 2.5 0 2 +71 -1 2 0 2 +72 -1 1.5 0 2 +73 -1 1 0 2 +74 -1 0.5 0 2 +75 -1 0 5 1.5 +76 -1 0 5 1 +77 -1 0 5 0.5 +78 -1 4.5 0 0 +79 -1 4 0 0 +80 -1 3.5 0 0 +81 -1 3 0 0 +82 -1 2.5 0 0 +83 -1 2 0 0 +84 -1 1.5 0 0 +85 -1 1 0 0 +86 -1 0.5 0 0 +87 -1 0 0 1.5 +88 -1 0 0 1 +89 -1 0 0 0.5 +90 -1 5 0 0.5 +91 -1 5 0 1 +92 -1 5 0 1.5 +93 -1 2.5 0.5 0 +94 -1 2.93301 0.75 0 +95 -1 2.93301 1.25 0 +96 -1 2.5 1.5 0 +97 -1 2.06699 1.25 0 +98 -1 2.06699 0.750001 0 +99 -1 2.5 4 2 +100 -1 2.96792 3.88377 2 +101 -1 3.3234 3.56746 2 +102 -1 3.49371 3.11196 2 +103 -1 3.43243 2.63864 2 +104 -1 3.15762 2.24665 2 +105 -1 2.73392 2.02774 2 +106 -1 2.26007 2.02921 2 +107 -1 1.83445 2.25365 2 +108 -1 1.56257 2.65183 2 +109 -1 1.50756 3.12273 2 +110 -1 1.67547 3.56582 2 +111 -1 2.03213 3.8838 2 +112 -1 2.5 2 0 +113 -1 2.03452 2.11494 0 +114 -1 1.67613 2.43322 0 +115 -1 1.50603 2.89032 0 +116 -1 1.56885 3.36464 0 +117 -1 1.84232 3.7533 0 +118 -1 2.2663 3.97231 0 +119 -1 2.73954 3.97089 0 +120 -1 3.16066 3.75069 0 +121 -1 3.43258 3.36095 0 +122 -1 3.49325 2.88405 0 +123 -1 3.32271 2.43153 0 +124 -1 2.96921 2.11691 0 +125 -1 2.5 1.5 2 +126 -1 2.93301 1.25 2 +127 -1 2.93301 0.750001 2 +128 -1 2.5 0.5 2 +129 -1 2.06699 0.749997 2 +130 -1 2.06699 1.25 2 +131 -1 0.440862 0.69728 0 +132 -1 0.443536 1.75321 0 +133 -1 0.489853 2.82588 0 +134 -1 0.362152 3.78173 0 +135 -1 4.57734 4.33131 0 +136 -1 4.49591 3.31376 0 +137 -1 4.50175 2.24063 0 +138 -1 4.57481 1.25115 0 +139 -1 4.18404 4.58432 0 +140 -1 3.70064 4.47231 0 +141 -1 3.22763 4.62478 0 +142 -1 2.71957 4.47774 0 +143 -1 2.17668 4.52468 0 +144 -1 1.67447 4.58335 0 +145 -1 1.16429 4.56976 0 +146 -1 0.668178 4.55489 0 +147 -1 4.31837 0.438279 0 +148 -1 3.32708 0.439425 0 +149 -1 1.80408 0.412832 0 +150 -1 0.830694 0.434424 0 +151 -1 3.4566 0.938372 0 +152 -1 2.93998 1.70596 0 +153 -1 2.06732 1.70463 0 +154 -1 1.57703 0.957664 0 +155 -1 1.56037 1.93046 0 +156 -1 1.2989 2.36682 0 +157 -1 1.03228 3.25051 0 +158 -1 1.38764 3.77896 0 +159 -1 1.80193 4.14958 0 +160 -1 3.66891 3.83794 0 +161 -1 3.92159 3.27124 0 +162 -1 3.86182 2.31353 0 +163 -1 3.3809 1.96474 0 +164 -1 0.437359 1.22237 0 +165 -1 0.479642 2.27908 0 +166 -1 0.490897 3.35393 0 +167 -1 0.393521 4.18321 0 +168 -1 4.32709 2.77971 0 +169 -1 4.56696 3.82244 0 +170 -1 4.58328 1.73328 0 +171 -1 4.59058 0.815473 0 +172 -1 3.79496 0.470163 0 +173 -1 1.29149 0.470692 0 +174 -1 3.2135 4.18663 0 +175 -1 1.69614 1.46093 0 +176 -1 0.813905 1.47656 0 +177 -1 4.14986 3.66572 0 +178 -1 0.872396 3.96045 0 +179 -1 0.938507 2.61247 0 +180 -1 4.17938 1.91591 0 +181 -1 4.09599 0.942625 0 +182 -1 0.963094 1.98413 0 +183 -1 4.13075 4.12066 0 +184 -1 1.37308 4.21059 0 +185 -1 0.957526 0.95983 0 +186 -1 3.36562 1.48055 0 +187 -1 3.77954 1.75022 0 +188 -1 3.77271 1.30374 0 +189 -1 4.1741 1.47401 0 +190 -1 1.25713 1.46026 0 +191 -1 0 0.584522 0.617438 +192 -1 0 1.19803 0.532523 +193 -1 0 1.73106 0.509539 +194 -1 0 2.24429 0.502087 +195 -1 0 2.75131 0.500158 +196 -1 0 3.25715 0.49991 +197 -1 0 3.7616 0.495153 +198 -1 0 4.24053 0.441414 +199 -1 0 4.66051 0.346804 +200 -1 0 4.18526 1.55785 +201 -1 0 3.7419 1.5082 +202 -1 0 3.25148 1.50016 +203 -1 0 2.7509 1.49888 +204 -1 0 2.24841 1.49998 +205 -1 0 1.74588 1.50544 +206 -1 0 1.24707 1.52277 +207 -1 0 0.7668 1.57254 +208 -1 0 0.344096 1.65283 +209 -1 0 4.57159 1.29966 +210 -1 0 4.58364 0.784945 +211 -1 0 0.440165 1.20969 +212 -1 0 1.47644 1.01864 +213 -1 0 1.99051 1.00365 +214 -1 0 2.49908 0.999329 +215 -1 0 3.0071 0.998991 +216 -1 0 3.5228 1.0008 +217 -1 0 4.08036 1.00963 +218 -1 0 0.951124 1.06715 +219 -1 4.64565 5 1.4949 +220 -1 4.21607 5 1.49167 +221 -1 3.74063 5 1.49417 +222 -1 3.24818 5 1.49761 +223 -1 2.75112 5 1.5009 +224 -1 2.2551 5 1.50691 +225 -1 1.7644 5 1.52246 +226 -1 1.28693 5 1.55335 +227 -1 0.812099 5 1.547 +228 -1 0.37431 5 1.50196 +229 -1 4.29705 5 0.491169 +230 -1 3.25277 5 0.497244 +231 -1 2.24239 5 0.508091 +232 -1 1.14078 5 0.607425 +233 -1 0.565526 5 0.532974 +234 -1 4.50933 5 0.97612 +235 -1 2.74861 5 0.501035 +236 -1 3.76218 5 0.493912 +237 -1 1.72293 5 0.528314 +238 -1 3.00037 5 0.998038 +239 -1 4.00348 5 0.985668 +240 -1 2.00163 5 1.01777 +241 -1 3.50116 5 0.992721 +242 -1 1.07418 5 1.15052 +243 -1 0.634481 5 1.04426 +244 -1 2.50016 5 1.00405 +245 -1 1.51225 5 1.05429 +246 -1 5 4.58995 1.21644 +247 -1 5 4.49822 0.7804 +248 -1 5 4.64111 0.343645 +249 -1 5 4.20182 0.390749 +250 -1 5 3.71288 0.390517 +251 -1 5 3.22371 0.380601 +252 -1 5 2.72178 0.418326 +253 -1 5 2.22799 0.47631 +254 -1 5 1.7319 0.425451 +255 -1 5 1.22605 0.391301 +256 -1 5 0.704154 0.424887 +257 -1 5 4.32753 1.59947 +258 -1 5 3.28703 1.57833 +259 -1 5 2.2367 1.49594 +260 -1 5 1.22369 1.59384 +261 -1 5 0.50069 0.877473 +262 -1 5 0.425531 1.36617 +263 -1 5 2.76159 1.53235 +264 -1 5 3.8037 1.59138 +265 -1 5 1.71516 1.53424 +266 -1 5 0.792947 1.63961 +267 -1 5 4.11539 1.1899 +268 -1 5 1.36543 1.16371 +269 -1 5 3.92245 0.788088 +270 -1 5 3.42618 0.777264 +271 -1 5 2.97909 0.744491 +272 -1 5 2.52877 0.977271 +273 -1 5 1.45047 0.755343 +274 -1 5 1.00364 0.804926 +275 -1 5 3.08587 1.15204 +276 -1 5 3.59985 1.18247 +277 -1 5 0.880539 1.22992 +278 -1 5 1.90724 0.980748 +279 -1 4.30494 4.54926 2 +280 -1 3.30192 4.60247 2 +281 -1 2.29229 4.5636 2 +282 -1 1.27489 4.53481 2 +283 -1 4.56833 4.15963 2 +284 -1 4.52741 3.69311 2 +285 -1 4.51499 3.1664 2 +286 -1 4.52383 2.64619 2 +287 -1 4.64755 2.21397 2 +288 -1 4.61675 1.78355 2 +289 -1 4.62003 1.31131 2 +290 -1 4.62338 0.857686 2 +291 -1 4.58073 0.410127 2 +292 -1 0.437264 4.30293 2 +293 -1 0.446818 3.2446 2 +294 -1 0.38318 2.27009 2 +295 -1 0.484649 1.31136 2 +296 -1 4.0915 0.399642 2 +297 -1 3.50641 0.47146 2 +298 -1 1.68189 0.430135 2 +299 -1 1.22265 0.475674 2 +300 -1 0.702156 0.455446 2 +301 -1 2.84282 4.44177 2 +302 -1 3.43132 4.09692 2 +303 -1 3.70667 3.6428 2 +304 -1 3.97693 2.74831 2 +305 -1 3.6348 2.14458 2 +306 -1 3.17648 1.69568 2 +307 -1 1.91042 1.7389 2 +308 -1 1.40944 2.00423 2 +309 -1 0.996613 2.99755 2 +310 -1 1.24576 3.55912 2 +311 -1 1.54831 4.06381 2 +312 -1 2.02938 4.24184 2 +313 -1 3.37306 1.09225 2 +314 -1 1.5707 0.906794 2 +315 -1 3.77712 4.53329 2 +316 -1 1.76452 4.57989 2 +317 -1 0.823789 4.56873 2 +318 -1 0.473227 2.73212 2 +319 -1 0.43594 3.7747 2 +320 -1 0.470108 1.81824 2 +321 -1 0.44457 0.846378 2 +322 -1 1.47589 1.42405 2 +323 -1 4.05852 4.0132 2 +324 -1 0.946778 4.04489 2 +325 -1 0.813524 3.52034 2 +326 -1 0.984098 1.01136 2 +327 -1 4.067 3.38242 2 +328 -1 4.1716 2.10782 2 +329 -1 4.25529 1.58142 2 +330 -1 4.21016 1.14697 2 +331 -1 4.26103 0.735677 2 +332 -1 0.959337 1.63899 2 +333 -1 0.909327 2.30086 2 +334 -1 3.77262 1.51938 2 +335 -1 3.83515 0.881476 2 +336 -1 4.3632 0 1.6406 +337 -1 3.3148 0 1.47816 +338 -1 2.2605 0 1.49773 +339 -1 1.26002 0 1.50945 +340 -1 4.31598 0 0.381597 +341 -1 3.82299 0 0.463123 +342 -1 3.29189 0 0.488834 +343 -1 2.7704 0 0.497316 +344 -1 2.25641 0 0.500612 +345 -1 1.74669 0 0.501748 +346 -1 1.24028 0 0.497402 +347 -1 0.760467 0 0.443127 +348 -1 0.339896 0 0.347383 +349 -1 0.428943 0 1.30065 +350 -1 0.416868 0 0.786174 +351 -1 4.50898 0 1.25237 +352 -1 3.92008 0 1.42808 +353 -1 2.7773 0 1.49255 +354 -1 1.75297 0 1.50138 +355 -1 0.815466 0 1.55885 +356 -1 4.28627 0 0.848 +357 -1 3.61595 0 0.958692 +358 -1 2.00167 0 1.00085 +359 -1 0.921131 0 1.01231 +360 -1 2.52045 0 0.996787 +361 -1 3.05042 0 0.987566 +362 -1 1.48101 0 1.00384 +363 -1 2.7623 0.574324 0.423755 +364 -1 2.73471 1.44149 0.501174 +365 -1 2.00112 0.966614 0.409572 +366 -1 2.26344 0.559501 0.384572 +367 -1 2.74604 1.43528 1.50847 +368 -1 2.72702 0.554509 1.5371 +369 -1 2.00019 1.01394 1.61547 +370 -1 2.261 1.43918 1.57616 +371 -1 2.99999 0.997162 0.491686 +372 -1 2.22627 1.41842 0.463195 +373 -1 2.99975 0.984135 1.49906 +374 -1 2.2228 0.583876 1.59057 +375 -1 2.89015 0.687295 0.986142 +376 -1 2.39451 0.511256 1.16202 +377 -1 2.11058 0.686388 0.792025 +378 -1 2.02314 1.15033 0.838376 +379 -1 2.06476 1.24609 1.24945 +380 -1 2.42117 1.49375 1.01411 +381 -1 2.49827 0.500003 0.750499 +382 -1 2.93235 1.25115 1.00019 +383 -1 2.03465 0.817118 1.20805 +384 -1 2.5 1 0 +385 -1 2.7808 3.95977 1.50577 +386 -1 3.45337 3.3018 1.50297 +387 -1 3.28819 2.38457 1.50735 +388 -1 2.45163 2.00117 1.53798 +389 -1 1.65698 2.46211 1.56717 +390 -1 1.57167 3.37176 1.54332 +391 -1 2.29471 3.9787 1.54466 +392 -1 2.25055 2.03161 0.543669 +393 -1 1.84748 2.24223 0.358659 +394 -1 1.59126 2.58264 0.456276 +395 -1 1.5011 3.04695 0.512694 +396 -1 1.64966 3.52624 0.542471 +397 -1 2.02154 3.87811 0.397488 +398 -1 2.47437 3.99967 0.430682 +399 -1 2.90977 3.91219 0.490294 +400 -1 3.2829 3.62214 0.501041 +401 -1 3.48229 3.18735 0.503701 +402 -1 3.456 2.70665 0.505644 +403 -1 3.20592 2.2917 0.509889 +404 -1 2.78037 2.04011 0.518429 +405 -1 3.20048 3.71367 1.50139 +406 -1 3.48396 2.82163 1.5041 +407 -1 2.91275 2.08915 1.51508 +408 -1 2.00747 2.12971 1.57823 +409 -1 1.50466 2.90358 1.52369 +410 -1 1.85087 3.76068 1.56485 +411 -1 3.0512 3.83437 1.00077 +412 -1 3.06928 2.17786 1.01644 +413 -1 3.49997 3.00792 1.00601 +414 -1 2.15778 2.06038 1.10613 +415 -1 1.55849 2.663 1.01487 +416 -1 1.69955 3.5994 1.12104 +417 -1 2.61669 2.00683 1.03628 +418 -1 3.37998 3.475 1.00393 +419 -1 1.82516 2.26203 0.78434 +420 -1 1.88732 3.79033 0.796086 +421 -1 2.2132 3.95799 0.76086 +422 -1 3.38779 2.53975 1.009 +423 -1 1.80315 2.28278 1.21193 +424 -1 1.51686 3.18287 1.04142 +425 -1 2.06713 3.90145 1.15968 +426 -1 2.5721 3.9974 0.998078 +427 -1 2.63591 3.54276 2 +428 -1 2.99472 3.30168 2 +429 -1 3.01873 2.80488 2 +430 -1 2.6313 2.47051 2 +431 -1 2.13545 2.59492 2 +432 -1 1.95258 3.07083 2 +433 -1 2.20714 3.49721 2 +434 -1 2.50901 3.03255 2 +435 -1 2.36587 2.45738 0 +436 -1 2.00989 2.69992 0 +437 -1 1.98295 3.19817 0 +438 -1 2.36963 3.52836 0 +439 -1 2.8622 3.40557 0 +440 -1 3.04685 2.93158 0 +441 -1 2.79345 2.50298 0 +442 -1 2.49168 2.96798 0 +443 -1 2.5 1 2 +444 -1 0.91692 1.12319 0.806137 +445 -1 1.47521 0.526616 0.582443 +446 -1 0.39518 0.393891 0.419825 +447 -1 0.549475 1.47358 0.518374 +448 -1 0.593209 2.01475 0.45625 +449 -1 0.549393 0.528851 1.47357 +450 -1 0.90563 2.57548 0.570469 +451 -1 0.508981 1.99815 1.50631 +452 -1 1.38163 1.86922 0.483259 +453 -1 0.619597 1.2753 1.56753 +454 -1 0.692122 3.33623 0.630146 +455 -1 0.458671 4.38515 0.546964 +456 -1 0.891402 3.37152 1.2536 +457 -1 0.406033 3.06557 0.351453 +458 -1 0.742593 2.6468 1.43356 +459 -1 0.679039 4.26119 1.17812 +460 -1 4.35086 4.21089 1.5781 +461 -1 4.25986 4.4003 0.603741 +462 -1 4.46106 3.18479 0.455976 +463 -1 4.42567 2.63244 0.610685 +464 -1 4.15009 3.45623 1.57211 +465 -1 4.38998 1.97741 0.765479 +466 -1 4.16074 2.76872 1.56272 +467 -1 4.18353 1.38541 0.535468 +468 -1 4.3469 1.95809 1.4707 +469 -1 4.5455 0.507932 0.562027 +470 -1 4.32536 1.2495 1.58331 +471 -1 4.32984 0.593771 1.408 +472 -1 1.34912 1.13304 1.31573 +473 -1 1.34752 0.613765 1.54526 +474 -1 0.741797 0.715329 0.701587 +475 -1 1.20064 0.764918 0.911156 +476 -1 0.670327 0.326291 0.682307 +477 -1 0.8115 0.859314 1.18966 +478 -1 0.741573 0.62614 0.35541 +479 -1 0.930898 0.30511 0.322807 +480 -1 1.80357 0.467777 0.337997 +481 -1 1.09631 0.741127 0.399452 +482 -1 1.02833 0.367195 0.711488 +483 -1 0.355413 0.868385 0.350662 +484 -1 0.751851 1.03994 0.365287 +485 -1 0.427589 0.939869 0.75418 +486 -1 0.301426 0.298692 0.918661 +487 -1 0.725425 0.377334 1.04826 +488 -1 0.386109 0.649098 0.985252 +489 -1 0.353425 2.5774 0.440292 +490 -1 0.446919 2.3433 1.00343 +491 -1 0.392254 1.82302 0.930756 +492 -1 1.21224 1.84752 1.21088 +493 -1 0.540742 1.39104 1.10211 +494 -1 1.33638 1.22745 0.476763 +495 -1 0.329326 1.06091 1.18752 +496 -1 0.335599 3.98407 0.379821 +497 -1 0.902278 3.9391 0.479151 +498 -1 0.348497 3.57125 0.417225 +499 -1 0.403765 3.87081 0.821521 +500 -1 0.397388 2.94499 0.936729 +501 -1 3.82449 3.97483 1.34571 +502 -1 4.4637 3.73682 1.13296 +503 -1 4.46833 4.45031 1.13157 +504 -1 3.57499 4.46137 1.32711 +505 -1 3.84679 3.54078 1.22571 +506 -1 4.43739 3.81048 0.478157 +507 -1 3.42437 4.45038 0.532426 +508 -1 3.8723 3.58818 0.334343 +509 -1 3.6605 3.88147 0.698621 +510 -1 3.93212 2.8544 0.343448 +511 -1 3.94734 3.19417 0.752022 +512 -1 3.84568 2.41311 0.716984 +513 -1 3.84843 3.13255 1.22139 +514 -1 4.47025 3.12839 1.15844 +515 -1 3.96669 2.75795 1.10658 +516 -1 3.97098 1.7676 0.407323 +517 -1 4.6158 1.70265 0.357887 +518 -1 3.43515 1.62676 0.511113 +519 -1 3.67072 1.80505 1.165 +520 -1 3.88479 2.33349 1.29905 +521 -1 4.52321 2.50216 1.19009 +522 -1 4.50407 1.00925 0.419674 +523 -1 3.91633 1.01867 0.765868 +524 -1 3.74697 0.483584 0.472566 +525 -1 3.82601 0.453107 1.12634 +526 -1 4.53627 1.11406 1.06998 +527 -1 3.50802 1.07058 1.29422 +528 -1 1.1446 0.370277 1.17165 +529 -1 1.71693 0.458113 1.1011 +530 -1 2.50905 0.96427 0.71598 +531 -1 2.49857 1.00161 1.34003 +532 -1 2.34435 2.60992 1.04044 +533 -1 2.8573 3.17186 0.898997 +534 -1 2.13235 3.32612 1.02193 +535 -1 2.26583 0.986776 1.03037 +536 -1 1.38874 4.50294 0.326848 diff --git a/fem/tests/mgdyn_hypre_ams2/runtest.cmake b/fem/tests/mgdyn_hypre_ams2/runtest.cmake new file mode 100644 index 0000000000..cac4da63b6 --- /dev/null +++ b/fem/tests/mgdyn_hypre_ams2/runtest.cmake @@ -0,0 +1,4 @@ +include(test_macros) +execute_process(COMMAND ${ELMERGRID_BIN} 2 2 cylinders -metis 2 3 -nooverwrite) + +RUN_ELMER_TEST()