[petsc-users] DIVERGED_INDEFINITE_PC in algebraic multigrid

Michele Rosso mrosso at uci.edu
Thu May 15 17:15:23 CDT 2014


Hi,

I am solving an inhomogeneous Laplacian in 3D (basically a slightly 
modified version of example ex34).
The laplacian is discretized by using a  cell-center finite difference 
7-point stencil with periodic BCs.
I am solving a time-dependent problem so the solution of the laplacian 
is repeated at each time step with a different matrix (always SPD 
though) and rhs. Also, the laplacian features large magnitude variations 
in the coefficients. I solve by means of CG + GAMG as preconditioner.
Everything works fine for a while until I receive  a 
DIVERGED_INDEFINITE_PC message. Before checking my model is incorrect I 
would like to rule out the possibility of improper use of the linear solver.
I attached the full output of a serial run with -log-summary -ksp_view 
-ksp_converged_reason ksp_monitor_true_residual. I would appreciate if 
you could help me in locating the issue.
Thanks.

Michele


-------------- next part --------------

  0 KSP unpreconditioned resid norm 1.436519531784e-03 true resid norm 1.436519531784e-03 ||r(i)||/||b|| 1.000000000000e+00
  1 KSP unpreconditioned resid norm 5.442655469101e-04 true resid norm 5.442655469101e-04 ||r(i)||/||b|| 3.788779302111e-01
  2 KSP unpreconditioned resid norm 9.032635039164e-05 true resid norm 9.032635039164e-05 ||r(i)||/||b|| 6.287860930055e-02
  3 KSP unpreconditioned resid norm 2.083274324922e-05 true resid norm 2.083274324922e-05 ||r(i)||/||b|| 1.450223459430e-02
  4 KSP unpreconditioned resid norm 3.472803766647e-06 true resid norm 3.472803766647e-06 ||r(i)||/||b|| 2.417512390058e-03
  5 KSP unpreconditioned resid norm 5.985774054401e-07 true resid norm 5.985774054401e-07 ||r(i)||/||b|| 4.166858801403e-04
  6 KSP unpreconditioned resid norm 1.076601847506e-07 true resid norm 1.076601847507e-07 ||r(i)||/||b|| 7.494515902407e-05
  7 KSP unpreconditioned resid norm 1.899550823170e-08 true resid norm 1.899550823182e-08 ||r(i)||/||b|| 1.322328573440e-05
  8 KSP unpreconditioned resid norm 3.253138971746e-09 true resid norm 3.253138971800e-09 ||r(i)||/||b|| 2.264597800324e-06
  9 KSP unpreconditioned resid norm 5.542615532199e-10 true resid norm 5.542615531507e-10 ||r(i)||/||b|| 3.858364198240e-07
Linear solve converged due to CONVERGED_RTOL iterations 9
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =        1 ****************************************
                         Simulation time =     0.0391 sec 
                          Time/time step =    28.3848 sec 
                  Average time/time step =    28.3848 sec 
  
   U MAX =  0.000000000000000E+00  V MAX =  0.000000000000000E+00  W MAX =  0.000000000000000E+00  
   U MIN =  0.000000000000000E+00  V MIN =  0.000000000000000E+00  W MIN = -2.393531935714555E-04  
   U MAX =  0.000000000000000E+00  V MAX =  0.000000000000000E+00  W MAX =  2.393531935714555E-04  
   max(|divU|)    =  1.519695631721842E-03
   sum(divU*dV)   = -5.185694521768437E-19
   sum(|divU|*dV) =  7.171332934751148E-04
   Convective cfl =  1.531860438857315E-03  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.222653406554768E-01  
               Iterations to convergence =     9
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.387273402621e-03 true resid norm 1.387273402621e-03 ||r(i)||/||b|| 4.913739999200e-01
  1 KSP unpreconditioned resid norm 5.438934302605e-04 true resid norm 5.438934302605e-04 ||r(i)||/||b|| 1.926477433016e-01
  2 KSP unpreconditioned resid norm 8.987734737919e-05 true resid norm 8.987734737919e-05 ||r(i)||/||b|| 3.183467051302e-02
  3 KSP unpreconditioned resid norm 2.082485764685e-05 true resid norm 2.082485764685e-05 ||r(i)||/||b|| 7.376191009187e-03
  4 KSP unpreconditioned resid norm 3.456700428092e-06 true resid norm 3.456700428091e-06 ||r(i)||/||b|| 1.224367678835e-03
  5 KSP unpreconditioned resid norm 5.978250288791e-07 true resid norm 5.978250288791e-07 ||r(i)||/||b|| 2.117503839817e-04
  6 KSP unpreconditioned resid norm 1.072323731238e-07 true resid norm 1.072323731239e-07 ||r(i)||/||b|| 3.798184265859e-05
  7 KSP unpreconditioned resid norm 1.896537313626e-08 true resid norm 1.896537313628e-08 ||r(i)||/||b|| 6.717559235506e-06
  8 KSP unpreconditioned resid norm 3.238581391500e-09 true resid norm 3.238581391409e-09 ||r(i)||/||b|| 1.147109639208e-06
  9 KSP unpreconditioned resid norm 5.535175902890e-10 true resid norm 5.535175902904e-10 ||r(i)||/||b|| 1.960566329991e-07
Linear solve converged due to CONVERGED_RTOL iterations 9
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =        2 ****************************************
                         Simulation time =     0.0781 sec 
                          Time/time step =     5.6450 sec 
                  Average time/time step =    17.0149 sec 
  
   U MAX =  2.461642558262655E-06  V MAX =  2.461642558262655E-06  W MAX =  0.000000000000000E+00  
   U MIN = -2.461642558262655E-06  V MIN = -2.461642558262655E-06  W MIN = -4.787063871429022E-04  
   U MAX =  2.461642558262655E-06  V MAX =  2.461642558262655E-06  W MAX =  4.787063871429022E-04  
   max(|divU|)    =  2.991458565354511E-03
   sum(divU*dV)   = -3.567187440313492E-19
   sum(|divU|*dV) =  1.437560546432204E-03
   Convective cfl =  3.095229902460337E-03  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.215998719111754E-01  
               Iterations to convergence =     9
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.358918535350e-03 true resid norm 1.358918535350e-03 ||r(i)||/||b|| 3.249904384726e-01
  1 KSP unpreconditioned resid norm 5.438197237016e-04 true resid norm 5.438197237016e-04 ||r(i)||/||b|| 1.300565161621e-01
  2 KSP unpreconditioned resid norm 8.964805696977e-05 true resid norm 8.964805696977e-05 ||r(i)||/||b|| 2.143966734202e-02
  3 KSP unpreconditioned resid norm 2.082401686586e-05 true resid norm 2.082401686586e-05 ||r(i)||/||b|| 4.980141337354e-03
  4 KSP unpreconditioned resid norm 3.448023436879e-06 true resid norm 3.448023436880e-06 ||r(i)||/||b|| 8.246076710745e-04
  5 KSP unpreconditioned resid norm 5.975866292463e-07 true resid norm 5.975866292461e-07 ||r(i)||/||b|| 1.429150722519e-04
  6 KSP unpreconditioned resid norm 1.070083763305e-07 true resid norm 1.070083763303e-07 ||r(i)||/||b|| 2.559145249634e-05
  7 KSP unpreconditioned resid norm 1.895097623737e-08 true resid norm 1.895097623731e-08 ||r(i)||/||b|| 4.532196681870e-06
  8 KSP unpreconditioned resid norm 3.230731653657e-09 true resid norm 3.230731653621e-09 ||r(i)||/||b|| 7.726415302937e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =        3 ****************************************
                         Simulation time =     0.1172 sec 
                          Time/time step =     5.2815 sec 
                  Average time/time step =    13.1038 sec 
  
   U MAX =  6.252436586750240E-06  V MAX =  6.252436586750240E-06  W MAX =  0.000000000000000E+00  
   U MIN = -6.252436586750240E-06  V MIN = -6.252436586750240E-06  W MIN = -7.180595806250817E-04  
   U MAX =  6.252436586750240E-06  V MAX =  6.252436586750240E-06  W MAX =  7.180595806250817E-04  
   max(|divU|)    =  4.445068216431675E-03
   sum(divU*dV)   =  8.811539788548160E-18
   sum(|divU|*dV) =  2.160108093875001E-03
   Convective cfl =  4.675612504310926E-03  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.209274045579312E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.332134890432e-03 true resid norm 1.332134890432e-03 ||r(i)||/||b|| 2.416626272755e-01
  1 KSP unpreconditioned resid norm 5.438184509314e-04 true resid norm 5.438184509314e-04 ||r(i)||/||b|| 9.865412020722e-02
  2 KSP unpreconditioned resid norm 8.944495318173e-05 true resid norm 8.944495318173e-05 ||r(i)||/||b|| 1.622621142774e-02
  3 KSP unpreconditioned resid norm 2.082458866812e-05 true resid norm 2.082458866812e-05 ||r(i)||/||b|| 3.777789205592e-03
  4 KSP unpreconditioned resid norm 3.440115169336e-06 true resid norm 3.440115169336e-06 ||r(i)||/||b|| 6.240713879072e-04
  5 KSP unpreconditioned resid norm 5.974692409002e-07 true resid norm 5.974692409003e-07 ||r(i)||/||b|| 1.083869114977e-04
  6 KSP unpreconditioned resid norm 1.068060495192e-07 true resid norm 1.068060495197e-07 ||r(i)||/||b|| 1.937568839403e-05
  7 KSP unpreconditioned resid norm 1.893864251792e-08 true resid norm 1.893864251800e-08 ||r(i)||/||b|| 3.435659662397e-06
  8 KSP unpreconditioned resid norm 3.223578380294e-09 true resid norm 3.223578380319e-09 ||r(i)||/||b|| 5.847894430296e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =        4 ****************************************
                         Simulation time =     0.1562 sec 
                          Time/time step =     5.2840 sec 
                  Average time/time step =    11.1488 sec 
  
   U MAX =  1.130662420195935E-05  V MAX =  1.130662420195935E-05  W MAX =  0.000000000000000E+00  
   U MIN = -1.130662420195935E-05  V MIN = -1.130662420195935E-05  W MIN = -9.574127740050222E-04  
   U MAX =  1.130662420195935E-05  V MAX =  1.130662420195935E-05  W MAX =  9.574127740050222E-04  
   max(|divU|)    =  5.875355255447298E-03
   sum(divU*dV)   = -6.773730321252588E-19
   sum(|divU|*dV) =  2.884755678217677E-03
   Convective cfl =  6.272166543417223E-03  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.202483055484767E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.307223362909e-03 true resid norm 1.307223362909e-03 ||r(i)||/||b|| 1.917339325704e-01
  1 KSP unpreconditioned resid norm 5.438982564847e-04 true resid norm 5.438982564847e-04 ||r(i)||/||b|| 7.977500601115e-02
  2 KSP unpreconditioned resid norm 8.927299097308e-05 true resid norm 8.927299097308e-05 ||r(i)||/||b|| 1.309390737441e-02
  3 KSP unpreconditioned resid norm 2.082704964639e-05 true resid norm 2.082704964639e-05 ||r(i)||/||b|| 3.054758846763e-03
  4 KSP unpreconditioned resid norm 3.433123136852e-06 true resid norm 3.433123136852e-06 ||r(i)||/||b|| 5.035453149813e-04
  5 KSP unpreconditioned resid norm 5.974837111114e-07 true resid norm 5.974837111118e-07 ||r(i)||/||b|| 8.763452737203e-05
  6 KSP unpreconditioned resid norm 1.066300405697e-07 true resid norm 1.066300405697e-07 ||r(i)||/||b|| 1.563971207115e-05
  7 KSP unpreconditioned resid norm 1.892883581926e-08 true resid norm 1.892883581947e-08 ||r(i)||/||b|| 2.776342768669e-06
  8 KSP unpreconditioned resid norm 3.217263431375e-09 true resid norm 3.217263430635e-09 ||r(i)||/||b|| 4.718845969046e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =        5 ****************************************
                         Simulation time =     0.1953 sec 
                          Time/time step =     5.2903 sec 
                  Average time/time step =     9.9771 sec 
  
   U MAX =  1.751966015931765E-05  V MAX =  1.751966015931765E-05  W MAX =  0.000000000000000E+00  
   U MIN = -1.751966015931765E-05  V MIN = -1.751966015931765E-05  W MIN = -1.196765967264871E-03  
   U MAX =  1.751966015931765E-05  V MAX =  1.751966015931765E-05  W MAX =  1.196765967264871E-03  
   max(|divU|)    =  7.282771149617234E-03
   sum(divU*dV)   =  1.540113958245672E-18
   sum(|divU|*dV) =  3.611478531740617E-03
   Convective cfl =  7.883553840534440E-03  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.195631525122878E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.284025180478e-03 true resid norm 1.284025180478e-03 ||r(i)||/||b|| 1.585293618291e-01
  1 KSP unpreconditioned resid norm 5.440529475024e-04 true resid norm 5.440529475024e-04 ||r(i)||/||b|| 6.717030777910e-02
  2 KSP unpreconditioned resid norm 8.912993213531e-05 true resid norm 8.912993213531e-05 ||r(i)||/||b|| 1.100423221921e-02
  3 KSP unpreconditioned resid norm 2.083128820889e-05 true resid norm 2.083128820889e-05 ||r(i)||/||b|| 2.571889458278e-03
  4 KSP unpreconditioned resid norm 3.426985329255e-06 true resid norm 3.426985329255e-06 ||r(i)||/||b|| 4.231052517541e-04
  5 KSP unpreconditioned resid norm 5.976212412688e-07 true resid norm 5.976212412689e-07 ||r(i)||/||b|| 7.378400006037e-05
  6 KSP unpreconditioned resid norm 1.064784783066e-07 true resid norm 1.064784783067e-07 ||r(i)||/||b|| 1.314613254563e-05
  7 KSP unpreconditioned resid norm 1.892141014094e-08 true resid norm 1.892141014064e-08 ||r(i)||/||b|| 2.336090537872e-06
  8 KSP unpreconditioned resid norm 3.211733810102e-09 true resid norm 3.211733810296e-09 ||r(i)||/||b|| 3.965296935390e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =        6 ****************************************
                         Simulation time =     0.2344 sec 
                          Time/time step =     5.2861 sec 
                  Average time/time step =     9.1953 sec 
  
   U MAX =  2.479691939489266E-05  V MAX =  2.479691939489266E-05  W MAX =  0.000000000000000E+00  
   U MIN = -2.479691939489266E-05  V MIN = -2.479691939489266E-05  W MIN = -1.436119160392139E-03  
   U MAX =  2.479691939489266E-05  V MAX =  2.479691939489266E-05  W MAX =  1.436119160392139E-03  
   max(|divU|)    =  8.667778929815951E-03
   sum(divU*dV)   =  1.929412357010522E-17
   sum(|divU|*dV) =  4.340254834708106E-03
   Convective cfl =  9.508563194764315E-03  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.188724683969847E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.262404152977e-03 true resid norm 1.262404152977e-03 ||r(i)||/||b|| 1.348871940068e-01
  1 KSP unpreconditioned resid norm 5.442761720331e-04 true resid norm 5.442761720331e-04 ||r(i)||/||b|| 5.815561160596e-02
  2 KSP unpreconditioned resid norm 8.901362921075e-05 true resid norm 8.901362921075e-05 ||r(i)||/||b|| 9.511057646855e-03
  3 KSP unpreconditioned resid norm 2.083716594647e-05 true resid norm 2.083716594647e-05 ||r(i)||/||b|| 2.226439796593e-03
  4 KSP unpreconditioned resid norm 3.421634895428e-06 true resid norm 3.421634895429e-06 ||r(i)||/||b|| 3.655998191003e-04
  5 KSP unpreconditioned resid norm 5.978718503849e-07 true resid norm 5.978718503845e-07 ||r(i)||/||b|| 6.388228055477e-05
  6 KSP unpreconditioned resid norm 1.063494715136e-07 true resid norm 1.063494715136e-07 ||r(i)||/||b|| 1.136338292514e-05
  7 KSP unpreconditioned resid norm 1.891618348142e-08 true resid norm 1.891618348117e-08 ||r(i)||/||b|| 2.021183869741e-06
  8 KSP unpreconditioned resid norm 3.206931177866e-09 true resid norm 3.206931177846e-09 ||r(i)||/||b|| 3.426588441841e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =        7 ****************************************
                         Simulation time =     0.2734 sec 
                          Time/time step =     5.2908 sec 
                  Average time/time step =     8.6375 sec 
  
   U MAX =  3.305085009380369E-05  V MAX =  3.305085009380369E-05  W MAX =  0.000000000000000E+00  
   U MIN = -3.305085009380369E-05  V MIN = -3.305085009380369E-05  W MIN = -1.675472353378616E-03  
   U MAX =  3.305085009380369E-05  V MAX =  3.305085009380369E-05  W MAX =  1.675472353378616E-03  
   max(|divU|)    =  1.003084665173450E-02
   sum(divU*dV)   =  1.650583198534465E-17
   sum(|divU|*dV) =  5.071065394490515E-03
   Convective cfl =  1.114607394282383E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.181767370247083E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.242229955292e-03 true resid norm 1.242229955292e-03 ||r(i)||/||b|| 1.172208952731e-01
  1 KSP unpreconditioned resid norm 5.445606391168e-04 true resid norm 5.445606391168e-04 ||r(i)||/||b|| 5.138652902053e-02
  2 KSP unpreconditioned resid norm 8.892190380460e-05 true resid norm 8.892190380460e-05 ||r(i)||/||b|| 8.390962662720e-03
  3 KSP unpreconditioned resid norm 2.084447741222e-05 true resid norm 2.084447741222e-05 ||r(i)||/||b|| 1.966953295042e-03
  4 KSP unpreconditioned resid norm 3.416997089687e-06 true resid norm 3.416997089688e-06 ||r(i)||/||b|| 3.224390591231e-04
  5 KSP unpreconditioned resid norm 5.982254535369e-07 true resid norm 5.982254535377e-07 ||r(i)||/||b|| 5.645051702395e-05
  6 KSP unpreconditioned resid norm 1.062409410453e-07 true resid norm 1.062409410446e-07 ||r(i)||/||b|| 1.002524385348e-05
  7 KSP unpreconditioned resid norm 1.891292046742e-08 true resid norm 1.891292046669e-08 ||r(i)||/||b|| 1.784685242769e-06
  8 KSP unpreconditioned resid norm 3.202788322478e-09 true resid norm 3.202788322675e-09 ||r(i)||/||b|| 3.022256168875e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =        8 ****************************************
                         Simulation time =     0.3125 sec 
                          Time/time step =     5.2868 sec 
                  Average time/time step =     8.2187 sec 
  
   U MAX =  4.220050557427550E-05  V MAX =  4.220050557427550E-05  W MAX =  0.000000000000000E+00  
   U MIN = -4.220050557427550E-05  V MIN = -4.220050557427550E-05  W MIN = -1.914825546219209E-03  
   U MAX =  4.220050557427550E-05  V MAX =  4.220050557427550E-05  W MAX =  1.914825546219209E-03  
   max(|divU|)    =  1.137244546422055E-02
   sum(divU*dV)   =  2.000003067929342E-18
   sum(|divU|*dV) =  5.803893153988580E-03
   Convective cfl =  1.279504996715366E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.174764056878764E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.223379873944e-03 true resid norm 1.223379873944e-03 ||r(i)||/||b|| 1.035358121775e-01
  1 KSP unpreconditioned resid norm 5.448986744158e-04 true resid norm 5.448986744158e-04 ||r(i)||/||b|| 4.611529747356e-02
  2 KSP unpreconditioned resid norm 8.885276850463e-05 true resid norm 8.885276850464e-05 ||r(i)||/||b|| 7.519695024645e-03
  3 KSP unpreconditioned resid norm 2.085297091140e-05 true resid norm 2.085297091140e-05 ||r(i)||/||b|| 1.764806930055e-03
  4 KSP unpreconditioned resid norm 3.412995973201e-06 true resid norm 3.412995973200e-06 ||r(i)||/||b|| 2.888451229009e-04
  5 KSP unpreconditioned resid norm 5.986734251487e-07 true resid norm 5.986734251486e-07 ||r(i)||/||b|| 5.066630620792e-05
  6 KSP unpreconditioned resid norm 1.061508214252e-07 true resid norm 1.061508214263e-07 ||r(i)||/||b|| 8.983645835408e-06
  7 KSP unpreconditioned resid norm 1.891136234479e-08 true resid norm 1.891136234533e-08 ||r(i)||/||b|| 1.600486734750e-06
  8 KSP unpreconditioned resid norm 3.199236033375e-09 true resid norm 3.199236033557e-09 ||r(i)||/||b|| 2.707544141740e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =        9 ****************************************
                         Simulation time =     0.3516 sec 
                          Time/time step =     5.2901 sec 
                  Average time/time step =     7.8933 sec 
  
   U MAX =  5.217110505333921E-05  V MAX =  5.217110505333921E-05  W MAX =  0.000000000000000E+00  
   U MIN = -5.217110505333921E-05  V MIN = -5.217110505333921E-05  W MIN = -2.154178738910741E-03  
   U MAX =  5.217110505333921E-05  V MAX =  5.217110505333921E-05  W MAX =  2.154178738910741E-03  
   max(|divU|)    =  1.269304839536958E-02
   sum(divU*dV)   = -2.694000336582297E-17
   sum(|divU|*dV) =  6.538722584835714E-03
   Convective cfl =  1.445453407371149E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.167718875855106E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.205741071227e-03 true resid norm 1.205741071227e-03 ||r(i)||/||b|| 9.263443341308e-02
  1 KSP unpreconditioned resid norm 5.452830457760e-04 true resid norm 5.452830457760e-04 ||r(i)||/||b|| 4.189289657671e-02
  2 KSP unpreconditioned resid norm 8.880461896504e-05 true resid norm 8.880461896504e-05 ||r(i)||/||b|| 6.822663471120e-03
  3 KSP unpreconditioned resid norm 2.086238471379e-05 true resid norm 2.086238471379e-05 ||r(i)||/||b|| 1.602811112373e-03
  4 KSP unpreconditioned resid norm 3.409561410338e-06 true resid norm 3.409561410337e-06 ||r(i)||/||b|| 2.619491008233e-04
  5 KSP unpreconditioned resid norm 5.992097002504e-07 true resid norm 5.992097002501e-07 ||r(i)||/||b|| 4.603596278080e-05
  6 KSP unpreconditioned resid norm 1.060772787794e-07 true resid norm 1.060772787798e-07 ||r(i)||/||b|| 8.149683918264e-06
  7 KSP unpreconditioned resid norm 1.891126501641e-08 true resid norm 1.891126501618e-08 ||r(i)||/||b|| 1.452910879212e-06
  8 KSP unpreconditioned resid norm 3.196215804033e-09 true resid norm 3.196215804331e-09 ||r(i)||/||b|| 2.455582273554e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       10 ****************************************
                         Simulation time =     0.3906 sec 
                          Time/time step =     5.2867 sec 
                  Average time/time step =     7.6326 sec 
  
   U MAX =  6.289364203444345E-05  V MAX =  6.289364203444345E-05  W MAX =  0.000000000000000E+00  
   U MIN = -6.289364203444345E-05  V MIN = -6.289364203444345E-05  W MIN = -2.393531931450745E-03  
   U MAX =  6.289364203444345E-05  V MAX =  6.289364203444345E-05  W MAX =  2.393531931450745E-03  
   max(|divU|)    =  1.399312989607586E-02
   sum(divU*dV)   =  1.953489400469769E-17
   sum(|divU|*dV) =  7.275539118175428E-03
   Convective cfl =  1.612364297932565E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.160635639983364E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.189212180809e-03 true resid norm 1.189212180809e-03 ||r(i)||/||b|| 8.375462057382e-02
  1 KSP unpreconditioned resid norm 5.457076531056e-04 true resid norm 5.457076531056e-04 ||r(i)||/||b|| 3.843345886265e-02
  2 KSP unpreconditioned resid norm 8.877633152293e-05 true resid norm 8.877633152293e-05 ||r(i)||/||b|| 6.252398085579e-03
  3 KSP unpreconditioned resid norm 2.087248091046e-05 true resid norm 2.087248091046e-05 ||r(i)||/||b|| 1.470020865327e-03
  4 KSP unpreconditioned resid norm 3.406633345812e-06 true resid norm 3.406633345813e-06 ||r(i)||/||b|| 2.399246222979e-04
  5 KSP unpreconditioned resid norm 5.998310926621e-07 true resid norm 5.998310926614e-07 ||r(i)||/||b|| 4.224530019533e-05
  6 KSP unpreconditioned resid norm 1.060188550981e-07 true resid norm 1.060188550980e-07 ||r(i)||/||b|| 7.466765919236e-06
  7 KSP unpreconditioned resid norm 1.891242496403e-08 true resid norm 1.891242496489e-08 ||r(i)||/||b|| 1.331976751186e-06
  8 KSP unpreconditioned resid norm 3.193674607405e-09 true resid norm 3.193674607819e-09 ||r(i)||/||b|| 2.249262237056e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       11 ****************************************
                         Simulation time =     0.4297 sec 
                          Time/time step =     5.2932 sec 
                  Average time/time step =     7.4199 sec 
  
   U MAX =  7.430448596718565E-05  V MAX =  7.430448596718565E-05  W MAX =  2.709060511180018E-21  
   U MIN = -7.430448596718565E-05  V MIN = -7.430448596718565E-05  W MIN = -2.632885123836222E-03  
   U MAX =  7.430448596718565E-05  V MAX =  7.430448596718565E-05  W MAX =  2.632885123836222E-03  
   max(|divU|)    =  1.527316561904287E-02
   sum(divU*dV)   = -1.972843168610879E-17
   sum(|divU|*dV) =  8.014328726644185E-03
   Convective cfl =  1.780156221293180E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.153517864980171E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.173703535188e-03 true resid norm 1.173703535188e-03 ||r(i)||/||b|| 7.638845186070e-02
  1 KSP unpreconditioned resid norm 5.461678657327e-04 true resid norm 5.461678657327e-04 ||r(i)||/||b|| 3.554638498442e-02
  2 KSP unpreconditioned resid norm 8.876725102317e-05 true resid norm 8.876725102317e-05 ||r(i)||/||b|| 5.777262041306e-03
  3 KSP unpreconditioned resid norm 2.088306633812e-05 true resid norm 2.088306633812e-05 ||r(i)||/||b|| 1.359138027490e-03
  4 KSP unpreconditioned resid norm 3.404162327555e-06 true resid norm 3.404162327556e-06 ||r(i)||/||b|| 2.215539804460e-04
  5 KSP unpreconditioned resid norm 6.005368354461e-07 true resid norm 6.005368354463e-07 ||r(i)||/||b|| 3.908489475386e-05
  6 KSP unpreconditioned resid norm 1.059745081597e-07 true resid norm 1.059745081589e-07 ||r(i)||/||b|| 6.897166424276e-06
  7 KSP unpreconditioned resid norm 1.891469142575e-08 true resid norm 1.891469142698e-08 ||r(i)||/||b|| 1.231029772180e-06
  8 KSP unpreconditioned resid norm 3.191570541883e-09 true resid norm 3.191570541947e-09 ||r(i)||/||b|| 2.077178140768e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       12 ****************************************
                         Simulation time =     0.4688 sec 
                          Time/time step =     5.2795 sec 
                  Average time/time step =     7.2416 sec 
  
   U MAX =  8.634496512897778E-05  V MAX =  8.634496512897778E-05  W MAX =  8.489812655424283E-19  
   U MIN = -8.634496512897778E-05  V MIN = -8.634496512897778E-05  W MIN = -2.872238316062392E-03  
   U MAX =  8.634496512897778E-05  V MAX =  8.634496512897778E-05  W MAX =  2.872238316062392E-03  
   max(|divU|)    =  1.653363196596731E-02
   sum(divU*dV)   = -2.462346780191219E-17
   sum(|divU|*dV) =  8.755077706950073E-03
   Convective cfl =  1.948754077645023E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.146368792554558E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.159136096728e-03 true resid norm 1.159136096728e-03 ||r(i)||/||b|| 7.018451665043e-02
  1 KSP unpreconditioned resid norm 5.466604833622e-04 true resid norm 5.466604833622e-04 ||r(i)||/||b|| 3.309973859407e-02
  2 KSP unpreconditioned resid norm 8.877709917005e-05 true resid norm 8.877709917005e-05 ||r(i)||/||b|| 5.375363438739e-03
  3 KSP unpreconditioned resid norm 2.089399796449e-05 true resid norm 2.089399796449e-05 ||r(i)||/||b|| 1.265110414706e-03
  4 KSP unpreconditioned resid norm 3.402106992486e-06 true resid norm 3.402106992486e-06 ||r(i)||/||b|| 2.059941326429e-04
  5 KSP unpreconditioned resid norm 6.013276058776e-07 true resid norm 6.013276058795e-07 ||r(i)||/||b|| 3.640977749406e-05
  6 KSP unpreconditioned resid norm 1.059435670909e-07 true resid norm 1.059435670911e-07 ||r(i)||/||b|| 6.414775684667e-06
  7 KSP unpreconditioned resid norm 1.891796347385e-08 true resid norm 1.891796347347e-08 ||r(i)||/||b|| 1.145463527660e-06
  8 KSP unpreconditioned resid norm 3.189873620070e-09 true resid norm 3.189873619632e-09 ||r(i)||/||b|| 1.931436168727e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       13 ****************************************
                         Simulation time =     0.5078 sec 
                          Time/time step =     5.2942 sec 
                  Average time/time step =     7.0918 sec 
  
   U MAX =  9.896094562848124E-05  V MAX =  9.896094562848124E-05  W MAX =  9.909002805648082E-18  
   U MIN = -9.896094562848124E-05  V MIN = -9.896094562848124E-05  W MIN = -3.111591508121445E-03  
   U MAX =  9.896094562848124E-05  V MAX =  9.896094562848124E-05  W MAX =  3.111591508121445E-03  
   max(|divU|)    =  1.777500515817062E-02
   sum(divU*dV)   =  1.234132652517441E-18
   sum(|divU|*dV) =  9.497772642299201E-03
   Convective cfl =  2.118088575602181E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.139191413667278E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.145439560085e-03 true resid norm 1.145439560085e-03 ||r(i)||/||b|| 6.489199472629e-02
  1 KSP unpreconditioned resid norm 5.471834130806e-04 true resid norm 5.471834130806e-04 ||r(i)||/||b|| 3.099929877864e-02
  2 KSP unpreconditioned resid norm 8.880585182682e-05 true resid norm 8.880585182682e-05 ||r(i)||/||b|| 5.031071973787e-03
  3 KSP unpreconditioned resid norm 2.090517530672e-05 true resid norm 2.090517530672e-05 ||r(i)||/||b|| 1.184330079935e-03
  4 KSP unpreconditioned resid norm 3.400429960731e-06 true resid norm 3.400429960732e-06 ||r(i)||/||b|| 1.926427991213e-04
  5 KSP unpreconditioned resid norm 6.022043913180e-07 true resid norm 6.022043913185e-07 ||r(i)||/||b|| 3.411637378990e-05
  6 KSP unpreconditioned resid norm 1.059256456909e-07 true resid norm 1.059256456905e-07 ||r(i)||/||b|| 6.000950797457e-06
  7 KSP unpreconditioned resid norm 1.892217526757e-08 true resid norm 1.892217526718e-08 ||r(i)||/||b|| 1.071988204735e-06
  8 KSP unpreconditioned resid norm 3.188547743643e-09 true resid norm 3.188547741446e-09 ||r(i)||/||b|| 1.806391453837e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       14 ****************************************
                         Simulation time =     0.5469 sec 
                          Time/time step =     5.2864 sec 
                  Average time/time step =     6.9628 sec 
  
   U MAX =  1.121024310588700E-04  V MAX =  1.121024310588700E-04  W MAX =  4.203521926363097E-17  
   U MIN = -1.121024310588700E-04  V MIN = -1.121024310588700E-04  W MIN = -3.350944700001264E-03  
   U MAX =  1.121024310588700E-04  V MAX =  1.121024310588700E-04  W MAX =  3.350944700001264E-03  
   max(|divU|)    =  1.899775987895855E-02
   sum(divU*dV)   =  6.277424218272801E-18
   sum(|divU|*dV) =  1.024240047107154E-02
   Convective cfl =  2.288095719756163E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.131988490632803E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.132550247035e-03 true resid norm 1.132550247035e-03 ||r(i)||/||b|| 6.032706786034e-02
  1 KSP unpreconditioned resid norm 5.477352053856e-04 true resid norm 5.477352053856e-04 ||r(i)||/||b|| 2.917597606933e-02
  2 KSP unpreconditioned resid norm 8.885363013505e-05 true resid norm 8.885363013505e-05 ||r(i)||/||b|| 4.732928175885e-03
  3 KSP unpreconditioned resid norm 2.091652524753e-05 true resid norm 2.091652524753e-05 ||r(i)||/||b|| 1.114151571918e-03
  4 KSP unpreconditioned resid norm 3.399093507522e-06 true resid norm 3.399093507523e-06 ||r(i)||/||b|| 1.810580548006e-04
  5 KSP unpreconditioned resid norm 6.031675064902e-07 true resid norm 6.031675064902e-07 ||r(i)||/||b|| 3.212866465789e-05
  6 KSP unpreconditioned resid norm 1.059205575554e-07 true resid norm 1.059205575550e-07 ||r(i)||/||b|| 5.642024872768e-06
  7 KSP unpreconditioned resid norm 1.892728637898e-08 true resid norm 1.892728637999e-08 ||r(i)||/||b|| 1.008191639044e-06
  8 KSP unpreconditioned resid norm 3.187569971159e-09 true resid norm 3.187569969133e-09 ||r(i)||/||b|| 1.697909212779e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       15 ****************************************
                         Simulation time =     0.5859 sec 
                          Time/time step =     5.2800 sec 
                  Average time/time step =     6.8506 sec 
  
   U MAX =  1.257232025658109E-04  V MAX =  1.257232025658109E-04  W MAX =  1.252536729387660E-16  
   U MIN = -1.257232025658109E-04  V MIN = -1.257232025658109E-04  W MIN = -3.590297891684162E-03  
   U MAX =  1.257232025658109E-04  V MAX =  1.257232025658109E-04  W MAX =  3.590297891684162E-03  
   max(|divU|)    =  2.020236775959870E-02
   sum(divU*dV)   = -2.143760560576972E-17
   sum(|divU|*dV) =  1.098894856855465E-02
   Convective cfl =  2.458716349962102E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.124762576993311E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.120409377489e-03 true resid norm 1.120409377489e-03 ||r(i)||/||b|| 5.635193026078e-02
  1 KSP unpreconditioned resid norm 5.483146006913e-04 true resid norm 5.483146006913e-04 ||r(i)||/||b|| 2.757794316965e-02
  2 KSP unpreconditioned resid norm 8.892063571212e-05 true resid norm 8.892063571212e-05 ||r(i)||/||b|| 4.472338024897e-03
  3 KSP unpreconditioned resid norm 2.092798582458e-05 true resid norm 2.092798582458e-05 ||r(i)||/||b|| 1.052590616770e-03
  4 KSP unpreconditioned resid norm 3.398055920868e-06 true resid norm 3.398055920868e-06 ||r(i)||/||b|| 1.709080753181e-04
  5 KSP unpreconditioned resid norm 6.042159401370e-07 true resid norm 6.042159401381e-07 ||r(i)||/||b|| 3.038954796811e-05
  6 KSP unpreconditioned resid norm 1.059282601319e-07 true resid norm 1.059282601309e-07 ||r(i)||/||b|| 5.327750773493e-06
  7 KSP unpreconditioned resid norm 1.893326684092e-08 true resid norm 1.893326684090e-08 ||r(i)||/||b|| 9.522645508544e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       16 ****************************************
                         Simulation time =     0.6250 sec 
                          Time/time step =     4.9413 sec 
                  Average time/time step =     6.7313 sec 
  
   U MAX =  1.397805072379311E-04  V MAX =  1.397805072379311E-04  W MAX =  7.133117161023170E-16  
   U MIN = -1.397805072379311E-04  V MIN = -1.397805072379311E-04  W MIN = -3.829651083145590E-03  
   U MAX =  1.397805072379311E-04  V MAX =  1.397805072379311E-04  W MAX =  3.829651083145590E-03  
   max(|divU|)    =  2.138929604270771E-02
   sum(divU*dV)   =  1.306705937858796E-17
   sum(|divU|*dV) =  1.173740476487146E-02
   Convective cfl =  2.629895742477729E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.117516034740129E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.108962607610e-03 true resid norm 1.108962607610e-03 ||r(i)||/||b|| 5.286125774350e-02
  1 KSP unpreconditioned resid norm 5.489205855391e-04 true resid norm 5.489205855391e-04 ||r(i)||/||b|| 2.616556442369e-02
  2 KSP unpreconditioned resid norm 8.900718881832e-05 true resid norm 8.900718881832e-05 ||r(i)||/||b|| 4.242732727741e-03
  3 KSP unpreconditioned resid norm 2.093948323922e-05 true resid norm 2.093948323923e-05 ||r(i)||/||b|| 9.981287132030e-04
  4 KSP unpreconditioned resid norm 3.397281585611e-06 true resid norm 3.397281585611e-06 ||r(i)||/||b|| 1.619392541208e-04
  5 KSP unpreconditioned resid norm 6.053482815860e-07 true resid norm 6.053482815853e-07 ||r(i)||/||b|| 2.885532056524e-05
  6 KSP unpreconditioned resid norm 1.059487960121e-07 true resid norm 1.059487960112e-07 ||r(i)||/||b|| 5.050293468081e-06
  7 KSP unpreconditioned resid norm 1.894010874842e-08 true resid norm 1.894010874811e-08 ||r(i)||/||b|| 9.028239215219e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       17 ****************************************
                         Simulation time =     0.6641 sec 
                          Time/time step =     4.9385 sec 
                  Average time/time step =     6.6258 sec 
  
   U MAX =  1.542347908037065E-04  V MAX =  1.542347908037065E-04  W MAX =  5.397018840409226E-15  
   U MIN = -1.542347908037065E-04  V MIN = -1.542347908037065E-04  W MIN = -4.069004274352844E-03  
   U MAX =  1.542347908037065E-04  V MAX =  1.542347908037065E-04  W MAX =  4.069004274352844E-03  
   max(|divU|)    =  2.255900665212567E-02
   sum(divU*dV)   =  3.138559063017270E-17
   sum(|divU|*dV) =  1.248775726365972E-02
   Convective cfl =  2.801583267814565E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.110251049105822E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.098157656259e-03 true resid norm 1.098157656259e-03 ||r(i)||/||b|| 4.977309599735e-02
  1 KSP unpreconditioned resid norm 5.495507861759e-04 true resid norm 5.495507861759e-04 ||r(i)||/||b|| 2.490793911044e-02
  2 KSP unpreconditioned resid norm 8.911358386156e-05 true resid norm 8.911358386156e-05 ||r(i)||/||b|| 4.039000173546e-03
  3 KSP unpreconditioned resid norm 2.095097948922e-05 true resid norm 2.095097948922e-05 ||r(i)||/||b|| 9.495859792192e-04
  4 KSP unpreconditioned resid norm 3.396688656334e-06 true resid norm 3.396688656331e-06 ||r(i)||/||b|| 1.539521302803e-04
  5 KSP unpreconditioned resid norm 6.065576823288e-07 true resid norm 6.065576823288e-07 ||r(i)||/||b|| 2.749172997012e-05
  6 KSP unpreconditioned resid norm 1.059825424861e-07 true resid norm 1.059825424861e-07 ||r(i)||/||b|| 4.803571901665e-06
  7 KSP unpreconditioned resid norm 1.894779795394e-08 true resid norm 1.894779795395e-08 ||r(i)||/||b|| 8.587934174348e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       18 ****************************************
                         Simulation time =     0.7031 sec 
                          Time/time step =     4.9321 sec 
                  Average time/time step =     6.5317 sec 
  
   U MAX =  1.690494631829092E-04  V MAX =  1.690494631829092E-04  W MAX =  1.511073763710468E-14  
   U MIN = -1.690494631829092E-04  V MIN = -1.690494631829092E-04  W MIN = -4.308357465263742E-03  
   U MAX =  1.690494631829092E-04  V MAX =  1.690494631829092E-04  W MAX =  4.308357465263742E-03  
   max(|divU|)    =  2.371195570421031E-02
   sum(divU*dV)   =  3.211602794323830E-18
   sum(|divU|*dV) =  1.323999447402270E-02
   Convective cfl =  2.973732090642919E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.102969641552062E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.087947834748e-03 true resid norm 1.087947834748e-03 ||r(i)||/||b|| 4.702287504217e-02
  1 KSP unpreconditioned resid norm 5.502038146917e-04 true resid norm 5.502038146917e-04 ||r(i)||/||b|| 2.378070381654e-02
  2 KSP unpreconditioned resid norm 8.924045016893e-05 true resid norm 8.924045016893e-05 ||r(i)||/||b|| 3.857117412228e-03
  3 KSP unpreconditioned resid norm 2.096241068775e-05 true resid norm 2.096241068775e-05 ||r(i)||/||b|| 9.060294867735e-04
  4 KSP unpreconditioned resid norm 3.396224040976e-06 true resid norm 3.396224040977e-06 ||r(i)||/||b|| 1.467903272505e-04
  5 KSP unpreconditioned resid norm 6.078391357452e-07 true resid norm 6.078391357456e-07 ||r(i)||/||b|| 2.627179614043e-05
  6 KSP unpreconditioned resid norm 1.060299620778e-07 true resid norm 1.060299620776e-07 ||r(i)||/||b|| 4.582787426253e-06
  7 KSP unpreconditioned resid norm 1.895638236531e-08 true resid norm 1.895638236494e-08 ||r(i)||/||b|| 8.193256797143e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       19 ****************************************
                         Simulation time =     0.7422 sec 
                          Time/time step =     4.9272 sec 
                  Average time/time step =     6.4473 sec 
  
   U MAX =  1.841906839855050E-04  V MAX =  1.841906839855050E-04  W MAX =  3.305759669279126E-14  
   U MIN = -1.841906839855050E-04  V MIN = -1.841906839855050E-04  W MIN = -4.547710655825268E-03  
   U MAX =  1.841906839855050E-04  V MAX =  1.841906839855050E-04  W MAX =  4.547710655825268E-03  
   max(|divU|)    =  2.484859332098110E-02
   sum(divU*dV)   =  1.110347635684405E-17
   sum(|divU|*dV) =  1.399410480450672E-02
   Convective cfl =  3.146298895229618E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.095673681655521E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.078290222827e-03 true resid norm 1.078290222827e-03 ||r(i)||/||b|| 4.455900228385e-02
  1 KSP unpreconditioned resid norm 5.508779799768e-04 true resid norm 5.508779799768e-04 ||r(i)||/||b|| 2.276434734200e-02
  2 KSP unpreconditioned resid norm 8.938865146485e-05 true resid norm 8.938865146485e-05 ||r(i)||/||b|| 3.693874840422e-03
  3 KSP unpreconditioned resid norm 2.097375746539e-05 true resid norm 2.097375746539e-05 ||r(i)||/||b|| 8.667144401542e-04
  4 KSP unpreconditioned resid norm 3.395811674005e-06 true resid norm 3.395811674004e-06 ||r(i)||/||b|| 1.403276937268e-04
  5 KSP unpreconditioned resid norm 6.091841326740e-07 true resid norm 6.091841326724e-07 ||r(i)||/||b|| 2.517377658111e-05
  6 KSP unpreconditioned resid norm 1.060918815922e-07 true resid norm 1.060918815906e-07 ||r(i)||/||b|| 4.384115049934e-06
  7 KSP unpreconditioned resid norm 1.896595062233e-08 true resid norm 1.896595062427e-08 ||r(i)||/||b|| 7.837443197499e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       20 ****************************************
                         Simulation time =     0.7812 sec 
                          Time/time step =     4.9370 sec 
                  Average time/time step =     6.3718 sec 
  
   U MAX =  1.996271584416596E-04  V MAX =  1.996271584416596E-04  W MAX =  6.378338308959739E-14  
   U MIN = -1.996271584416596E-04  V MIN = -1.996271584416596E-04  W MIN = -4.787063845972175E-03  
   U MAX =  1.996271584416596E-04  V MAX =  1.996271584416596E-04  W MAX =  4.787063845972175E-03  
   max(|divU|)    =  2.596936353016404E-02
   sum(divU*dV)   = -5.087558198290590E-18
   sum(|divU|*dV) =  1.475007648125029E-02
   Convective cfl =  3.319243624227516E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.088364898408413E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.069146388466e-03 true resid norm 1.069146388466e-03 ||r(i)||/||b|| 4.233981144113e-02
  1 KSP unpreconditioned resid norm 5.515719033567e-04 true resid norm 5.515719033567e-04 ||r(i)||/||b|| 2.184308027066e-02
  2 KSP unpreconditioned resid norm 8.955941510882e-05 true resid norm 8.955941510882e-05 ||r(i)||/||b|| 3.546688076949e-03
  3 KSP unpreconditioned resid norm 2.098506285815e-05 true resid norm 2.098506285815e-05 ||r(i)||/||b|| 8.310401775466e-04
  4 KSP unpreconditioned resid norm 3.395363857784e-06 true resid norm 3.395363857784e-06 ||r(i)||/||b|| 1.344615359164e-04
  5 KSP unpreconditioned resid norm 6.105809735096e-07 true resid norm 6.105809735105e-07 ||r(i)||/||b|| 2.417992855503e-05
  6 KSP unpreconditioned resid norm 1.061694543455e-07 true resid norm 1.061694543438e-07 ||r(i)||/||b|| 4.204470712540e-06
  7 KSP unpreconditioned resid norm 1.897668188500e-08 true resid norm 1.897668188377e-08 ||r(i)||/||b|| 7.515052582182e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       21 ****************************************
                         Simulation time =     0.8203 sec 
                          Time/time step =     4.9311 sec 
                  Average time/time step =     6.3032 sec 
  
   U MAX =  2.153299398103797E-04  V MAX =  2.153299398103797E-04  W MAX =  1.135363150842961E-13  
   U MIN = -2.153299398103797E-04  V MIN = -2.153299398103797E-04  W MIN = -5.026417035625515E-03  
   U MAX =  2.153299398103797E-04  V MAX =  2.153299398103797E-04  W MAX =  5.026417035625515E-03  
   max(|divU|)    =  2.707470407611532E-02
   sum(divU*dV)   =  2.692776324389155E-17
   sum(|divU|*dV) =  1.550789744160050E-02
   Convective cfl =  3.492529225757616E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.081044891147881E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.060482205902e-03 true resid norm 1.060482205902e-03 ||r(i)||/||b|| 4.033130934561e-02
  1 KSP unpreconditioned resid norm 5.522846765089e-04 true resid norm 5.522846765089e-04 ||r(i)||/||b|| 2.100399611720e-02
  2 KSP unpreconditioned resid norm 8.975439648397e-05 true resid norm 8.975439648397e-05 ||r(i)||/||b|| 3.413458811074e-03
  3 KSP unpreconditioned resid norm 2.099646773029e-05 true resid norm 2.099646773029e-05 ||r(i)||/||b|| 7.985188534825e-04
  4 KSP unpreconditioned resid norm 3.394779537215e-06 true resid norm 3.394779537214e-06 ||r(i)||/||b|| 1.291072145422e-04
  5 KSP unpreconditioned resid norm 6.120131793176e-07 true resid norm 6.120131793168e-07 ||r(i)||/||b|| 2.327553703518e-05
  6 KSP unpreconditioned resid norm 1.062640565168e-07 true resid norm 1.062640565178e-07 ||r(i)||/||b|| 4.041339413228e-06
  7 KSP unpreconditioned resid norm 1.898884634996e-08 true resid norm 1.898884635060e-08 ||r(i)||/||b|| 7.221667954637e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       22 ****************************************
                         Simulation time =     0.8594 sec 
                          Time/time step =     4.9284 sec 
                  Average time/time step =     6.2407 sec 
  
   U MAX =  2.312722392105076E-04  V MAX =  2.312722392105076E-04  W MAX =  1.906783837822408E-13  
   U MIN = -2.312722392105076E-04  V MIN = -2.312722392105076E-04  W MIN = -5.265770379365912E-03  
   U MAX =  2.312722392105076E-04  V MAX =  2.312722392105076E-04  W MAX =  5.265770379365912E-03  
   max(|divU|)    =  2.816504607520991E-02
   sum(divU*dV)   =  8.245320893979468E-18
   sum(|divU|*dV) =  1.626755532681830E-02
   Convective cfl =  3.666121508983634E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.073715135884436E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.052267378610e-03 true resid norm 1.052267378610e-03 ||r(i)||/||b|| 3.850549867735e-02
  1 KSP unpreconditioned resid norm 5.530158897949e-04 true resid norm 5.530158897949e-04 ||r(i)||/||b|| 2.023644659705e-02
  2 KSP unpreconditioned resid norm 8.997572962617e-05 true resid norm 8.997572962617e-05 ||r(i)||/||b|| 3.292471484474e-03
  3 KSP unpreconditioned resid norm 2.100825099164e-05 true resid norm 2.100825099164e-05 ||r(i)||/||b|| 7.687525026587e-04
  4 KSP unpreconditioned resid norm 3.393942616429e-06 true resid norm 3.393942616428e-06 ||r(i)||/||b|| 1.241941502554e-04
  5 KSP unpreconditioned resid norm 6.134571479999e-07 true resid norm 6.134571479977e-07 ||r(i)||/||b|| 2.244816657915e-05
  6 KSP unpreconditioned resid norm 1.063770079844e-07 true resid norm 1.063770079864e-07 ||r(i)||/||b|| 3.892641569610e-06
  7 KSP unpreconditioned resid norm 1.900281175641e-08 true resid norm 1.900281175742e-08 ||r(i)||/||b|| 6.953676963341e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       23 ****************************************
                         Simulation time =     0.8984 sec 
                          Time/time step =     4.9308 sec 
                  Average time/time step =     6.1837 sec 
  
   U MAX =  2.474292462119088E-04  V MAX =  2.474292462119088E-04  W MAX =  3.061489539643341E-13  
   U MIN = -2.474292462119088E-04  V MIN = -2.474292462119088E-04  W MIN = -5.505123957015076E-03  
   U MAX =  2.474292462119088E-04  V MAX =  2.474292462119088E-04  W MAX =  5.505123957015076E-03  
   max(|divU|)    =  2.924081356023149E-02
   sum(divU*dV)   =  3.321134889941472E-17
   sum(|divU|*dV) =  1.702903756496682E-02
   Convective cfl =  3.839988767640892E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.066377001411958E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.044474816858e-03 true resid norm 1.044474816858e-03 ||r(i)||/||b|| 3.683911364142e-02
  1 KSP unpreconditioned resid norm 5.537655397092e-04 true resid norm 5.537655397092e-04 ||r(i)||/||b|| 1.953156870686e-02
  2 KSP unpreconditioned resid norm 9.022607780607e-05 true resid norm 9.022607780607e-05 ||r(i)||/||b|| 3.182315820419e-03
  3 KSP unpreconditioned resid norm 2.102087735276e-05 true resid norm 2.102087735276e-05 ||r(i)||/||b|| 7.414161424877e-04
  4 KSP unpreconditioned resid norm 3.392721415668e-06 true resid norm 3.392721415672e-06 ||r(i)||/||b|| 1.196628657468e-04
  5 KSP unpreconditioned resid norm 6.148790223682e-07 true resid norm 6.148790223667e-07 ||r(i)||/||b|| 2.168706972642e-05
  6 KSP unpreconditioned resid norm 1.065090503259e-07 true resid norm 1.065090503268e-07 ||r(i)||/||b|| 3.756623851048e-06
  7 KSP unpreconditioned resid norm 1.901908100219e-08 true resid norm 1.901908100011e-08 ||r(i)||/||b|| 6.708118520521e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       24 ****************************************
                         Simulation time =     0.9375 sec 
                          Time/time step =     4.9346 sec 
                  Average time/time step =     6.1317 sec 
  
   U MAX =  2.637779631398120E-04  V MAX =  2.637779631398120E-04  W MAX =  4.739806503114139E-13  
   U MIN = -2.637779631398120E-04  V MIN = -2.637779631398120E-04  W MIN = -5.744477599478519E-03  
   U MAX =  2.637779631398120E-04  V MAX =  2.637779631398120E-04  W MAX =  5.744477599478519E-03  
   max(|divU|)    =  3.030242301450445E-02
   sum(divU*dV)   = -1.221618764499917E-17
   sum(|divU|*dV) =  1.779233150950448E-02
   Convective cfl =  4.014101456485212E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.059031763149156E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.037080016490e-03 true resid norm 1.037080016490e-03 ||r(i)||/||b|| 3.531265790473e-02
  1 KSP unpreconditioned resid norm 5.545338685654e-04 true resid norm 5.545338685654e-04 ||r(i)||/||b|| 1.888192278887e-02
  2 KSP unpreconditioned resid norm 9.050870210229e-05 true resid norm 9.050870210229e-05 ||r(i)||/||b|| 3.081828580168e-03
  3 KSP unpreconditioned resid norm 2.103505922838e-05 true resid norm 2.103505922838e-05 ||r(i)||/||b|| 7.162454571748e-04
  4 KSP unpreconditioned resid norm 3.390971345242e-06 true resid norm 3.390971345244e-06 ||r(i)||/||b|| 1.154628468155e-04
  5 KSP unpreconditioned resid norm 6.162308170075e-07 true resid norm 6.162308170072e-07 ||r(i)||/||b|| 2.098270884149e-05
  6 KSP unpreconditioned resid norm 1.066594669233e-07 true resid norm 1.066594669234e-07 ||r(i)||/||b|| 3.631763420256e-06
  7 KSP unpreconditioned resid norm 1.903823155722e-08 true resid norm 1.903823155849e-08 ||r(i)||/||b|| 6.482533145433e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       25 ****************************************
                         Simulation time =     0.9766 sec 
                          Time/time step =     4.9259 sec 
                  Average time/time step =     6.0835 sec 
  
   U MAX =  2.802970539392997E-04  V MAX =  2.802970539392997E-04  W MAX =  7.118669076767622E-13  
   U MIN = -2.802970539392997E-04  V MIN = -2.802970539392997E-04  W MIN = -5.983831310938474E-03  
   U MAX =  2.802970539392997E-04  V MAX =  2.802970539392997E-04  W MAX =  5.983831310938474E-03  
   max(|divU|)    =  3.135028298108410E-02
   sum(divU*dV)   =  2.828981006113311E-17
   sum(|divU|*dV) =  1.855823305025077E-02
   Convective cfl =  4.188432268042927E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.051680600073254E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.030060522589e-03 true resid norm 1.030060522589e-03 ||r(i)||/||b|| 3.390966630881e-02
  1 KSP unpreconditioned resid norm 5.553212043042e-04 true resid norm 5.553212043042e-04 ||r(i)||/||b|| 1.828121388910e-02
  2 KSP unpreconditioned resid norm 9.082756384795e-05 true resid norm 9.082756384795e-05 ||r(i)||/||b|| 2.990049918606e-03
  3 KSP unpreconditioned resid norm 2.105184319773e-05 true resid norm 2.105184319773e-05 ||r(i)||/||b|| 6.930281885051e-04
  4 KSP unpreconditioned resid norm 3.388544492928e-06 true resid norm 3.388544492927e-06 ||r(i)||/||b|| 1.115511278298e-04
  5 KSP unpreconditioned resid norm 6.174461021315e-07 true resid norm 6.174461021323e-07 ||r(i)||/||b|| 2.032636998296e-05
  6 KSP unpreconditioned resid norm 1.068247480447e-07 true resid norm 1.068247480449e-07 ||r(i)||/||b|| 3.516678370141e-06
  7 KSP unpreconditioned resid norm 1.906085595275e-08 true resid norm 1.906085595211e-08 ||r(i)||/||b|| 6.274847455291e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       26 ****************************************
                         Simulation time =     1.0156 sec 
                          Time/time step =     4.9355 sec 
                  Average time/time step =     6.0393 sec 
  
   U MAX =  2.969667062277622E-04  V MAX =  2.969667062277622E-04  W MAX =  1.041779941880119E-12  
   U MIN = -2.969667062277622E-04  V MIN = -2.969667062277622E-04  W MIN = -6.226019377274523E-03  
   U MAX =  2.969667062277622E-04  V MAX =  2.969667062277622E-04  W MAX =  6.226019377274523E-03  
   max(|divU|)    =  3.238479376966569E-02
   sum(divU*dV)   = -6.519427921141458E-17
   sum(|divU|*dV) =  1.932639723845376E-02
   Convective cfl =  4.364769785427231E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.044248168636828E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.023395463874e-03 true resid norm 1.023395463874e-03 ||r(i)||/||b|| 3.261613207602e-02
  1 KSP unpreconditioned resid norm 5.561278383905e-04 true resid norm 5.561278383905e-04 ||r(i)||/||b|| 1.772407604723e-02
  2 KSP unpreconditioned resid norm 9.118747527464e-05 true resid norm 9.118747527464e-05 ||r(i)||/||b|| 2.906191049526e-03
  3 KSP unpreconditioned resid norm 2.107273617243e-05 true resid norm 2.107273617243e-05 ||r(i)||/||b|| 6.715987811802e-04
  4 KSP unpreconditioned resid norm 3.385312807046e-06 true resid norm 3.385312807042e-06 ||r(i)||/||b|| 1.078916347891e-04
  5 KSP unpreconditioned resid norm 6.184362436807e-07 true resid norm 6.184362436783e-07 ||r(i)||/||b|| 1.970987650077e-05
  6 KSP unpreconditioned resid norm 1.069966168774e-07 true resid norm 1.069966168782e-07 ||r(i)||/||b|| 3.410036404283e-06
  7 KSP unpreconditioned resid norm 1.908732989312e-08 true resid norm 1.908732989601e-08 ||r(i)||/||b|| 6.083228769749e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       27 ****************************************
                         Simulation time =     1.0547 sec 
                          Time/time step =     4.9416 sec 
                  Average time/time step =     5.9987 sec 
  
   U MAX =  3.137685038647847E-04  V MAX =  3.137685038647847E-04  W MAX =  1.490637308130234E-12  
   U MIN = -3.137685038647847E-04  V MIN = -3.137685038647847E-04  W MIN = -6.468958239699217E-03  
   U MAX =  3.137685038647847E-04  V MAX =  3.137685038647847E-04  W MAX =  6.468958239699217E-03  
   max(|divU|)    =  3.340634722407749E-02
   sum(divU*dV)   =  1.986223127301173E-17
   sum(|divU|*dV) =  2.009669468666401E-02
   Convective cfl =  4.541756958354424E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.036791757405083E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.017065243907e-03 true resid norm 1.017065243907e-03 ||r(i)||/||b|| 3.142006095747e-02
  1 KSP unpreconditioned resid norm 5.569540235575e-04 true resid norm 5.569540235575e-04 ||r(i)||/||b|| 1.720590638164e-02
  2 KSP unpreconditioned resid norm 9.159428781950e-05 true resid norm 9.159428781949e-05 ||r(i)||/||b|| 2.829610119789e-03
  3 KSP unpreconditioned resid norm 2.109988559131e-05 true resid norm 2.109988559131e-05 ||r(i)||/||b|| 6.518359519669e-04
  4 KSP unpreconditioned resid norm 3.381216180592e-06 true resid norm 3.381216180594e-06 ||r(i)||/||b|| 1.044554605922e-04
  5 KSP unpreconditioned resid norm 6.190897167649e-07 true resid norm 6.190897167645e-07 ||r(i)||/||b|| 1.912545606628e-05
  6 KSP unpreconditioned resid norm 1.071592799258e-07 true resid norm 1.071592799256e-07 ||r(i)||/||b|| 3.310457345377e-06
  7 KSP unpreconditioned resid norm 1.911726630815e-08 true resid norm 1.911726630583e-08 ||r(i)||/||b|| 5.905871587568e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       28 ****************************************
                         Simulation time =     1.0938 sec 
                          Time/time step =     4.9359 sec 
                  Average time/time step =     5.9607 sec 
  
   U MAX =  3.306853077415233E-04  V MAX =  3.306853077415233E-04  W MAX =  2.091014663450294E-12  
   U MIN = -3.306853077415233E-04  V MIN = -3.306853077415233E-04  W MIN = -6.712267098442212E-03  
   U MAX =  3.306853077415233E-04  V MAX =  3.306853077415233E-04  W MAX =  6.712267098442212E-03  
   max(|divU|)    =  3.441532656931547E-02
   sum(divU*dV)   = -9.662507560945147E-17
   sum(|divU|*dV) =  2.086896801303882E-02
   Convective cfl =  4.719128136912165E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.029322602551064E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.011051571776e-03 true resid norm 1.011051571776e-03 ||r(i)||/||b|| 3.031112740975e-02
  1 KSP unpreconditioned resid norm 5.577999890334e-04 true resid norm 5.577999890334e-04 ||r(i)||/||b|| 1.672273404120e-02
  2 KSP unpreconditioned resid norm 9.205514482216e-05 true resid norm 9.205514482217e-05 ||r(i)||/||b|| 2.759795149248e-03
  3 KSP unpreconditioned resid norm 2.113634676424e-05 true resid norm 2.113634676424e-05 ||r(i)||/||b|| 6.336635218537e-04
  4 KSP unpreconditioned resid norm 3.376357337148e-06 true resid norm 3.376357337147e-06 ||r(i)||/||b|| 1.012225293783e-04
  5 KSP unpreconditioned resid norm 6.192812171961e-07 true resid norm 6.192812171938e-07 ||r(i)||/||b|| 1.856592917792e-05
  6 KSP unpreconditioned resid norm 1.072861280251e-07 true resid norm 1.072861280260e-07 ||r(i)||/||b|| 3.216417032202e-06
  7 KSP unpreconditioned resid norm 1.914838022261e-08 true resid norm 1.914838022181e-08 ||r(i)||/||b|| 5.740646756266e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       29 ****************************************
                         Simulation time =     1.1328 sec 
                          Time/time step =     4.9249 sec 
                  Average time/time step =     5.9250 sec 
  
   U MAX =  3.477011451042520E-04  V MAX =  3.477011451042520E-04  W MAX =  2.881901841773920E-12  
   U MIN = -3.477011451042520E-04  V MIN = -3.477011451042520E-04  W MIN = -6.955954894808746E-03  
   U MAX =  3.477011451042520E-04  V MAX =  3.477011451042520E-04  W MAX =  6.955954894808746E-03  
   max(|divU|)    =  3.541210624580458E-02
   sum(divU*dV)   =  3.454128104623594E-17
   sum(|divU|*dV) =  2.164316982199105E-02
   Convective cfl =  4.896868598411040E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.021841360604639E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.005337398416e-03 true resid norm 1.005337398416e-03 ||r(i)||/||b|| 2.928039669666e-02
  1 KSP unpreconditioned resid norm 5.586660114961e-04 true resid norm 5.586660114961e-04 ||r(i)||/||b|| 1.627111700342e-02
  2 KSP unpreconditioned resid norm 9.257879095466e-05 true resid norm 9.257879095465e-05 ||r(i)||/||b|| 2.696352218787e-03
  3 KSP unpreconditioned resid norm 2.118646758439e-05 true resid norm 2.118646758439e-05 ||r(i)||/||b|| 6.170547086473e-04
  4 KSP unpreconditioned resid norm 3.371181273599e-06 true resid norm 3.371181273596e-06 ||r(i)||/||b|| 9.818547005487e-05
  5 KSP unpreconditioned resid norm 6.189056124530e-07 true resid norm 6.189056124541e-07 ||r(i)||/||b|| 1.802559208380e-05
  6 KSP unpreconditioned resid norm 1.073375933067e-07 true resid norm 1.073375933085e-07 ||r(i)||/||b|| 3.126201529446e-06
  7 KSP unpreconditioned resid norm 1.917441834395e-08 true resid norm 1.917441834284e-08 ||r(i)||/||b|| 5.584538846266e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       30 ****************************************
                         Simulation time =     1.1719 sec 
                          Time/time step =     4.9409 sec 
                  Average time/time step =     5.8922 sec 
  
   U MAX =  3.648011082886927E-04  V MAX =  3.648011082886927E-04  W MAX =  3.909498888809396E-12  
   U MIN = -3.648011082886927E-04  V MIN = -3.648011082886927E-04  W MIN = -7.200030149701984E-03  
   U MAX =  3.648011082886927E-04  V MAX =  3.648011082886927E-04  W MAX =  7.200030149701984E-03  
   max(|divU|)    =  3.639705168563705E-02
   sum(divU*dV)   =  1.507642367696106E-17
   sum(|divU|*dV) =  2.241929289046668E-02
   Convective cfl =  5.074964714418797E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.014348641117621E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.999070192231e-04 true resid norm 9.999070192231e-04 ||r(i)||/||b|| 2.832010531776e-02
  1 KSP unpreconditioned resid norm 5.595524902876e-04 true resid norm 5.595524902876e-04 ||r(i)||/||b|| 1.584805902060e-02
  2 KSP unpreconditioned resid norm 9.317595589083e-05 true resid norm 9.317595589083e-05 ||r(i)||/||b|| 2.638998260020e-03
  3 KSP unpreconditioned resid norm 2.125644558449e-05 true resid norm 2.125644558449e-05 ||r(i)||/||b|| 6.020407558511e-04
  4 KSP unpreconditioned resid norm 3.366807458257e-06 true resid norm 3.366807458254e-06 ||r(i)||/||b|| 9.535720818967e-05
  5 KSP unpreconditioned resid norm 6.179712823500e-07 true resid norm 6.179712823509e-07 ||r(i)||/||b|| 1.750263920852e-05
  6 KSP unpreconditioned resid norm 1.072668127310e-07 true resid norm 1.072668127304e-07 ||r(i)||/||b|| 3.038089917587e-06
  7 KSP unpreconditioned resid norm 1.918241746540e-08 true resid norm 1.918241746529e-08 ||r(i)||/||b|| 5.432985991920e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       31 ****************************************
                         Simulation time =     1.2109 sec 
                          Time/time step =     4.9422 sec 
                  Average time/time step =     5.8615 sec 
  
   U MAX =  3.819712638762183E-04  V MAX =  3.819712638762183E-04  W MAX =  5.228048290315647E-12  
   U MIN = -3.819712638762183E-04  V MIN = -3.819712638762183E-04  W MIN = -7.444500960418116E-03  
   U MAX =  3.819712638762183E-04  V MAX =  3.819712638762183E-04  W MAX =  7.444500960418116E-03  
   max(|divU|)    =  3.737051905435520E-02
   sum(divU*dV)   =  3.823246617899632E-17
   sum(|divU|*dV) =  2.319732986848551E-02
   Convective cfl =  5.253403832429154E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  9.006845011728921E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.947462645860e-04 true resid norm 9.947462645860e-04 ||r(i)||/||b|| 2.742348500190e-02
  1 KSP unpreconditioned resid norm 5.604599968758e-04 true resid norm 5.604599968758e-04 ||r(i)||/||b|| 1.545094147690e-02
  2 KSP unpreconditioned resid norm 9.385983767545e-05 true resid norm 9.385983767545e-05 ||r(i)||/||b|| 2.587558196908e-03
  3 KSP unpreconditioned resid norm 2.135513624454e-05 true resid norm 2.135513624454e-05 ||r(i)||/||b|| 5.887252652911e-04
  4 KSP unpreconditioned resid norm 3.365634334577e-06 true resid norm 3.365634334576e-06 ||r(i)||/||b|| 9.278488995838e-05
  5 KSP unpreconditioned resid norm 6.168289689638e-07 true resid norm 6.168289689632e-07 ||r(i)||/||b|| 1.700493943160e-05
  6 KSP unpreconditioned resid norm 1.070545756011e-07 true resid norm 1.070545756046e-07 ||r(i)||/||b|| 2.951314976488e-06
  7 KSP unpreconditioned resid norm 1.915262615660e-08 true resid norm 1.915262615561e-08 ||r(i)||/||b|| 5.280057586784e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       32 ****************************************
                         Simulation time =     1.2500 sec 
                          Time/time step =     4.9284 sec 
                  Average time/time step =     5.8324 sec 
  
   U MAX =  3.991985725649520E-04  V MAX =  3.991985725649520E-04  W MAX =  6.900699263091350E-12  
   U MIN = -3.991985725649520E-04  V MIN = -3.991985725649520E-04  W MIN = -7.689374996953326E-03  
   U MAX =  3.991985725649520E-04  V MAX =  3.991985725649520E-04  W MAX =  7.689374996953326E-03  
   max(|divU|)    =  3.833285500851496E-02
   sum(divU*dV)   = -3.832772970957615E-17
   sum(|divU|*dV) =  2.397727321507414E-02
   Convective cfl =  5.432174170933268E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.999331002654465E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.898426613669e-04 true resid norm 9.898426613669e-04 ||r(i)||/||b|| 2.658461796242e-02
  1 KSP unpreconditioned resid norm 5.613892905236e-04 true resid norm 5.613892905236e-04 ||r(i)||/||b|| 1.507746675230e-02
  2 KSP unpreconditioned resid norm 9.464672133814e-05 true resid norm 9.464672133815e-05 ||r(i)||/||b|| 2.541966543143e-03
  3 KSP unpreconditioned resid norm 2.149522795860e-05 true resid norm 2.149522795859e-05 ||r(i)||/||b|| 5.773063190723e-04
  4 KSP unpreconditioned resid norm 3.372418915567e-06 true resid norm 3.372418915564e-06 ||r(i)||/||b|| 9.057446398170e-05
  5 KSP unpreconditioned resid norm 6.166967184143e-07 true resid norm 6.166967184150e-07 ||r(i)||/||b|| 1.656288145341e-05
  6 KSP unpreconditioned resid norm 1.068366215632e-07 true resid norm 1.068366215608e-07 ||r(i)||/||b|| 2.869355786976e-06
  7 KSP unpreconditioned resid norm 1.907817749690e-08 true resid norm 1.907817750218e-08 ||r(i)||/||b|| 5.123905849990e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       33 ****************************************
                         Simulation time =     1.2891 sec 
                          Time/time step =     4.9415 sec 
                  Average time/time step =     5.8054 sec 
  
   U MAX =  4.164708188215090E-04  V MAX =  4.164708188215090E-04  W MAX =  9.000399662903064E-12  
   U MIN = -4.164708188215090E-04  V MIN = -4.164708188215090E-04  W MIN = -7.934659497922977E-03  
   U MAX =  4.164708188215090E-04  V MAX =  4.164708188215090E-04  W MAX =  7.934659497922977E-03  
   max(|divU|)    =  3.928439652168028E-02
   sum(divU*dV)   = -5.266414533402403E-17
   sum(|divU|*dV) =  2.475911515855458E-02
   Convective cfl =  5.611264726762238E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.991807110650943E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.851854712036e-04 true resid norm 9.851854712036e-04 ||r(i)||/||b|| 2.579831449281e-02
  1 KSP unpreconditioned resid norm 5.623413102085e-04 true resid norm 5.623413102085e-04 ||r(i)||/||b|| 1.472561096068e-02
  2 KSP unpreconditioned resid norm 9.555677903554e-05 true resid norm 9.555677903554e-05 ||r(i)||/||b|| 2.502273845419e-03
  3 KSP unpreconditioned resid norm 2.169494954217e-05 true resid norm 2.169494954217e-05 ||r(i)||/||b|| 5.681094043244e-04
  4 KSP unpreconditioned resid norm 3.396150651318e-06 true resid norm 3.396150651318e-06 ||r(i)||/||b|| 8.893245498294e-05
  5 KSP unpreconditioned resid norm 6.207853792369e-07 true resid norm 6.207853792359e-07 ||r(i)||/||b|| 1.625604204912e-05
  6 KSP unpreconditioned resid norm 1.072872335213e-07 true resid norm 1.072872335227e-07 ||r(i)||/||b|| 2.809450476469e-06
  7 KSP unpreconditioned resid norm 1.907040101434e-08 true resid norm 1.907040101209e-08 ||r(i)||/||b|| 4.993823165225e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       34 ****************************************
                         Simulation time =     1.3281 sec 
                          Time/time step =     4.9264 sec 
                  Average time/time step =     5.7795 sec 
  
   U MAX =  4.337765483258318E-04  V MAX =  4.337765483258318E-04  W MAX =  1.161081079721469E-11  
   U MIN = -4.337765483258318E-04  V MIN = -4.337765483258318E-04  W MIN = -8.180361266170116E-03  
   U MAX =  4.337765483258318E-04  V MAX =  4.337765483258318E-04  W MAX =  8.180361266170116E-03  
   max(|divU|)    =  4.022547080844885E-02
   sum(divU*dV)   =  1.233544127631819E-17
   sum(|divU|*dV) =  2.554284768086973E-02
   Convective cfl =  5.790665192205939E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.984273802559585E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.807655573968e-04 true resid norm 9.807655573968e-04 ||r(i)||/||b|| 2.506000711107e-02
  1 KSP unpreconditioned resid norm 5.633171668328e-04 true resid norm 5.633171668328e-04 ||r(i)||/||b|| 1.439358478706e-02
  2 KSP unpreconditioned resid norm 9.661510804421e-05 true resid norm 9.661510804421e-05 ||r(i)||/||b|| 2.468658566121e-03
  3 KSP unpreconditioned resid norm 2.198053894015e-05 true resid norm 2.198053894015e-05 ||r(i)||/||b|| 5.616352022061e-04
  4 KSP unpreconditioned resid norm 3.453141439878e-06 true resid norm 3.453141439878e-06 ||r(i)||/||b|| 8.823285889908e-05
  5 KSP unpreconditioned resid norm 6.364463899108e-07 true resid norm 6.364463899125e-07 ||r(i)||/||b|| 1.626214433891e-05
  6 KSP unpreconditioned resid norm 1.105673245591e-07 true resid norm 1.105673245571e-07 ||r(i)||/||b|| 2.825158284520e-06
  7 KSP unpreconditioned resid norm 1.972920790450e-08 true resid norm 1.972920790619e-08 ||r(i)||/||b|| 5.041103724495e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       35 ****************************************
                         Simulation time =     1.3672 sec 
                          Time/time step =     4.9401 sec 
                  Average time/time step =     5.7555 sec 
  
   U MAX =  4.511050108339042E-04  V MAX =  4.511050108339042E-04  W MAX =  1.482724021178660E-11  
   U MIN = -4.511050108339042E-04  V MIN = -4.511050108339042E-04  W MIN = -8.426486664096112E-03  
   U MAX =  4.511050108339042E-04  V MAX =  4.511050108339042E-04  W MAX =  8.426486664096112E-03  
   max(|divU|)    =  4.115639534074935E-02
   sum(divU*dV)   = -1.145860583228735E-17
   sum(|divU|*dV) =  2.632846251912788E-02
   Convective cfl =  5.970365878888909E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.976731518557743E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.765751078588e-04 true resid norm 9.765751078588e-04 ||r(i)||/||b|| 2.436565860028e-02
  1 KSP unpreconditioned resid norm 5.643181597471e-04 true resid norm 5.643181597471e-04 ||r(i)||/||b|| 1.407980145273e-02
  2 KSP unpreconditioned resid norm 9.785307283726e-05 true resid norm 9.785307283727e-05 ||r(i)||/||b|| 2.441445155169e-03
  3 KSP unpreconditioned resid norm 2.238976860976e-05 true resid norm 2.238976860975e-05 ||r(i)||/||b|| 5.586272409508e-04
  4 KSP unpreconditioned resid norm 3.571652839321e-06 true resid norm 3.571652839320e-06 ||r(i)||/||b|| 8.911313940040e-05
  5 KSP unpreconditioned resid norm 6.783193984635e-07 true resid norm 6.783193984689e-07 ||r(i)||/||b|| 1.692414515999e-05
  6 KSP unpreconditioned resid norm 1.217975177427e-07 true resid norm 1.217975177415e-07 ||r(i)||/||b|| 3.038861744242e-06
  7 KSP unpreconditioned resid norm 2.276836536065e-08 true resid norm 2.276836535724e-08 ||r(i)||/||b|| 5.680732723130e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       36 ****************************************
                         Simulation time =     1.4062 sec 
                          Time/time step =     4.9283 sec 
                  Average time/time step =     5.7326 sec 
  
   U MAX =  4.684461064760571E-04  V MAX =  4.684461064760571E-04  W MAX =  1.875758734736681E-11  
   U MIN = -4.684461064760571E-04  V MIN = -4.684461064760571E-04  W MIN = -8.673041608687577E-03  
   U MAX =  4.684461064760571E-04  V MAX =  4.684461064760571E-04  W MAX =  8.673041608687577E-03  
   max(|divU|)    =  4.207747792094865E-02
   sum(divU*dV)   =  4.599775939863605E-17
   sum(|divU|*dV) =  2.711595117503776E-02
   Convective cfl =  6.150357645849402E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.969180675226200E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.726073108163e-04 true resid norm 9.726073108163e-04 ||r(i)||/||b|| 2.371168358058e-02
  1 KSP unpreconditioned resid norm 5.653458120211e-04 true resid norm 5.653458120211e-04 ||r(i)||/||b|| 1.378285034379e-02
  2 KSP unpreconditioned resid norm 9.931002100599e-05 true resid norm 9.931002100599e-05 ||r(i)||/||b|| 2.421129029452e-03
  3 KSP unpreconditioned resid norm 2.297687015357e-05 true resid norm 2.297687015357e-05 ||r(i)||/||b|| 5.601646920547e-04
  4 KSP unpreconditioned resid norm 3.797658632871e-06 true resid norm 3.797658632874e-06 ||r(i)||/||b|| 9.258503287849e-05
  5 KSP unpreconditioned resid norm 7.702859013373e-07 true resid norm 7.702859013399e-07 ||r(i)||/||b|| 1.877918801970e-05
  6 KSP unpreconditioned resid norm 1.486225606933e-07 true resid norm 1.486225606894e-07 ||r(i)||/||b|| 3.623344275549e-06
  7 KSP unpreconditioned resid norm 3.002239710354e-08 true resid norm 3.002239710279e-08 ||r(i)||/||b|| 7.319311427287e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       37 ****************************************
                         Simulation time =     1.4453 sec 
                          Time/time step =     4.9175 sec 
                  Average time/time step =     5.7105 sec 
  
   U MAX =  4.857903344348851E-04  V MAX =  4.857903344348851E-04  W MAX =  2.352329683379803E-11  
   U MIN = -4.857903344348851E-04  V MIN = -4.857903344348851E-04  W MIN = -8.920031566154332E-03  
   U MAX =  4.857903344348851E-04  V MAX =  4.857903344348851E-04  W MAX =  8.920031566154332E-03  
   max(|divU|)    =  4.298901676450798E-02
   sum(divU*dV)   =  1.778694787993800E-17
   sum(|divU|*dV) =  2.790530492402937E-02
   Convective cfl =  6.330631830415426E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.961621668491502E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.688561023665e-04 true resid norm 9.688561023665e-04 ||r(i)||/||b|| 2.309488393758e-02
  1 KSP unpreconditioned resid norm 5.664018426655e-04 true resid norm 5.664018426655e-04 ||r(i)||/||b|| 1.350147332142e-02
  2 KSP unpreconditioned resid norm 1.010354191468e-04 true resid norm 1.010354191468e-04 ||r(i)||/||b|| 2.408408506775e-03
  3 KSP unpreconditioned resid norm 2.381918152940e-05 true resid norm 2.381918152940e-05 ||r(i)||/||b|| 5.677842473883e-04
  4 KSP unpreconditioned resid norm 4.199762467923e-06 true resid norm 4.199762467922e-06 ||r(i)||/||b|| 1.001108694317e-04
  5 KSP unpreconditioned resid norm 9.414129391480e-07 true resid norm 9.414129391472e-07 ||r(i)||/||b|| 2.244071386229e-05
  6 KSP unpreconditioned resid norm 1.950841469631e-07 true resid norm 1.950841469624e-07 ||r(i)||/||b|| 4.650273369962e-06
  7 KSP unpreconditioned resid norm 3.989489021571e-08 true resid norm 3.989489021477e-08 ||r(i)||/||b|| 9.509852463769e-07
Linear solve converged due to CONVERGED_RTOL iterations 7
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       38 ****************************************
                         Simulation time =     1.4844 sec 
                          Time/time step =     4.9318 sec 
                  Average time/time step =     5.6900 sec 
  
   U MAX =  5.031287439701298E-04  V MAX =  5.031287439701298E-04  W MAX =  2.926031410161659E-11  
   U MIN = -5.031287439701298E-04  V MIN = -5.031287439701298E-04  W MIN = -9.167461546052079E-03  
   U MAX =  5.031287439701298E-04  V MAX =  5.031287439701298E-04  W MAX =  9.167461546052079E-03  
   max(|divU|)    =  4.389130055351834E-02
   sum(divU*dV)   = -1.294684815588316E-16
   sum(|divU|*dV) =  2.869651481910813E-02
   Convective cfl =  6.511180181755097E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.954054876448685E-01  
               Iterations to convergence =     7
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.653160648367e-04 true resid norm 9.653160648367e-04 ||r(i)||/||b|| 2.251239751711e-02
  1 KSP unpreconditioned resid norm 5.674880156214e-04 true resid norm 5.674880156214e-04 ||r(i)||/||b|| 1.323454178298e-02
  2 KSP unpreconditioned resid norm 1.030914649249e-04 true resid norm 1.030914649249e-04 ||r(i)||/||b|| 2.404223987926e-03
  3 KSP unpreconditioned resid norm 2.502572173112e-05 true resid norm 2.502572173112e-05 ||r(i)||/||b|| 5.836316376429e-04
  4 KSP unpreconditioned resid norm 4.870445401901e-06 true resid norm 4.870445401897e-06 ||r(i)||/||b|| 1.135849769489e-04
  5 KSP unpreconditioned resid norm 1.215482808089e-06 true resid norm 1.215482808082e-06 ||r(i)||/||b|| 2.834660392334e-05
  6 KSP unpreconditioned resid norm 2.551625330565e-07 true resid norm 2.551625330483e-07 ||r(i)||/||b|| 5.950714573914e-06
  7 KSP unpreconditioned resid norm 4.861220178024e-08 true resid norm 4.861220177235e-08 ||r(i)||/||b|| 1.133698329849e-06
  8 KSP unpreconditioned resid norm 8.144841115238e-09 true resid norm 8.144841112622e-09 ||r(i)||/||b|| 1.899480465728e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       39 ****************************************
                         Simulation time =     1.5234 sec 
                          Time/time step =     5.2763 sec 
                  Average time/time step =     5.6794 sec 
  
   U MAX =  5.204528884791881E-04  V MAX =  5.204528884791881E-04  W MAX =  3.612003794311162E-11  
   U MIN = -5.204528884791881E-04  V MIN = -5.204528884791881E-04  W MIN = -9.415336094758673E-03  
   U MAX =  5.204528884791881E-04  V MAX =  5.204528884791881E-04  W MAX =  9.415336094758673E-03  
   max(|divU|)    =  4.478460844464908E-02
   sum(divU*dV)   =  1.137276829931661E-16
   sum(|divU|*dV) =  2.948957168820364E-02
   Convective cfl =  6.691994797898912E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.946480662031222E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.619817564018e-04 true resid norm 9.619817564018e-04 ||r(i)||/||b|| 2.196164143736e-02
  1 KSP unpreconditioned resid norm 5.686026262463e-04 true resid norm 5.686026262463e-04 ||r(i)||/||b|| 1.298096030913e-02
  2 KSP unpreconditioned resid norm 1.055538212906e-04 true resid norm 1.055538212906e-04 ||r(i)||/||b|| 2.409749623732e-03
  3 KSP unpreconditioned resid norm 2.674695797372e-05 true resid norm 2.674695797372e-05 ||r(i)||/||b|| 6.106218716207e-04
  4 KSP unpreconditioned resid norm 5.924085158408e-06 true resid norm 5.924085158412e-06 ||r(i)||/||b|| 1.352443881889e-04
  5 KSP unpreconditioned resid norm 1.602272846882e-06 true resid norm 1.602272846877e-06 ||r(i)||/||b|| 3.657921942258e-05
  6 KSP unpreconditioned resid norm 3.168298436773e-07 true resid norm 3.168298436703e-07 ||r(i)||/||b|| 7.233092911626e-06
  7 KSP unpreconditioned resid norm 5.586014529979e-08 true resid norm 5.586014529694e-08 ||r(i)||/||b|| 1.275263770322e-06
  8 KSP unpreconditioned resid norm 9.407129276743e-09 true resid norm 9.407129273877e-09 ||r(i)||/||b|| 2.147608296030e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       40 ****************************************
                         Simulation time =     1.5625 sec 
                          Time/time step =     5.2801 sec 
                  Average time/time step =     5.6694 sec 
  
   U MAX =  5.377547834995266E-04  V MAX =  5.377547834995266E-04  W MAX =  4.427026464318359E-11  
   U MIN = -5.377547834995266E-04  V MIN = -5.377547834995266E-04  W MIN = -9.663659288215718E-03  
   U MAX =  5.377547834995266E-04  V MAX =  5.377547834995266E-04  W MAX =  9.663659288215718E-03  
   max(|divU|)    =  4.566921003955636E-02
   sum(divU*dV)   =  6.161473781623374E-17
   sum(|divU|*dV) =  3.028446612649909E-02
   Convective cfl =  6.873068067337454E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.938899375482311E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.588526158093e-04 true resid norm 9.588526158093e-04 ||r(i)||/||b|| 2.144038799229e-02
  1 KSP unpreconditioned resid norm 5.697560491174e-04 true resid norm 5.697560491174e-04 ||r(i)||/||b|| 1.274000879032e-02
  2 KSP unpreconditioned resid norm 1.085274114053e-04 true resid norm 1.085274114053e-04 ||r(i)||/||b|| 2.426723116738e-03
  3 KSP unpreconditioned resid norm 2.919112513317e-05 true resid norm 2.919112513317e-05 ||r(i)||/||b|| 6.527270598919e-04
  4 KSP unpreconditioned resid norm 7.501781719811e-06 true resid norm 7.501781719801e-06 ||r(i)||/||b|| 1.677433090906e-04
  5 KSP unpreconditioned resid norm 2.097754413791e-06 true resid norm 2.097754413779e-06 ||r(i)||/||b|| 4.690675897672e-05
  6 KSP unpreconditioned resid norm 3.750084920979e-07 true resid norm 3.750084920952e-07 ||r(i)||/||b|| 8.385363337763e-06
  7 KSP unpreconditioned resid norm 6.407190922772e-08 true resid norm 6.407190922495e-08 ||r(i)||/||b|| 1.432677525764e-06
  8 KSP unpreconditioned resid norm 1.109760823695e-08 true resid norm 1.109760823122e-08 ||r(i)||/||b|| 2.481476530813e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       41 ****************************************
                         Simulation time =     1.6016 sec 
                          Time/time step =     5.2897 sec 
                  Average time/time step =     5.6602 sec 
  
   U MAX =  5.550268693159551E-04  V MAX =  5.550268693159551E-04  W MAX =  5.389611832243758E-11  
   U MIN = -5.550268693159551E-04  V MIN = -5.550268693159551E-04  W MIN = -9.912434723936841E-03  
   U MAX =  5.550268693159551E-04  V MAX =  5.550268693159551E-04  W MAX =  9.912434723936841E-03  
   max(|divU|)    =  4.654536534164120E-02
   sum(divU*dV)   =  7.663481308386309E-17
   sum(|divU|*dV) =  3.108213844533452E-02
   Convective cfl =  7.054392616044000E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.931311356592495E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.559282785354e-04 true resid norm 9.559282785354e-04 ||r(i)||/||b|| 2.094662207925e-02
  1 KSP unpreconditioned resid norm 5.709496722979e-04 true resid norm 5.709496722979e-04 ||r(i)||/||b|| 1.251084132611e-02
  2 KSP unpreconditioned resid norm 1.121376956818e-04 true resid norm 1.121376956818e-04 ||r(i)||/||b|| 2.457198918608e-03
  3 KSP unpreconditioned resid norm 3.263680051620e-05 true resid norm 3.263680051620e-05 ||r(i)||/||b|| 7.151485541742e-04
  4 KSP unpreconditioned resid norm 9.787969787122e-06 true resid norm 9.787969787117e-06 ||r(i)||/||b|| 2.144772873212e-04
  5 KSP unpreconditioned resid norm 2.697948086712e-06 true resid norm 2.697948086711e-06 ||r(i)||/||b|| 5.911834625121e-05
  6 KSP unpreconditioned resid norm 4.388419847123e-07 true resid norm 4.388419847060e-07 ||r(i)||/||b|| 9.616053225489e-06
  7 KSP unpreconditioned resid norm 7.533046586121e-08 true resid norm 7.533046585203e-08 ||r(i)||/||b|| 1.650666514097e-06
  8 KSP unpreconditioned resid norm 1.327386810018e-08 true resid norm 1.327386809678e-08 ||r(i)||/||b|| 2.908614639783e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       42 ****************************************
                         Simulation time =     1.6406 sec 
                          Time/time step =     5.2955 sec 
                  Average time/time step =     5.6515 sec 
  
   U MAX =  5.722619783523600E-04  V MAX =  5.722619783523600E-04  W MAX =  6.520096218797720E-11  
   U MIN = -5.722619783523600E-04  V MIN = -5.722619783523600E-04  W MIN = -1.016166551240614E-02  
   U MAX =  5.722619783523600E-04  V MAX =  5.722619783523600E-04  W MAX =  1.016166551240614E-02  
   max(|divU|)    =  4.741332470628808E-02
   sum(divU*dV)   = -6.679930840361994E-17
   sum(|divU|*dV) =  3.188275111165742E-02
   Convective cfl =  7.235961260230947E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.923716936691350E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.532094014231e-04 true resid norm 9.532094014231e-04 ||r(i)||/||b|| 2.047853444210e-02
  1 KSP unpreconditioned resid norm 5.721881245947e-04 true resid norm 5.721881245947e-04 ||r(i)||/||b|| 1.229275980638e-02
  2 KSP unpreconditioned resid norm 1.165466916946e-04 true resid norm 1.165466916946e-04 ||r(i)||/||b|| 2.503862673215e-03
  3 KSP unpreconditioned resid norm 3.745944846755e-05 true resid norm 3.745944846755e-05 ||r(i)||/||b|| 8.047702891721e-04
  4 KSP unpreconditioned resid norm 1.305337758017e-05 true resid norm 1.305337758017e-05 ||r(i)||/||b|| 2.804358013697e-04
  5 KSP unpreconditioned resid norm 3.436611414495e-06 true resid norm 3.436611414503e-06 ||r(i)||/||b|| 7.383137966426e-05
  6 KSP unpreconditioned resid norm 5.329476257960e-07 true resid norm 5.329476257973e-07 ||r(i)||/||b|| 1.144972583614e-05
  7 KSP unpreconditioned resid norm 9.361074626380e-08 true resid norm 9.361074626318e-08 ||r(i)||/||b|| 2.011112027052e-06
  8 KSP unpreconditioned resid norm 1.654045230649e-08 true resid norm 1.654045231200e-08 ||r(i)||/||b|| 3.553513234904e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       43 ****************************************
                         Simulation time =     1.6797 sec 
                          Time/time step =     5.2843 sec 
                  Average time/time step =     5.6430 sec 
  
   U MAX =  5.894533070614432E-04  V MAX =  5.894533070614432E-04  W MAX =  7.840728546853753E-11  
   U MIN = -5.894533070614432E-04  V MIN = -5.894533070614432E-04  W MIN = -1.041135426811980E-02  
   U MAX =  5.894533070614432E-04  V MAX =  5.894533070614432E-04  W MAX =  1.041135426811980E-02  
   max(|divU|)    =  4.827332879033855E-02
   sum(divU*dV)   = -1.944361779260113E-17
   sum(|divU|*dV) =  3.268620746643017E-02
   Convective cfl =  7.417766964635319E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.916116440402518E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.506987107380e-04 true resid norm 9.506987107380e-04 ||r(i)||/||b|| 2.003452088410e-02
  1 KSP unpreconditioned resid norm 5.734767148944e-04 true resid norm 5.734767148944e-04 ||r(i)||/||b|| 1.208514442202e-02
  2 KSP unpreconditioned resid norm 1.219614101567e-04 true resid norm 1.219614101567e-04 ||r(i)||/||b|| 2.570150134044e-03
  3 KSP unpreconditioned resid norm 4.417104052445e-05 true resid norm 4.417104052446e-05 ||r(i)||/||b|| 9.308371031371e-04
  4 KSP unpreconditioned resid norm 1.774091199672e-05 true resid norm 1.774091199672e-05 ||r(i)||/||b|| 3.738625790554e-04
  5 KSP unpreconditioned resid norm 4.454157853553e-06 true resid norm 4.454157853559e-06 ||r(i)||/||b|| 9.386456248470e-05
  6 KSP unpreconditioned resid norm 7.200394014205e-07 true resid norm 7.200394014228e-07 ||r(i)||/||b|| 1.517372881886e-05
  7 KSP unpreconditioned resid norm 1.379733077289e-07 true resid norm 1.379733077328e-07 ||r(i)||/||b|| 2.907576379351e-06
  8 KSP unpreconditioned resid norm 2.662633277832e-08 true resid norm 2.662633278849e-08 ||r(i)||/||b|| 5.611092287101e-07
Linear solve converged due to CONVERGED_RTOL iterations 8
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       44 ****************************************
                         Simulation time =     1.7188 sec 
                          Time/time step =     5.2837 sec 
                  Average time/time step =     5.6348 sec 
  
   U MAX =  6.065943917762114E-04  V MAX =  6.065943917762114E-04  W MAX =  9.375756091715709E-11  
   U MIN = -6.065943917762114E-04  V MIN = -6.065943917762114E-04  W MIN = -1.066150310063001E-02  
   U MAX =  6.065943917762114E-04  V MAX =  6.065943917762114E-04  W MAX =  1.066150310063001E-02  
   max(|divU|)    =  4.912560853256981E-02
   sum(divU*dV)   =  6.111669858309849E-17
   sum(|divU|*dV) =  3.349197454532234E-02
   Convective cfl =  7.599802805876757E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.908510187181871E-01  
               Iterations to convergence =     8
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.484010305825e-04 true resid norm 9.484010305825e-04 ||r(i)||/||b|| 1.961316094007e-02
  1 KSP unpreconditioned resid norm 5.748213015688e-04 true resid norm 5.748213015688e-04 ||r(i)||/||b|| 1.188744248045e-02
  2 KSP unpreconditioned resid norm 1.286469364839e-04 true resid norm 1.286469364839e-04 ||r(i)||/||b|| 2.660449523295e-03
  3 KSP unpreconditioned resid norm 5.348907510610e-05 true resid norm 5.348907510610e-05 ||r(i)||/||b|| 1.106166911214e-03
  4 KSP unpreconditioned resid norm 2.465650792099e-05 true resid norm 2.465650792099e-05 ||r(i)||/||b|| 5.099025016637e-04
  5 KSP unpreconditioned resid norm 6.146862394919e-06 true resid norm 6.146862394916e-06 ||r(i)||/||b|| 1.271185896476e-04
  6 KSP unpreconditioned resid norm 1.188069342317e-06 true resid norm 1.188069342320e-06 ||r(i)||/||b|| 2.456955915007e-05
  7 KSP unpreconditioned resid norm 2.741412806621e-07 true resid norm 2.741412806753e-07 ||r(i)||/||b|| 5.669307481560e-06
  8 KSP unpreconditioned resid norm 6.049923165219e-08 true resid norm 6.049923166410e-08 ||r(i)||/||b|| 1.251138631355e-06
  9 KSP unpreconditioned resid norm 1.176107887875e-08 true resid norm 1.176107888235e-08 ||r(i)||/||b|| 2.432219340870e-07
Linear solve converged due to CONVERGED_RTOL iterations 9
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       45 ****************************************
                         Simulation time =     1.7578 sec 
                          Time/time step =     5.6541 sec 
                  Average time/time step =     5.6352 sec 
  
   U MAX =  6.236790880062606E-04  V MAX =  6.236790880062606E-04  W MAX =  1.115150678938498E-10  
   U MIN = -6.236790880062606E-04  V MIN = -6.236790880062606E-04  W MIN = -1.091211360600322E-02  
   U MAX =  6.236790880062606E-04  V MAX =  6.236790880062606E-04  W MAX =  1.091211360600322E-02  
   max(|divU|)    =  4.997038517101132E-02
   sum(divU*dV)   = -1.366059071355439E-16
   sum(|divU|*dV) =  3.429973463439592E-02
   Convective cfl =  7.782061940490073E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.900898492656075E-01  
               Iterations to convergence =     9
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.463226338129e-04 true resid norm 9.463226338129e-04 ||r(i)||/||b|| 1.921318554716e-02
  1 KSP unpreconditioned resid norm 5.762320387465e-04 true resid norm 5.762320387465e-04 ||r(i)||/||b|| 1.169923732464e-02
  2 KSP unpreconditioned resid norm 1.369454100402e-04 true resid norm 1.369454100402e-04 ||r(i)||/||b|| 2.780402242240e-03
  3 KSP unpreconditioned resid norm 6.645141899166e-05 true resid norm 6.645141899167e-05 ||r(i)||/||b|| 1.349162957051e-03
  4 KSP unpreconditioned resid norm 3.542849089818e-05 true resid norm 3.542849089818e-05 ||r(i)||/||b|| 7.193045426169e-04
  5 KSP unpreconditioned resid norm 9.634571468376e-06 true resid norm 9.634571468390e-06 ||r(i)||/||b|| 1.956106751286e-04
  6 KSP unpreconditioned resid norm 2.490903677247e-06 true resid norm 2.490903677264e-06 ||r(i)||/||b|| 5.057280975999e-05
  7 KSP unpreconditioned resid norm 6.460104461267e-07 true resid norm 6.460104461372e-07 ||r(i)||/||b|| 1.311594811701e-05
  8 KSP unpreconditioned resid norm 1.308945022433e-07 true resid norm 1.308945022564e-07 ||r(i)||/||b|| 2.657550679965e-06
  9 KSP unpreconditioned resid norm 2.332721980281e-08 true resid norm 2.332721980822e-08 ||r(i)||/||b|| 4.736124725971e-07
Linear solve converged due to CONVERGED_RTOL iterations 9
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       46 ****************************************
                         Simulation time =     1.7969 sec 
                          Time/time step =     5.6396 sec 
                  Average time/time step =     5.6353 sec 
  
   U MAX =  6.407015528670302E-04  V MAX =  6.407015528670302E-04  W MAX =  1.319646761900996E-10  
   U MIN = -6.407015528670302E-04  V MIN = -6.407015528670302E-04  W MIN = -1.116318685908394E-02  
   U MAX =  6.407015528670302E-04  V MAX =  6.407015528670302E-04  W MAX =  1.116318685908394E-02  
   max(|divU|)    =  5.080787027504124E-02
   sum(divU*dV)   = -1.802459127280384E-16
   sum(|divU|*dV) =  3.510958606679235E-02
   Convective cfl =  7.964537577483519E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.893281669768407E-01  
               Iterations to convergence =     9
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.444723150048e-04 true resid norm 9.444723150048e-04 ||r(i)||/||b|| 1.883348287760e-02
  1 KSP unpreconditioned resid norm 5.777155860646e-04 true resid norm 5.777155860646e-04 ||r(i)||/||b|| 1.152007996996e-02
  2 KSP unpreconditioned resid norm 1.472956246270e-04 true resid norm 1.472956246270e-04 ||r(i)||/||b|| 2.937184690633e-03
  3 KSP unpreconditioned resid norm 8.458940194082e-05 true resid norm 8.458940194082e-05 ||r(i)||/||b|| 1.686775808850e-03
  4 KSP unpreconditioned resid norm 5.365762440872e-05 true resid norm 5.365762440871e-05 ||r(i)||/||b|| 1.069973078617e-03
  5 KSP unpreconditioned resid norm 1.864657810331e-05 true resid norm 1.864657810332e-05 ||r(i)||/||b|| 3.718266844412e-04
  6 KSP unpreconditioned resid norm 6.524460622530e-06 true resid norm 6.524460622545e-06 ||r(i)||/||b|| 1.301026144103e-04
  7 KSP unpreconditioned resid norm 1.622750138813e-06 true resid norm 1.622750138828e-06 ||r(i)||/||b|| 3.235884892410e-05
  8 KSP unpreconditioned resid norm 2.958932862640e-07 true resid norm 2.958932862731e-07 ||r(i)||/||b|| 5.900332971215e-06
  9 KSP unpreconditioned resid norm 6.413461809109e-08 true resid norm 6.413461809469e-08 ||r(i)||/||b|| 1.278892152325e-06
 10 KSP unpreconditioned resid norm 1.891915012387e-08 true resid norm 1.891915013001e-08 ||r(i)||/||b|| 3.772619740903e-07
Linear solve converged due to CONVERGED_RTOL iterations 10
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       47 ****************************************
                         Simulation time =     1.8359 sec 
                          Time/time step =     5.9881 sec 
                  Average time/time step =     5.6428 sec 
  
   U MAX =  6.576562305696783E-04  V MAX =  6.576562305696783E-04  W MAX =  1.554135859239686E-10  
   U MIN = -6.576562305696783E-04  V MIN = -6.576562305696783E-04  W MIN = -1.141472340685389E-02  
   U MAX =  6.576562305696783E-04  V MAX =  6.576562305696783E-04  W MAX =  1.141472340685389E-02  
   max(|divU|)    =  5.163826577654140E-02
   sum(divU*dV)   = -7.239041132354072E-17
   sum(|divU|*dV) =  3.592336567287319E-02
   Convective cfl =  8.147222955515682E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.885660029728505E-01  
               Iterations to convergence =    10
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.428598999965e-04 true resid norm 9.428598999965e-04 ||r(i)||/||b|| 1.847305363556e-02
  1 KSP unpreconditioned resid norm 5.792840703613e-04 true resid norm 5.792840703613e-04 ||r(i)||/||b|| 1.134966679785e-02
  2 KSP unpreconditioned resid norm 1.602663517902e-04 true resid norm 1.602663517901e-04 ||r(i)||/||b|| 3.140030573583e-03
  3 KSP unpreconditioned resid norm 1.101142848680e-04 true resid norm 1.101142848680e-04 ||r(i)||/||b|| 2.157422423433e-03
  4 KSP unpreconditioned resid norm 8.731041325492e-05 true resid norm 8.731041325492e-05 ||r(i)||/||b|| 1.710635850572e-03
  5 KSP unpreconditioned resid norm 5.035997710797e-05 true resid norm 5.035997710799e-05 ||r(i)||/||b|| 9.866816461331e-04
  6 KSP unpreconditioned resid norm 2.457879661966e-05 true resid norm 2.457879661967e-05 ||r(i)||/||b|| 4.815619247933e-04
  7 KSP unpreconditioned resid norm 5.634575585722e-06 true resid norm 5.634575585741e-06 ||r(i)||/||b|| 1.103958467312e-04
  8 KSP unpreconditioned resid norm 1.134851225677e-06 true resid norm 1.134851225701e-06 ||r(i)||/||b|| 2.223465815104e-05
  9 KSP unpreconditioned resid norm 3.682136578226e-07 true resid norm 3.682136578415e-07 ||r(i)||/||b|| 7.214253836309e-06
 10 KSP unpreconditioned resid norm 1.353419828913e-07 true resid norm 1.353419829004e-07 ||r(i)||/||b|| 2.651697998050e-06
 11 KSP unpreconditioned resid norm 3.039998964113e-08 true resid norm 3.039998964440e-08 ||r(i)||/||b|| 5.956140877596e-07
Linear solve converged due to CONVERGED_RTOL iterations 11
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       48 ****************************************
                         Simulation time =     1.8750 sec 
                          Time/time step =     6.3739 sec 
                  Average time/time step =     5.6581 sec 
  
   U MAX =  6.745378410411323E-04  V MAX =  6.745378410411323E-04  W MAX =  1.821920190168132E-10  
   U MIN = -6.745378410411323E-04  V MIN = -6.745378410411323E-04  W MIN = -1.166672326300875E-02  
   U MAX =  6.745378410411323E-04  V MAX =  6.745378410411323E-04  W MAX =  1.166672326300875E-02  
   max(|divU|)    =  5.252541757016951E-02
   sum(divU*dV)   =  9.877092826794907E-17
   sum(|divU|*dV) =  3.673921294188139E-02
   Convective cfl =  8.330111324858251E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.878033882759807E-01  
               Iterations to convergence =    11
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.414933765577e-04 true resid norm 9.414933765577e-04 ||r(i)||/||b|| 1.813094466660e-02
  1 KSP unpreconditioned resid norm 5.809485671766e-04 true resid norm 5.809485671766e-04 ||r(i)||/||b|| 1.118770093118e-02
  2 KSP unpreconditioned resid norm 1.765886995066e-04 true resid norm 1.765886995066e-04 ||r(i)||/||b|| 3.400682383137e-03
  3 KSP unpreconditioned resid norm 1.457796058411e-04 true resid norm 1.457796058411e-04 ||r(i)||/||b|| 2.807371812521e-03
  4 KSP unpreconditioned resid norm 1.438887535261e-04 true resid norm 1.438887535261e-04 ||r(i)||/||b|| 2.770958450994e-03
Linear solve did not converge due to DIVERGED_INDEFINITE_PC iterations 5
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       49 ****************************************
                         Simulation time =     1.9141 sec 
                          Time/time step =     4.1844 sec 
                  Average time/time step =     5.6280 sec 
  
   U MAX =  6.913413717411347E-04  V MAX =  6.913413717411347E-04  W MAX =  2.126538579577966E-10  
   U MIN = -6.913413717411347E-04  V MIN = -6.913413717411347E-04  W MIN = -1.191918590367497E-02  
   U MAX =  6.913413717411347E-04  V MAX =  6.913413717411347E-04  W MAX =  1.191918590367497E-02  
   max(|divU|)    =  5.340673281799226E-02
   sum(divU*dV)   = -5.499226812896440E-17
   sum(|divU|*dV) =  3.755711646535303E-02
   Convective cfl =  8.513195934180635E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.870403538643769E-01  
               Iterations to convergence =     5
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.519521198687e-04 true resid norm 9.519521198687e-04 ||r(i)||/||b|| 1.802538489112e-02
  1 KSP unpreconditioned resid norm 6.431597000660e-04 true resid norm 6.431597000660e-04 ||r(i)||/||b|| 1.217834479085e-02
  2 KSP unpreconditioned resid norm 3.702102145333e-04 true resid norm 3.702102145333e-04 ||r(i)||/||b|| 7.009997108370e-03
  3 KSP unpreconditioned resid norm 3.869684006500e-04 true resid norm 3.869684006501e-04 ||r(i)||/||b|| 7.327316381605e-03
Linear solve did not converge due to DIVERGED_INDEFINITE_PC iterations 4
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       50 ****************************************
                         Simulation time =     1.9531 sec 
                          Time/time step =     3.8233 sec 
                  Average time/time step =     5.5919 sec 
  
   U MAX =  7.080620726354203E-04  V MAX =  7.080620726354203E-04  W MAX =  2.471772277684510E-10  
   U MIN = -7.080620726354203E-04  V MIN = -7.080620726354203E-04  W MIN = -1.217211026400828E-02  
   U MAX =  7.080620726354203E-04  V MAX =  7.080620726354203E-04  W MAX =  1.217211026400828E-02  
   max(|divU|)    =  5.428216207969611E-02
   sum(divU*dV)   =  2.375536962971300E-17
   sum(|divU|*dV) =  3.837706418998891E-02
   Convective cfl =  8.696470021938640E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.862769307070695E-01  
               Iterations to convergence =     4
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.016568468033e-03 true resid norm 1.016568468033e-03 ||r(i)||/||b|| 1.893304776508e-02
  1 KSP unpreconditioned resid norm 8.594004065921e-04 true resid norm 8.594004065921e-04 ||r(i)||/||b|| 1.600587610083e-02
  2 KSP unpreconditioned resid norm 8.414870106025e-04 true resid norm 8.414870106025e-04 ||r(i)||/||b|| 1.567224861525e-02
Linear solve did not converge due to DIVERGED_INDEFINITE_PC iterations 3
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       51 ****************************************
                         Simulation time =     1.9922 sec 
                          Time/time step =     3.4677 sec 
                  Average time/time step =     5.5502 sec 
  
   U MAX =  7.246954541516481E-04  V MAX =  7.246954541516481E-04  W MAX =  2.861650172945249E-10  
   U MIN = -7.246954541516481E-04  V MIN = -7.246954541516481E-04  W MIN = -1.242549473530513E-02  
   U MAX =  7.246954541516481E-04  V MAX =  7.246954541516481E-04  W MAX =  1.242549473530513E-02  
   max(|divU|)    =  5.515171879413290E-02
   sum(divU*dV)   = -4.605848273045875E-20
   sum(|divU|*dV) =  3.919904340353457E-02
   Convective cfl =  8.879926811909390E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.855131497816892E-01  
               Iterations to convergence =     3
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.258666639469e-03 true resid norm 1.258666639469e-03 ||r(i)||/||b|| 2.306487833771e-02
  1 KSP unpreconditioned resid norm 1.504157912911e-03 true resid norm 1.504157912911e-03 ||r(i)||/||b|| 2.756346928893e-02
  2 KSP unpreconditioned resid norm 1.513545089714e-03 true resid norm 1.513545089714e-03 ||r(i)||/||b|| 2.773548790299e-02
Linear solve did not converge due to DIVERGED_INDEFINITE_PC iterations 3
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       52 ****************************************
                         Simulation time =     2.0312 sec 
                          Time/time step =     3.4708 sec 
                  Average time/time step =     5.5103 sec 
  
   U MAX =  7.412372878275829E-04  V MAX =  7.412372878275829E-04  W MAX =  3.300453361744023E-10  
   U MIN = -7.412372878275829E-04  V MIN = -7.412372878275829E-04  W MIN = -1.267933716225437E-02  
   U MAX =  7.412372878275829E-04  V MAX =  7.412372878275829E-04  W MAX =  1.267933716225437E-02  
   max(|divU|)    =  5.601540601387010E-02
   sum(divU*dV)   = -1.943497884490673E-16
   sum(|divU|*dV) =  4.002304072475085E-02
   Convective cfl =  9.063559512262100E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.847490420774172E-01  
               Iterations to convergence =     3
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.761560659866e-03 true resid norm 1.761560659866e-03 ||r(i)||/||b|| 3.177100637149e-02
  1 KSP unpreconditioned resid norm 2.631712886238e-03 true resid norm 2.631712886238e-03 ||r(i)||/||b|| 4.746482410829e-02
Linear solve did not converge due to DIVERGED_INDEFINITE_PC iterations 2
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       53 ****************************************
                         Simulation time =     2.0703 sec 
                          Time/time step =     3.1133 sec 
                  Average time/time step =     5.4650 sec 
  
   U MAX =  7.576836087104737E-04  V MAX =  7.576836087104737E-04  W MAX =  3.792719040608200E-10  
   U MIN = -7.576836087104737E-04  V MIN = -7.576836087104737E-04  W MIN = -1.293363484006254E-02  
   U MAX =  7.576836087104737E-04  V MAX =  7.576836087104737E-04  W MAX =  1.293363484006254E-02  
   max(|divU|)    =  5.687321627651611E-02
   sum(divU*dV)   = -4.700826762012491E-17
   sum(|divU|*dV) =  4.084904209733418E-02
   Convective cfl =  9.247361316789432E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.839846385889424E-01  
               Iterations to convergence =     2
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 2.799899355961e-03 true resid norm 2.799899355961e-03 ||r(i)||/||b|| 4.971640159634e-02
  1 KSP unpreconditioned resid norm 4.527402695250e-03 true resid norm 4.527402695250e-03 ||r(i)||/||b|| 8.039080765750e-02
Linear solve did not converge due to DIVERGED_INDEFINITE_PC iterations 2
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       54 ****************************************
                         Simulation time =     2.1094 sec 
                          Time/time step =     3.1127 sec 
                  Average time/time step =     5.4215 sec 
  
   U MAX =  7.740307160562104E-04  V MAX =  7.740307160562104E-04  W MAX =  4.343243689038809E-10  
   U MIN = -7.740307160562104E-04  V MIN = -7.740307160562104E-04  W MIN = -1.318838451137465E-02  
   U MAX =  7.740307160562104E-04  V MAX =  7.740307160562104E-04  W MAX =  1.318838451137465E-02  
   max(|divU|)    =  5.772513218099847E-02
   sum(divU*dV)   =  1.862846001320152E-16
   sum(|divU|*dV) =  4.167703278667138E-02
   Convective cfl =  9.431325403831724E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.832199703200240E-01  
               Iterations to convergence =     2
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 4.697531508109e-03 true resid norm 4.697531508109e-03 ||r(i)||/||b|| 8.214417102469e-02
  1 KSP unpreconditioned resid norm 6.214787472969e-03 true resid norm 6.214787472969e-03 ||r(i)||/||b|| 1.086759214239e-01
Linear solve did not converge due to DIVERGED_INDEFINITE_PC iterations 2
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       55 ****************************************
                         Simulation time =     2.1484 sec 
                          Time/time step =     3.1091 sec 
                  Average time/time step =     5.3794 sec 
  
   U MAX =  7.902751731180926E-04  V MAX =  7.902751731180926E-04  W MAX =  4.957085513370435E-10  
   U MIN = -7.902751731180926E-04  V MIN = -7.902751731180926E-04  W MIN = -1.344358236313642E-02  
   U MAX =  7.902751731180926E-04  V MAX =  7.902751731180926E-04  W MAX =  1.344358236313642E-02  
   max(|divU|)    =  5.857112669786742E-02
   sum(divU*dV)   = -1.033909168771564E-16
   sum(|divU|*dV) =  4.250699737772344E-02
   Convective cfl =  9.615444933998471E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.824550682920411E-01  
               Iterations to convergence =     2
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 6.443380291215e-03 true resid norm 6.443380291215e-03 ||r(i)||/||b|| 1.109919986786e-01
  1 KSP unpreconditioned resid norm 8.054889194093e-03 true resid norm 8.054889194093e-03 ||r(i)||/||b|| 1.387514333130e-01
Linear solve did not converge due to DIVERGED_INDEFINITE_PC iterations 2
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       56 ****************************************
                         Simulation time =     2.1875 sec 
                          Time/time step =     3.1099 sec 
                  Average time/time step =     5.3389 sec 
  
   U MAX =  8.064138093027779E-04  V MAX =  8.064138093027779E-04  W MAX =  5.639566124425724E-10  
   U MIN = -8.064138093027779E-04  V MIN = -8.064138093027779E-04  W MIN = -1.369922402375323E-02  
   U MAX =  8.064138093027779E-04  V MAX =  8.064138093027779E-04  W MAX =  1.369922402375323E-02  
   max(|divU|)    =  5.941116286987973E-02
   sum(divU*dV)   = -1.848161969535551E-16
   sum(|divU|*dV) =  4.333892934140238E-02
   Convective cfl =  9.799713051109626E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.816899635391449E-01  
               Iterations to convergence =     2
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 8.320817865971e-03 true resid norm 8.320817865971e-03 ||r(i)||/||b|| 1.412314148924e-01
  1 KSP unpreconditioned resid norm 9.218063404335e-03 true resid norm 9.218063404335e-03 ||r(i)||/||b|| 1.564605977601e-01
Linear solve did not converge due to DIVERGED_INDEFINITE_PC iterations 2
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       57 ****************************************
                         Simulation time =     2.2266 sec 
                          Time/time step =     3.1149 sec 
                  Average time/time step =     5.2999 sec 
  
   U MAX =  8.224437242859797E-04  V MAX =  8.224437242859797E-04  W MAX =  6.396271424076921E-10  
   U MIN = -8.224437242859797E-04  V MIN = -8.224437242859797E-04  W MIN = -1.395530456105393E-02  
   U MAX =  8.224437242859797E-04  V MAX =  8.224437242859797E-04  W MAX =  1.395530456105393E-02  
   max(|divU|)    =  6.024519384412073E-02
   sum(divU*dV)   =  1.301277135451108E-16
   sum(|divU|*dV) =  4.417280564319946E-02
   Convective cfl =  9.984122886160571E-02  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.809246870908851E-01  
               Iterations to convergence =     2
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 9.540635888297e-03 true resid norm 9.540635888297e-03 ||r(i)||/||b|| 1.596034321147e-01
  1 KSP unpreconditioned resid norm 1.056716658719e-02 true resid norm 1.056716658719e-02 ||r(i)||/||b|| 1.767760634396e-01
Linear solve did not converge due to DIVERGED_INDEFINITE_PC iterations 2
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       58 ****************************************
                         Simulation time =     2.2656 sec 
                          Time/time step =     3.1126 sec 
                  Average time/time step =     5.2622 sec 
  
   U MAX =  8.383622937791725E-04  V MAX =  8.383622937791725E-04  W MAX =  7.233051678163470E-10  
   U MIN = -8.383622937791725E-04  V MIN = -8.383622937791725E-04  W MIN = -1.421181848163963E-02  
   U MAX =  8.383622937791725E-04  V MAX =  8.383622937791725E-04  W MAX =  1.421181848163963E-02  
   max(|divU|)    =  6.107316302490359E-02
   sum(divU*dV)   =  2.143023305597198E-16
   sum(|divU|*dV) =  4.500860689979907E-02
   Convective cfl =  1.016866756428670E-01  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.801592699424566E-01  
               Iterations to convergence =     2
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.093039378003e-02 true resid norm 1.093039378003e-02 ||r(i)||/||b|| 1.802637775768e-01
  1 KSP unpreconditioned resid norm 1.120586105321e-02 true resid norm 1.120586105321e-02 ||r(i)||/||b|| 1.848067768742e-01
Linear solve did not converge due to DIVERGED_INDEFINITE_PC iterations 2
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       59 ****************************************
                         Simulation time =     2.3047 sec 
                          Time/time step =     3.1166 sec 
                  Average time/time step =     5.2258 sec 
  
   U MAX =  8.541671768674378E-04  V MAX =  8.541671768674378E-04  W MAX =  8.156020755531066E-10  
   U MIN = -8.541671768674378E-04  V MIN = -8.541671768674378E-04  W MIN = -1.446875973217087E-02  
   U MAX =  8.541671768674378E-04  V MAX =  8.541671768674378E-04  W MAX =  1.446875973217087E-02  
   max(|divU|)    =  6.189500431536687E-02
   sum(divU*dV)   = -1.994552209034640E-16
   sum(|divU|*dV) =  4.584631503542637E-02
   Convective cfl =  1.035334021497968E-01  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.793937430115675E-01  
               Iterations to convergence =     2
 Convergence in            1  iterations
  0 KSP unpreconditioned resid norm 1.162684118472e-02 true resid norm 1.162684118472e-02 ||r(i)||/||b|| 1.890803640116e-01
  1 KSP unpreconditioned resid norm 1.216327907130e-02 true resid norm 1.216327907130e-02 ||r(i)||/||b|| 1.978041325102e-01
Linear solve did not converge due to DIVERGED_INDEFINITE_PC iterations 2
KSP Object: 1 MPI processes
  type: cg
  maximum iterations=10000
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000
  left preconditioning
  using nonzero initial guess
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=3 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (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:    (mg_coarse_)     1 MPI processes
      type: bjacobi
        block Jacobi: number of blocks = 1
        Local solve info for each block is in the following KSP and PC objects:
      [0] number of local blocks = 1, first local block number = 0
        [0] local block number 0
        KSP Object:        (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:        (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
            matrix ordering: nd
            factor fill ratio given 5, needed 2.26888
              Factored matrix follows:
                Matrix Object:                 1 MPI processes
                  type: seqaij
                  rows=155, cols=155
                  package used to perform factorization: petsc
                  total: nonzeros=16851, allocated nonzeros=16851
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 110 nodes, limit used is 5
          linear system matrix = precond matrix:
          Matrix Object:           1 MPI processes
            type: seqaij
            rows=155, cols=155
            total: nonzeros=7427, allocated nonzeros=7427
            total number of mallocs used during MatSetValues calls =0
              not using I-node routines
        - - - - - - - - - - - - - - - - - -
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=155, cols=155
        total: nonzeros=7427, allocated nonzeros=7427
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (mg_levels_1_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0704919, max = 1.48033
      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:    (mg_levels_1_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=11665, cols=11665
        total: nonzeros=393037, allocated nonzeros=393037
        total number of mallocs used during MatSetValues calls =0
          not using I-node routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (mg_levels_2_)     1 MPI processes
      type: chebyshev
        Chebyshev: eigenvalue estimates:  min = 0.0925946, max = 1.94449
      maximum iterations=2
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (mg_levels_2_)     1 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       1 MPI processes
        type: seqaij
        rows=131072, cols=131072
        total: nonzeros=917504, allocated nonzeros=917504
        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:
  Matrix Object:   1 MPI processes
    type: seqaij
    rows=131072, cols=131072
    total: nonzeros=917504, allocated nonzeros=917504
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines

**************************************** TIME STEP =       60 ****************************************
                         Simulation time =     2.3438 sec 
                          Time/time step =     3.1097 sec 
                  Average time/time step =     5.1905 sec 
  
   U MAX =  8.745386602467303E-04  V MAX =  8.745386602467303E-04  W MAX =  9.171554515245112E-10  
   U MIN = -8.745386602467303E-04  V MIN = -8.745386602467303E-04  W MIN = -1.472612170301261E-02  
   U MAX =  8.745386602467303E-04  V MAX =  8.745386602467303E-04  W MAX =  1.472612170301261E-02  
   max(|divU|)    =  6.271064239595950E-02
   sum(divU*dV)   =  5.434308178504297E-17
   sum(|divU|*dV) =  4.668591125631307E-02
   Convective cfl =  1.054412737504388E-01  Viscous cfl =  7.281777777777779E-01  Gravity cfl =  6.205004906490450E-01  
   DT =  3.906250000000000E-02  MAX DT ALLOWED =  8.786033133991950E-01  
               Iterations to convergence =     2

---------------------------------------- SUMMARY ----------------------------------------
                              Setup time =     0.0290 min 
                     Initialization time =     0.0021 min 
                         Processing time =     5.1905 min 
                    Post-processing time =     0.0000 min 
                   Total simulation time =     5.2216 min 
           Processing time per time step =     5.1905 sec 
              Total number of time steps =       60
************************************************************************************************************************
***             WIDEN YOUR WINDOW TO 120 CHARACTERS.  Use 'enscript -r -fCourier9' to print this document            ***
************************************************************************************************************************

---------------------------------------------- PETSc Performance Summary: ----------------------------------------------

./hit on a interlagos-64idx-gnu-dbg named nid21503 with 1 processor, by Unknown Thu May 15 13:14:15 2014
Using Petsc Release Version 3.4.2, Jul, 02, 2013 

                         Max       Max/Min        Avg      Total 
Time (sec):           3.135e+02      1.00000   3.135e+02
Objects:              1.264e+03      1.00000   1.264e+03
Flops:                1.133e+10      1.00000   1.133e+10  1.133e+10
Flops/sec:            3.614e+07      1.00000   3.614e+07  3.614e+07
Memory:               1.210e+08      1.00000              1.210e+08
MPI Messages:         0.000e+00      0.00000   0.000e+00  0.000e+00
MPI Message Lengths:  0.000e+00      0.00000   0.000e+00  0.000e+00
MPI Reductions:       2.820e+04      1.00000

Flop counting convention: 1 flop = 1 real number operation of type (multiply/divide/add/subtract)
                            e.g., VecAXPY() for real vectors of length N --> 2N flops
                            and VecAXPY() for complex vectors of length N --> 8N flops

Summary of Stages:   ----- Time ------  ----- Flops -----  --- Messages ---  -- Message Lengths --  -- Reductions --
                        Avg     %Total     Avg     %Total   counts   %Total     Avg         %Total   counts   %Total 
 0:      Main Stage: 3.1346e+02 100.0%  1.1329e+10 100.0%  0.000e+00   0.0%  0.000e+00        0.0%  2.819e+04 100.0% 

------------------------------------------------------------------------------------------------------------------------
See the 'Profiling' chapter of the users' manual for details on interpreting output.
Phase summary info:
   Count: number of times phase was executed
   Time and Flops: Max - maximum over all processors
                   Ratio - ratio of maximum to minimum over all processors
   Mess: number of messages sent
   Avg. len: average message length (bytes)
   Reduct: number of global reductions
   Global: entire computation
   Stage: stages of a computation. Set stages with PetscLogStagePush() and PetscLogStagePop().
      %T - percent time in this phase         %f - percent flops in this phase
      %M - percent messages in this phase     %L - percent message lengths in this phase
      %R - percent reductions in this phase
   Total Mflop/s: 10e-6 * (sum of flops over all processors)/(max time over all processors)
------------------------------------------------------------------------------------------------------------------------


      ##########################################################
      #                                                        #
      #                          WARNING!!!                    #
      #                                                        #
      #   This code was compiled with a debugging option,      #
      #   To get timing results run ./configure                #
      #   using --with-debugging=no, the performance will      #
      #   be generally two or three times faster.              #
      #                                                        #
      ##########################################################


Event                Count      Time (sec)     Flops                             --- Global ---  --- Stage ---   Total
                   Max Ratio  Max     Ratio   Max  Ratio  Mess   Avg len Reduct  %T %f %M %L %R  %T %f %M %L %R Mflop/s
------------------------------------------------------------------------------------------------------------------------

--- Event Stage 0: Main Stage

ThreadCommRunKer       1 1.0 5.9605e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
ThreadCommBarrie       1 1.0 2.8610e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecMDot               20 1.0 1.8802e-02 1.0 1.57e+07 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0   835
VecTDot              790 1.0 2.0298e-01 1.0 2.07e+08 1.0 0.0e+00 0.0e+00 0.0e+00  0  2  0  0  0   0  2  0  0  0  1020
VecNorm              980 1.0 1.0135e-01 1.0 2.54e+08 1.0 0.0e+00 0.0e+00 0.0e+00  0  2  0  0  0   0  2  0  0  0  2509
VecScale            3230 1.0 4.8646e-01 1.0 2.31e+08 1.0 0.0e+00 0.0e+00 0.0e+00  0  2  0  0  0   0  2  0  0  0   474
VecCopy             1314 1.0 2.0094e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecSet              3909 1.0 2.9169e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecAXPY             7196 1.0 1.2969e+00 1.0 1.12e+09 1.0 0.0e+00 0.0e+00 0.0e+00  0 10  0  0  0   0 10  0  0  0   864
VecAYPX             7253 1.0 4.8285e+00 1.0 7.25e+08 1.0 0.0e+00 0.0e+00 0.0e+00  2  6  0  0  0   2  6  0  0  0   150
VecMAXPY              22 1.0 3.6978e-02 1.0 1.86e+07 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0   502
VecAssemblyBegin      62 1.0 1.8764e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecAssemblyEnd        62 1.0 1.7571e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecPointwiseMult    4834 1.0 2.3412e+00 1.0 3.45e+08 1.0 0.0e+00 0.0e+00 0.0e+00  1  3  0  0  0   1  3  0  0  0   147
VecScatterBegin      120 1.0 1.4015e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecSetRandom           2 1.0 1.5882e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecNormalize          22 1.0 1.3849e-02 1.0 4.71e+06 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0   340
MatMult             5729 1.0 4.0637e+01 1.0 7.52e+09 1.0 0.0e+00 0.0e+00 0.0e+00 13 66  0  0  0  13 66  0  0  0   185
MatMultAdd           802 1.0 2.9998e+00 1.0 4.08e+08 1.0 0.0e+00 0.0e+00 0.0e+00  1  4  0  0  0   1  4  0  0  0   136
MatMultTranspose     802 1.0 3.5211e+00 1.0 4.08e+08 1.0 0.0e+00 0.0e+00 8.0e+02  1  4  0  0  3   1  4  0  0  3   116
MatSolve             401 1.0 6.9252e-02 1.0 1.35e+07 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0   194
MatLUFactorSym         1 1.0 2.0640e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 5.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatLUFactorNum         1 1.0 9.8920e-03 1.0 1.08e+06 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0   109
MatConvert             2 1.0 3.3493e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 6.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatScale               6 1.0 2.2011e-02 1.0 3.64e+06 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0   165
MatAssemblyBegin      79 1.0 3.0279e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatAssemblyEnd        79 1.0 5.6627e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatGetRow         428211 1.0 1.1904e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatGetRowIJ            1 1.0 1.1492e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatGetOrdering         1 1.0 5.8603e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 2.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatCoarsen             2 1.0 7.4472e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 8.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatView              360 1.0 5.0706e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatAXPY                2 1.0 7.3698e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatMatMult             2 1.0 2.6457e-01 1.0 3.13e+06 1.0 0.0e+00 0.0e+00 1.2e+01  0  0  0  0  0   0  0  0  0  0    12
MatMatMultSym          2 1.0 2.0506e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 1.2e+01  0  0  0  0  0   0  0  0  0  0     0
MatMatMultNum          2 1.0 5.9428e-02 1.0 3.13e+06 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0    53
MatPtAP                2 1.0 8.5463e-01 1.0 1.91e+07 1.0 0.0e+00 0.0e+00 1.2e+01  0  0  0  0  0   0  0  0  0  0    22
MatPtAPSymbolic        2 1.0 2.9844e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 1.2e+01  0  0  0  0  0   0  0  0  0  0     0
MatPtAPNumeric         2 1.0 5.5616e-01 1.0 1.91e+07 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0    34
MatTrnMatMult          2 1.0 2.5088e+00 1.0 3.99e+07 1.0 0.0e+00 0.0e+00 2.4e+01  1  0  0  0  0   1  0  0  0  0    16
MatGetSymTrans         4 1.0 5.5090e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
KSPGMRESOrthog        20 1.0 5.0538e-02 1.0 3.14e+07 1.0 0.0e+00 0.0e+00 1.1e+02  0  0  0  0  0   0  0  0  0  0   621
KSPSetUp               8 1.0 5.7340e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 1.0e+02  0  0  0  0  0   0  0  0  0  0     0
KSPSolve              60 1.0 1.6715e+02 1.0 1.13e+10 1.0 0.0e+00 0.0e+00 2.7e+04 53100  0  0 96  53100  0  0 96    68
PCSetUp                2 1.0 2.2745e+01 1.0 1.32e+08 1.0 0.0e+00 0.0e+00 5.8e+02  7  1  0  0  2   7  1  0  0  2     6
PCSetUpOnBlocks      401 1.0 1.4589e-02 1.0 1.08e+06 1.0 0.0e+00 0.0e+00 1.0e+01  0  0  0  0  0   0  0  0  0  0    74
PCApply              401 1.0 1.1839e+02 1.0 8.85e+09 1.0 0.0e+00 0.0e+00 2.1e+04 38 78  0  0 75  38 78  0  0 75    75
PCGAMGgraph_AGG        2 1.0 5.8934e+00 1.0 2.62e+06 1.0 0.0e+00 0.0e+00 3.0e+01  2  0  0  0  0   2  0  0  0  0     0
PCGAMGcoarse_AGG       2 1.0 2.7180e+00 1.0 3.99e+07 1.0 0.0e+00 0.0e+00 3.4e+01  1  0  0  0  0   1  0  0  0  0    15
PCGAMGProl_AGG         2 1.0 1.1115e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 1.2e+01  4  0  0  0  0   4  0  0  0  0     0
PCGAMGPOpt_AGG         2 1.0 2.1251e+00 1.0 6.98e+07 1.0 0.0e+00 0.0e+00 3.5e+02  1  1  0  0  1   1  1  0  0  1    33
------------------------------------------------------------------------------------------------------------------------

Memory usage is given in bytes:

Object Type          Creations   Destructions     Memory  Descendants' Mem.
Reports information only for process 0.

--- Event Stage 0: Main Stage

              Vector  1093           1093   1124012864     0
      Vector Scatter     2              2         1384     0
              Matrix    16             16     80634240     0
      Matrix Coarsen     2              2         1368     0
   Matrix Null Space   120            120        78240     0
    Distributed Mesh     1              1      2409608     0
     Bipartite Graph     2              2         1712     0
           Index Set    10             10      1206832     0
   IS L to G Mapping     1              1      1202876     0
       Krylov Solver     7              7        85064     0
      Preconditioner     7              7         7752     0
              Viewer     1              0            0     0
         PetscRandom     2              2         1344     0
========================================================================================================================
Average time to get PetscTime(): 1.90735e-07
#PETSc Option Table entries:
-finput input_droplet.txt
-ksp_converged_reason
-ksp_monitor_true_residual
-ksp_view
-log_summary
-options_left
-pc_gamg_agg_nsmooths 1
-pc_type gamg
#End of PETSc Option Table entries
Compiled without FORTRAN kernels
Compiled with full precision matrices (default)
sizeof(short) 2 sizeof(int) 4 sizeof(long) 8 sizeof(void*) 8 sizeof(PetscScalar) 8 sizeof(PetscInt) 8
Configure run at: Wed May 14 12:49:45 2014
Configure options: --known-level1-dcache-size=16384 --known-level1-dcache-linesize=64 --known-level1-dcache-assoc=4 --known-memcmp-ok=1 --known-sizeof-char=1 --known-sizeof-void-p=8 --known-sizeof-short=2 --known-sizeof-int=4 --known-sizeof-long=8 --known-sizeof-long-long=8 --known-sizeof-float=4 --known-sizeof-double=8 --known-sizeof-size_t=8 --known-bits-per-byte=8 --known-sizeof-MPI_Comm=4 --known-sizeof-MPI_Fint=4 --known-mpi-long-double=1 --known-mpi-c-double-complex=1 --with-batch="1 " --known-mpi-shared="0 " --known-mpi-shared-libraries=0 --known-memcmp-ok  --with-blas-lapack-lib="-L/opt/acml/5.3.0/gfortran64/lib  -lacml" --with-x="0 " --with-debugging="1 " --with-clib-autodetect="0 " --with-cxxlib-autodetect="0 " --with-fortranlib-autodetect="0 " --with-shared-libraries="0 " --with-dynamic-loading="0 " --with-mpi-compilers="1 " --with-cc="cc " --with-cxx="CC " --with-fc="ftn " --with-64-bit-indices --download-blacs="1 " --download-scalapack="1 " --download-superlu_dist="1 " --download-metis="1 " --download-parmetis="1 " PETSC_ARCH=interlagos-64idx-gnu-dbg
-----------------------------------------
Libraries compiled on Wed May 14 12:49:45 2014 on h2ologin2 
Machine characteristics: Linux-2.6.32.59-0.7-default-x86_64-with-SuSE-11-x86_64
Using PETSc directory: /mnt/a/u/sciteam/mrosso/LIBS/petsc-3.4.2
Using PETSc arch: interlagos-64idx-gnu-dbg
-----------------------------------------

Using C compiler: cc  -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -g3 -fno-inline -O0  ${COPTFLAGS} ${CFLAGS}
Using Fortran compiler: ftn  -Wall -Wno-unused-variable -Wno-unused-dummy-argument -g   ${FOPTFLAGS} ${FFLAGS} 
-----------------------------------------

Using include paths: -I/mnt/a/u/sciteam/mrosso/LIBS/petsc-3.4.2/interlagos-64idx-gnu-dbg/include -I/mnt/a/u/sciteam/mrosso/LIBS/petsc-3.4.2/include -I/mnt/a/u/sciteam/mrosso/LIBS/petsc-3.4.2/include -I/mnt/a/u/sciteam/mrosso/LIBS/petsc-3.4.2/interlagos-64idx-gnu-dbg/include
-----------------------------------------

Using C linker: cc
Using Fortran linker: ftn
Using libraries: -Wl,-rpath,/mnt/a/u/sciteam/mrosso/LIBS/petsc-3.4.2/interlagos-64idx-gnu-dbg/lib -L/mnt/a/u/sciteam/mrosso/LIBS/petsc-3.4.2/interlagos-64idx-gnu-dbg/lib -lpetsc -Wl,-rpath,/mnt/a/u/sciteam/mrosso/LIBS/petsc-3.4.2/interlagos-64idx-gnu-dbg/lib -L/mnt/a/u/sciteam/mrosso/LIBS/petsc-3.4.2/interlagos-64idx-gnu-dbg/lib -lsuperlu_dist_3.3 -L/opt/acml/5.3.0/gfortran64/lib -lacml -lpthread -lparmetis -lmetis -ldl 
-----------------------------------------

#PETSc Option Table entries:
-ksp_converged_reason
-ksp_monitor_true_residual
-ksp_view
-log_summary
-options_left
-pc_gamg_agg_nsmooths 1
-pc_type gamg
#End of PETSc Option Table entries
There is no unused database option.
Application 4423330 resources: utime ~282s, stime ~33s, Rss ~206632, inblocks ~23827, outblocks ~77441


More information about the petsc-users mailing list