====================== *** PetIBM - Start *** ====================== Parsing file ./cartesianMesh.yaml... done. Parsing file ./flowDescription.yaml... done. Parsing file ./simulationParameters.yaml... done. --------------------------------------- Cartesian grid --------------------------------------- number of cells: 32 x 32 --------------------------------------- --------------------------------------- Flow --------------------------------------- dimensions: 2 viscosity: 0.01 initial velocity field: 0 0 boundary conditions (component, type, value): ->location: xMinus (left) 0 DIRICHLET 0 1 DIRICHLET 0 ->location: xPlus (right) 0 DIRICHLET 0 1 DIRICHLET 0 ->location: yMinus (bottom) 0 DIRICHLET 0 1 DIRICHLET 0 ->location: yPlus (top) 0 DIRICHLET 1 1 DIRICHLET 0 --------------------------------------- --------------------------------------- Time-stepping --------------------------------------- formulation: Navier-Stokes solver (Perot, 1993) convection: second-order Adams-Bashforth diffusion: second-order Crank-Nicolson time-increment: 0.02 starting time-step: 0 number of time-steps: 1 saving-interval: 1000 --------------------------------------- ---------------------------------------- KSP info: Velocity system ---------------------------------------- KSP Object:(velocity_) 1 MPI processes type: cg maximum iterations=10000 tolerances: relative=1e-05, absolute=1e-50, divergence=10000 left preconditioning using nonzero initial guess using DEFAULT norm type for convergence test PC Object:(velocity_) 1 MPI processes type: ilu PC has not been set up so information may be incomplete ILU: out-of-place factorization 0 levels of fill tolerance for zero pivot 2.22045e-14 using diagonal shift on blocks to prevent zero pivot [INBLOCKS] matrix ordering: natural linear system matrix = precond matrix: Mat Object: 1 MPI processes type: seqaij rows=1984, cols=1984 total: nonzeros=9668, allocated nonzeros=9668 total number of mallocs used during MatSetValues calls =0 not using I-node routines ---------------------------------------- KSP info: Poisson system ---------------------------------------- KSP Object:(poisson_) 1 MPI processes type: cg maximum iterations=10000 tolerances: relative=1e-05, absolute=1e-50, divergence=10000 left preconditioning using nonzero initial guess using DEFAULT norm type for convergence test PC Object:(poisson_) 1 MPI processes type: gamg PC has not been set up so information may be incomplete MG: type is MULTIPLICATIVE, levels=0 cycles=unknown Cycles per PCApply=0 Using Galerkin computed coarse grid matrices linear system matrix = precond matrix: Mat Object: 1 MPI processes type: seqaij rows=1024, cols=1024 total: nonzeros=4992, allocated nonzeros=4992 total number of mallocs used during MatSetValues calls =0 not using I-node routines [time-step 0] Writing grid into file... done. Residual norms for poisson_ solve. 0 KSP preconditioned resid norm 6.575054755933e+00 true resid norm 1.623587145912e-02 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.830567097505e-01 true resid norm 4.821675440651e-03 ||r(i)||/||b|| 2.969766946475e-01 2 KSP preconditioned resid norm 5.715583983452e-02 true resid norm 4.206611711463e-04 ||r(i)||/||b|| 2.590936816699e-02 3 KSP preconditioned resid norm 3.923961240049e-03 true resid norm 4.526820636831e-05 ||r(i)||/||b|| 2.788159938461e-03 4 KSP preconditioned resid norm 3.636743873875e-04 true resid norm 3.449706761713e-06 ||r(i)||/||b|| 2.124743824438e-04 5 KSP preconditioned resid norm 2.590940134222e-05 true resid norm 3.287538655584e-07 ||r(i)||/||b|| 2.024861224026e-05 Linear solve converged due to CONVERGED_RTOL iterations 5 KSP Object:(poisson_) 1 MPI processes type: cg maximum iterations=10000 tolerances: relative=1e-05, absolute=1e-50, divergence=10000 left preconditioning has attached null space using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object:(poisson_) 1 MPI processes type: gamg MG: type is MULTIPLICATIVE, levels=2 cycles=v Cycles per PCApply=1 Using Galerkin computed coarse grid matrices Coarse grid solver -- level ------------------------------- KSP Object: (poisson_mg_coarse_) 1 MPI processes type: preonly maximum iterations=1, initial guess is zero tolerances: relative=1e-05, absolute=1e-50, divergence=10000 left preconditioning using NONE norm type for convergence test PC Object: (poisson_mg_coarse_) 1 MPI processes type: bjacobi block Jacobi: number of blocks = 1 Local solve is same for all blocks, in the following KSP and PC objects: KSP Object: (poisson_mg_coarse_sub_) 1 MPI processes type: preonly maximum iterations=1, initial guess is zero tolerances: relative=1e-05, absolute=1e-50, divergence=10000 left preconditioning using NONE norm type for convergence test PC Object: (poisson_mg_coarse_sub_) 1 MPI processes type: lu LU: out-of-place factorization tolerance for zero pivot 2.22045e-14 using diagonal shift on blocks to prevent zero pivot [INBLOCKS] matrix ordering: nd factor fill ratio given 5, needed 3.33261 Factored matrix follows: Mat Object: 1 MPI processes type: seqaij rows=145, cols=145 package used to perform factorization: petsc total: nonzeros=4629, allocated nonzeros=4629 total number of mallocs used during MatSetValues calls =0 not using I-node routines linear system matrix = precond matrix: Mat Object: 1 MPI processes type: seqaij rows=145, cols=145 total: nonzeros=1389, allocated nonzeros=1389 total number of mallocs used during MatSetValues calls =0 not using I-node routines linear system matrix = precond matrix: Mat Object: 1 MPI processes type: seqaij rows=145, cols=145 total: nonzeros=1389, allocated nonzeros=1389 total number of mallocs used during MatSetValues calls =0 not using I-node routines Down solver (pre-smoother) on level 1 ------------------------------- KSP Object: (poisson_mg_levels_1_) 1 MPI processes type: chebyshev Chebyshev: eigenvalue estimates: min = 0.098494, max = 2.06837 maximum iterations=2 tolerances: relative=1e-05, absolute=1e-50, divergence=10000 left preconditioning using nonzero initial guess using NONE norm type for convergence test PC Object: (poisson_mg_levels_1_) 1 MPI processes type: sor SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1 linear system matrix = precond matrix: Mat Object: 1 MPI processes type: seqaij rows=1024, cols=1024 total: nonzeros=4992, allocated nonzeros=4992 total number of mallocs used during MatSetValues calls =0 not using I-node routines Up solver (post-smoother) same as down solver (pre-smoother) linear system matrix = precond matrix: Mat Object: 1 MPI processes type: seqaij rows=1024, cols=1024 total: nonzeros=4992, allocated nonzeros=4992 total number of mallocs used during MatSetValues calls =0 not using I-node routines ===================== *** PetIBM - Done *** =====================