[petsc-users] Strange behavior of TS after setting hand-coded Jacobian

仓宇 yhcy1993 at gmail.com
Wed Oct 27 00:47:43 CDT 2021


Thanks for your kind reply.

Several comparison tests have been performed. Attached are execution
output files. Below are corresponding descriptions.

good.txt -- Run without hand-coded jacobian, solution converged, with
option '-ts_monitor -snes_monitor -snes_converged_reason
-ksp_monitor_true_residual -ksp_converged_reason';
jac1.txt -- Run with hand-coded jacobian, does not converge, with
option '-ts_monitor -snes_monitor -snes_converged_reason
-ksp_monitor_true_residual -ksp_converged_reason -snes_test_jacobian';
jac2.txt -- Run with hand-coded jacobian, does not converge, with
option '-ts_monitor -snes_monitor -snes_converged_reason
-ksp_monitor_true_residual -ksp_converged_reason -snes_test_jacobian
-ksp_view';
jac3.txt -- Run with hand-coded jacobian, does not converge, with
option '-ts_monitor -snes_monitor -snes_converged_reason
-ksp_monitor_true_residual -ksp_converged_reason -snes_test_jacobian
-ksp_view -ts_max_snes_failures -1 ';

The problem under consideration contains an eigen-value to be solved,
making the first diagonal element of the jacobian matrix being zero.
>From these outputs, it seems that the PC failed to factorize, which is
caused by this 0 diagonal element.  But I'm wondering why it works
with jacobian matrix generated by finite-difference? Would employing
DMDA for discretization be helpful?

Regards

Yu Cang

Barry Smith <bsmith at petsc.dev> 于2021年10月25日周一 下午10:50写道:
>
>
>   It is definitely unexpected that -snes_test_jacobian verifies the Jacobian as matching but the solve process is completely different.
>
>    Please run with -snes_monitor -snes_converged_reason -ksp_monitor_true_residual -ksp_converged_reason -snes_test_jacobian and send all the output
>
>   Barry
>
>
> > On Oct 25, 2021, at 9:53 AM, 仓宇 <yhcy1993 at gmail.com> wrote:
> >
> > I'm using TS to solve a set of DAE, which originates from a
> > one-dimensional problem. The grid points are uniformly distributed.
> > For simplicity, the DMDA is not employed for discretization.
> >
> > At first, only the residual function is prescribed through
> > 'TSSetIFunction', and PETSC produces converged results. However, after
> > providing hand-coded Jacobian through 'TSSetIJacobian', the internal
> > SNES object fails (residual norm does not change), and TS reports
> > 'DIVERGED_STEP_REJECTED'.
> >
> > I have tried to add the option '-snes_test_jacobian' to see if the
> > hand-coded jacobian is somewhere wrong, but it shows '||J -
> > Jfd||_F/||J||_F = 1.07488e-10, ||J - Jfd||_F = 2.14458e-07',
> > indicating that the hand-coded jacobian is correct.
> >
> > Then, I added a monitor for the internal SNES object through
> > 'SNESMonitorSet', in which the solution vector will be displayed at
> > each iteration. It is interesting to find that, if the jacobian is not
> > provided, meaning finite-difference is utilized for jacobian
> > evaluation internally, the solution vector converges to steady
> > solution and the SNES residual norm is reduced continuously. However,
> > it turns out that, as long as the jacobian is provided, the solution
> > vector will NEVER get changed! So the solution procedure stucked!
> >
> > This is quite strange!  Hope to get some advice.
> > PETSC version=3.14.6, program run in serial mode.
> >
> > Regards
> >
> > Yu Cang
>
-------------- next part --------------
============================================================
=                          OPPDIFF                         =
=      1D counterflow solver for incompressible fluid      =
============================================================
Parameters:
	Domain gap = 3.(cm)
	Grid points: 21
	Spacing = 0.05, 1.42857(mm)
	Reference density = 1.225(kg/m^3)
	Reference velocity = 0.01(m/s)
	Re = 100.000000
	Dynamic viscosity = 3.675e-06(kg/m/s)
	Kinetic viscosity = 3e-06(m^2/s)
	Inlet velocity @left = 5., 0.05(m/s)
	Inlet velocity @right = -5., -0.05(m/s)
	Starting time = 0., 0.(s)
	Ending time = 100., 33.3333(s)

Creating vectors and matrices ... Done!

Setting I.C. ... Done!

Setting TS ... Done!

Time-Stepping ... 
0 TS dt 0.1 time 0.
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    Run with -snes_test_jacobian_view and optionally -snes_test_jacobian <threshold> to show difference
      of hand-coded and finite difference Jacobian entries greater than <threshold>.
    Testing hand-coded Jacobian, if (for double precision runs) ||J - Jfd||_F/||J||_F is
      O(1.e-8), the hand-coded Jacobian is probably correct.
    ||J - Jfd||_F/||J||_F = 7.5633e-10, ||J - Jfd||_F = 3.17683e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
KSP Object: 1 MPI processes
  type: gmres
    restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=1e-05, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: ilu
    out-of-place factorization
    0 levels of fill
    tolerance for zero pivot 2.22045e-14
    matrix ordering: natural
    factor fill ratio given 1., needed 1.
      Factored matrix follows:
        Mat Object: 1 MPI processes
          type: seqaij
          rows=43, cols=43
          package used to perform factorization: petsc
          total: nonzeros=180, allocated nonzeros=180
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object: 1 MPI processes
    type: seqaij
    rows=43, cols=43
    total: nonzeros=180, allocated nonzeros=215
    total number of mallocs used during MatSetValues calls=0
      not using I-node routines
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    ||J - Jfd||_F/||J||_F = 6.13604e-10, ||J - Jfd||_F = 3.17683e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
KSP Object: 1 MPI processes
  type: gmres
    restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=1e-05, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: ilu
    out-of-place factorization
    0 levels of fill
    tolerance for zero pivot 2.22045e-14
    matrix ordering: natural
    factor fill ratio given 1., needed 1.
      Factored matrix follows:
        Mat Object: 1 MPI processes
          type: seqaij
          rows=43, cols=43
          package used to perform factorization: petsc
          total: nonzeros=180, allocated nonzeros=180
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object: 1 MPI processes
    type: seqaij
    rows=43, cols=43
    total: nonzeros=180, allocated nonzeros=215
    total number of mallocs used during MatSetValues calls=0
      not using I-node routines
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    ||J - Jfd||_F/||J||_F = 3.21478e-10, ||J - Jfd||_F = 3.17683e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
KSP Object: 1 MPI processes
  type: gmres
    restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=1e-05, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: ilu
    out-of-place factorization
    0 levels of fill
    tolerance for zero pivot 2.22045e-14
    matrix ordering: natural
    factor fill ratio given 1., needed 1.
      Factored matrix follows:
        Mat Object: 1 MPI processes
          type: seqaij
          rows=43, cols=43
          package used to perform factorization: petsc
          total: nonzeros=180, allocated nonzeros=180
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object: 1 MPI processes
    type: seqaij
    rows=43, cols=43
    total: nonzeros=180, allocated nonzeros=215
    total number of mallocs used during MatSetValues calls=0
      not using I-node routines
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    ||J - Jfd||_F/||J||_F = 1.04271e-10, ||J - Jfd||_F = 3.17683e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
KSP Object: 1 MPI processes
  type: gmres
    restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=1e-05, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: ilu
    out-of-place factorization
    0 levels of fill
    tolerance for zero pivot 2.22045e-14
    matrix ordering: natural
    factor fill ratio given 1., needed 1.
      Factored matrix follows:
        Mat Object: 1 MPI processes
          type: seqaij
          rows=43, cols=43
          package used to perform factorization: petsc
          total: nonzeros=180, allocated nonzeros=180
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object: 1 MPI processes
    type: seqaij
    rows=43, cols=43
    total: nonzeros=180, allocated nonzeros=215
    total number of mallocs used during MatSetValues calls=0
      not using I-node routines
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    ||J - Jfd||_F/||J||_F = 2.78563e-11, ||J - Jfd||_F = 3.17682e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
KSP Object: 1 MPI processes
  type: gmres
    restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=1e-05, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: ilu
    out-of-place factorization
    0 levels of fill
    tolerance for zero pivot 2.22045e-14
    matrix ordering: natural
    factor fill ratio given 1., needed 1.
      Factored matrix follows:
        Mat Object: 1 MPI processes
          type: seqaij
          rows=43, cols=43
          package used to perform factorization: petsc
          total: nonzeros=180, allocated nonzeros=180
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object: 1 MPI processes
    type: seqaij
    rows=43, cols=43
    total: nonzeros=180, allocated nonzeros=215
    total number of mallocs used during MatSetValues calls=0
      not using I-node routines
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    ||J - Jfd||_F/||J||_F = 7.07886e-12, ||J - Jfd||_F = 3.17682e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
KSP Object: 1 MPI processes
  type: gmres
    restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=1e-05, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: ilu
    out-of-place factorization
    0 levels of fill
    tolerance for zero pivot 2.22045e-14
    matrix ordering: natural
    factor fill ratio given 1., needed 1.
      Factored matrix follows:
        Mat Object: 1 MPI processes
          type: seqaij
          rows=43, cols=43
          package used to perform factorization: petsc
          total: nonzeros=180, allocated nonzeros=180
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object: 1 MPI processes
    type: seqaij
    rows=43, cols=43
    total: nonzeros=180, allocated nonzeros=215
    total number of mallocs used during MatSetValues calls=0
      not using I-node routines
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    ||J - Jfd||_F/||J||_F = 1.77683e-12, ||J - Jfd||_F = 3.17665e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
KSP Object: 1 MPI processes
  type: gmres
    restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=1e-05, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: ilu
    out-of-place factorization
    0 levels of fill
    tolerance for zero pivot 2.22045e-14
    matrix ordering: natural
    factor fill ratio given 1., needed 1.
      Factored matrix follows:
        Mat Object: 1 MPI processes
          type: seqaij
          rows=43, cols=43
          package used to perform factorization: petsc
          total: nonzeros=180, allocated nonzeros=180
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object: 1 MPI processes
    type: seqaij
    rows=43, cols=43
    total: nonzeros=180, allocated nonzeros=215
    total number of mallocs used during MatSetValues calls=0
      not using I-node routines
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    ||J - Jfd||_F/||J||_F = 4.44717e-13, ||J - Jfd||_F = 3.17707e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
KSP Object: 1 MPI processes
  type: gmres
    restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=1e-05, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: ilu
    out-of-place factorization
    0 levels of fill
    tolerance for zero pivot 2.22045e-14
    matrix ordering: natural
    factor fill ratio given 1., needed 1.
      Factored matrix follows:
        Mat Object: 1 MPI processes
          type: seqaij
          rows=43, cols=43
          package used to perform factorization: petsc
          total: nonzeros=180, allocated nonzeros=180
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object: 1 MPI processes
    type: seqaij
    rows=43, cols=43
    total: nonzeros=180, allocated nonzeros=215
    total number of mallocs used during MatSetValues calls=0
      not using I-node routines
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    ||J - Jfd||_F/||J||_F = 1.11165e-13, ||J - Jfd||_F = 3.17586e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
KSP Object: 1 MPI processes
  type: gmres
    restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=1e-05, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: ilu
    out-of-place factorization
    0 levels of fill
    tolerance for zero pivot 2.22045e-14
    matrix ordering: natural
    factor fill ratio given 1., needed 1.
      Factored matrix follows:
        Mat Object: 1 MPI processes
          type: seqaij
          rows=43, cols=43
          package used to perform factorization: petsc
          total: nonzeros=180, allocated nonzeros=180
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object: 1 MPI processes
    type: seqaij
    rows=43, cols=43
    total: nonzeros=180, allocated nonzeros=215
    total number of mallocs used during MatSetValues calls=0
      not using I-node routines
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    ||J - Jfd||_F/||J||_F = 2.77876e-14, ||J - Jfd||_F = 3.17524e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
KSP Object: 1 MPI processes
  type: gmres
    restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=1e-05, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: ilu
    out-of-place factorization
    0 levels of fill
    tolerance for zero pivot 2.22045e-14
    matrix ordering: natural
    factor fill ratio given 1., needed 1.
      Factored matrix follows:
        Mat Object: 1 MPI processes
          type: seqaij
          rows=43, cols=43
          package used to perform factorization: petsc
          total: nonzeros=180, allocated nonzeros=180
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object: 1 MPI processes
    type: seqaij
    rows=43, cols=43
    total: nonzeros=180, allocated nonzeros=215
    total number of mallocs used during MatSetValues calls=0
      not using I-node routines
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    ||J - Jfd||_F/||J||_F = 6.89057e-15, ||J - Jfd||_F = 3.14944e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
KSP Object: 1 MPI processes
  type: gmres
    restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=1e-05, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: ilu
    out-of-place factorization
    0 levels of fill
    tolerance for zero pivot 2.22045e-14
    matrix ordering: natural
    factor fill ratio given 1., needed 1.
      Factored matrix follows:
        Mat Object: 1 MPI processes
          type: seqaij
          rows=43, cols=43
          package used to perform factorization: petsc
          total: nonzeros=180, allocated nonzeros=180
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object: 1 MPI processes
    type: seqaij
    rows=43, cols=43
    total: nonzeros=180, allocated nonzeros=215
    total number of mallocs used during MatSetValues calls=0
      not using I-node routines
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0

[0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[0]PETSC ERROR:   
[0]PETSC ERROR: TSStep has failed due to DIVERGED_STEP_REJECTED
[0]PETSC ERROR: See https://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[0]PETSC ERROR: Petsc Release Version 3.14.6, unknown 
[0]PETSC ERROR: ./incompressible_jac on a  named LARGE by sun Wed Oct 27 13:24:28 2021
[0]PETSC ERROR: Configure options --prefix=/usr/local --download-hypre=/home/sun/Downloads/hypre-2.20.0.zip --download-zlib --download-p4est=/home/sun/Downloads/p4est-v2.0.zip --with-debugging=0 --COPTFLAGS="-O3 -march=native -mtune=native" --CXXOPTFLAGS="-O3 -march=native -mtune=native" --FOPTFLAGS="-O3 -march=native -mtune=native"
[0]PETSC ERROR: #1 TSStep() line 3775 in /home/sun/Desktop/SOFTWARE/petsc/3.14.6/src/ts/interface/ts.c
[0]PETSC ERROR: #2 TSSolve() line 4156 in /home/sun/Desktop/SOFTWARE/petsc/3.14.6/src/ts/interface/ts.c
[0]PETSC ERROR: #3 main() line 295 in /home/sun/Desktop/TFM/incompressible_jac.cc
[0]PETSC ERROR: PETSc Option Table entries:
[0]PETSC ERROR: -ksp_converged_reason
[0]PETSC ERROR: -ksp_monitor_true_residual
[0]PETSC ERROR: -ksp_view
[0]PETSC ERROR: -snes_converged_reason
[0]PETSC ERROR: -snes_monitor
[0]PETSC ERROR: -snes_test_jacobian
[0]PETSC ERROR: -ts_max_snes_failures -1
[0]PETSC ERROR: -ts_monitor
[0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
--------------------------------------------------------------------------
MPI_ABORT was invoked on rank 0 in communicator MPI_COMM_SELF
with errorcode 295091.

NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes.
You may or may not see output from other processes, depending on
exactly when Open MPI kills them.
--------------------------------------------------------------------------
-------------- next part --------------
============================================================
=                          OPPDIFF                         =
=      1D counterflow solver for incompressible fluid      =
============================================================
Parameters:
	Domain gap = 3.(cm)
	Grid points: 21
	Spacing = 0.05, 1.42857(mm)
	Reference density = 1.225(kg/m^3)
	Reference velocity = 0.01(m/s)
	Re = 100.000000
	Dynamic viscosity = 3.675e-06(kg/m/s)
	Kinetic viscosity = 3e-06(m^2/s)
	Inlet velocity @left = 5., 0.05(m/s)
	Inlet velocity @right = -5., -0.05(m/s)
	Starting time = 0., 0.(s)
	Ending time = 100., 33.3333(s)

Creating vectors and matrices ... Done!

Setting I.C. ... Done!

Setting TS ... Done!

Time-Stepping ... 
0 TS dt 0.1 time 0.
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    Run with -snes_test_jacobian_view and optionally -snes_test_jacobian <threshold> to show difference
      of hand-coded and finite difference Jacobian entries greater than <threshold>.
    Testing hand-coded Jacobian, if (for double precision runs) ||J - Jfd||_F/||J||_F is
      O(1.e-8), the hand-coded Jacobian is probably correct.
    ||J - Jfd||_F/||J||_F = 7.5633e-10, ||J - Jfd||_F = 3.17683e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
KSP Object: 1 MPI processes
  type: gmres
    restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=1e-05, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: ilu
    out-of-place factorization
    0 levels of fill
    tolerance for zero pivot 2.22045e-14
    matrix ordering: natural
    factor fill ratio given 1., needed 1.
      Factored matrix follows:
        Mat Object: 1 MPI processes
          type: seqaij
          rows=43, cols=43
          package used to perform factorization: petsc
          total: nonzeros=180, allocated nonzeros=180
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object: 1 MPI processes
    type: seqaij
    rows=43, cols=43
    total: nonzeros=180, allocated nonzeros=215
    total number of mallocs used during MatSetValues calls=0
      not using I-node routines
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0

[0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[0]PETSC ERROR:   
[0]PETSC ERROR: TSStep has failed due to DIVERGED_NONLINEAR_SOLVE, increase -ts_max_snes_failures or make negative to attempt recovery
[0]PETSC ERROR: See https://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[0]PETSC ERROR: Petsc Release Version 3.14.6, unknown 
[0]PETSC ERROR: ./incompressible_jac on a  named LARGE by sun Wed Oct 27 13:23:34 2021
[0]PETSC ERROR: Configure options --prefix=/usr/local --download-hypre=/home/sun/Downloads/hypre-2.20.0.zip --download-zlib --download-p4est=/home/sun/Downloads/p4est-v2.0.zip --with-debugging=0 --COPTFLAGS="-O3 -march=native -mtune=native" --CXXOPTFLAGS="-O3 -march=native -mtune=native" --FOPTFLAGS="-O3 -march=native -mtune=native"
[0]PETSC ERROR: #1 TSStep() line 3774 in /home/sun/Desktop/SOFTWARE/petsc/3.14.6/src/ts/interface/ts.c
[0]PETSC ERROR: #2 TSSolve() line 4156 in /home/sun/Desktop/SOFTWARE/petsc/3.14.6/src/ts/interface/ts.c
[0]PETSC ERROR: #3 main() line 295 in /home/sun/Desktop/TFM/incompressible_jac.cc
[0]PETSC ERROR: PETSc Option Table entries:
[0]PETSC ERROR: -ksp_converged_reason
[0]PETSC ERROR: -ksp_monitor_true_residual
[0]PETSC ERROR: -ksp_view
[0]PETSC ERROR: -snes_converged_reason
[0]PETSC ERROR: -snes_monitor
[0]PETSC ERROR: -snes_test_jacobian
[0]PETSC ERROR: -ts_monitor
[0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
--------------------------------------------------------------------------
MPI_ABORT was invoked on rank 0 in communicator MPI_COMM_SELF
with errorcode 295091.

NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes.
You may or may not see output from other processes, depending on
exactly when Open MPI kills them.
--------------------------------------------------------------------------
-------------- next part --------------
============================================================
=                          OPPDIFF                         =
=      1D counterflow solver for incompressible fluid      =
============================================================
Parameters:
	Domain gap = 3.(cm)
	Grid points: 21
	Spacing = 0.05, 1.42857(mm)
	Reference density = 1.225(kg/m^3)
	Reference velocity = 0.01(m/s)
	Re = 100.000000
	Dynamic viscosity = 3.675e-06(kg/m/s)
	Kinetic viscosity = 3e-06(m^2/s)
	Inlet velocity @left = 5., 0.05(m/s)
	Inlet velocity @right = -5., -0.05(m/s)
	Starting time = 0., 0.(s)
	Ending time = 100., 33.3333(s)

Creating vectors and matrices ... Done!

Setting I.C. ... Done!

Setting TS ... Done!

Time-Stepping ... 
0 TS dt 0.1 time 0.
    0 SNES Function norm 4.472135955000e+01 
    ---------- Testing Jacobian -------------
    Run with -snes_test_jacobian_view and optionally -snes_test_jacobian <threshold> to show difference
      of hand-coded and finite difference Jacobian entries greater than <threshold>.
    Testing hand-coded Jacobian, if (for double precision runs) ||J - Jfd||_F/||J||_F is
      O(1.e-8), the hand-coded Jacobian is probably correct.
    ||J - Jfd||_F/||J||_F = 7.5633e-10, ||J - Jfd||_F = 3.17683e-07
    Linear solve did not converge due to DIVERGED_PC_FAILED iterations 0
                   PC failed due to FACTOR_NUMERIC_ZEROPIVOT 
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0

[0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[0]PETSC ERROR:   
[0]PETSC ERROR: TSStep has failed due to DIVERGED_NONLINEAR_SOLVE, increase -ts_max_snes_failures or make negative to attempt recovery
[0]PETSC ERROR: See https://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[0]PETSC ERROR: Petsc Release Version 3.14.6, unknown 
[0]PETSC ERROR: ./incompressible_jac on a  named LARGE by sun Wed Oct 27 13:23:07 2021
[0]PETSC ERROR: Configure options --prefix=/usr/local --download-hypre=/home/sun/Downloads/hypre-2.20.0.zip --download-zlib --download-p4est=/home/sun/Downloads/p4est-v2.0.zip --with-debugging=0 --COPTFLAGS="-O3 -march=native -mtune=native" --CXXOPTFLAGS="-O3 -march=native -mtune=native" --FOPTFLAGS="-O3 -march=native -mtune=native"
[0]PETSC ERROR: #1 TSStep() line 3774 in /home/sun/Desktop/SOFTWARE/petsc/3.14.6/src/ts/interface/ts.c
[0]PETSC ERROR: #2 TSSolve() line 4156 in /home/sun/Desktop/SOFTWARE/petsc/3.14.6/src/ts/interface/ts.c
[0]PETSC ERROR: #3 main() line 295 in /home/sun/Desktop/TFM/incompressible_jac.cc
[0]PETSC ERROR: PETSc Option Table entries:
[0]PETSC ERROR: -ksp_converged_reason
[0]PETSC ERROR: -ksp_monitor_true_residual
[0]PETSC ERROR: -snes_converged_reason
[0]PETSC ERROR: -snes_monitor
[0]PETSC ERROR: -snes_test_jacobian
[0]PETSC ERROR: -ts_monitor
[0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
--------------------------------------------------------------------------
MPI_ABORT was invoked on rank 0 in communicator MPI_COMM_SELF
with errorcode 295091.

NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes.
You may or may not see output from other processes, depending on
exactly when Open MPI kills them.
--------------------------------------------------------------------------
-------------- next part --------------
============================================================
=                          OPPDIFF                         =
=      1D counterflow solver for incompressible fluid      =
============================================================
Parameters:
	Domain gap = 3.(cm)
	Grid points: 21
	Spacing = 0.05, 1.42857(mm)
	Reference density = 1.225(kg/m^3)
	Reference velocity = 0.01(m/s)
	Re = 100.000000
	Dynamic viscosity = 3.675e-06(kg/m/s)
	Kinetic viscosity = 3e-06(m^2/s)
	Inlet velocity @left = 5., 0.05(m/s)
	Inlet velocity @right = -5., -0.05(m/s)
	Starting time = 0., 0.(s)
	Ending time = 100., 33.3333(s)

Creating vectors and matrices ... Done!

Setting I.C. ... Done!

Setting TS ... Done!

Time-Stepping ... 
0 TS dt 0.1 time 0.
    0 SNES Function norm 4.472135955000e+01 
      0 KSP preconditioned resid norm 1.039786297622e+02 true resid norm 4.472135955000e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.274255218218e-13 true resid norm 7.808054931715e-13 ||r(i)||/||b|| 1.745934159937e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.033045523509e+01 
      0 KSP preconditioned resid norm 1.032123726781e+02 true resid norm 4.033045523509e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.644630031141e-14 true resid norm 3.044025711296e-13 ||r(i)||/||b|| 7.547709773054e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 3.647084550217e+01 
      0 KSP preconditioned resid norm 1.002205980268e+02 true resid norm 3.647084550217e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 9.146773490752e-14 true resid norm 3.867971263170e-13 ||r(i)||/||b|| 1.060565284383e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    3 SNES Function norm 3.302987397637e+01 
      0 KSP preconditioned resid norm 9.588715518038e+01 true resid norm 3.302987397637e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.733726433179e-14 true resid norm 2.146878075769e-13 ||r(i)||/||b|| 6.499807045299e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    4 SNES Function norm 2.993583488032e+01 
      0 KSP preconditioned resid norm 9.076494989978e+01 true resid norm 2.993583488032e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 5.859560435859e-14 true resid norm 4.878395102318e-13 ||r(i)||/||b|| 1.629617186833e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    5 SNES Function norm 2.713914093755e+01 
      0 KSP preconditioned resid norm 8.522166977424e+01 true resid norm 2.713914093755e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.108184839803e-13 true resid norm 5.364124140451e-13 ||r(i)||/||b|| 1.976526874153e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    6 SNES Function norm 2.411351569164e+01 
      0 KSP preconditioned resid norm 7.824190976367e+01 true resid norm 2.411351569164e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 7.275103061298e-14 true resid norm 3.526740473154e-13 ||r(i)||/||b|| 1.462557562428e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    7 SNES Function norm 2.067788533862e+01 
      0 KSP preconditioned resid norm 6.899643046015e+01 true resid norm 2.067788533862e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.974878875731e-14 true resid norm 1.477492467331e-13 ||r(i)||/||b|| 7.145278364476e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    8 SNES Function norm 1.673094982754e+01 
      0 KSP preconditioned resid norm 5.639802573789e+01 true resid norm 1.673094982754e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.726172589271e-14 true resid norm 2.345889463959e-13 ||r(i)||/||b|| 1.402125694082e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    9 SNES Function norm 1.221764259446e+01 
      0 KSP preconditioned resid norm 3.860709295211e+01 true resid norm 1.221764259446e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.754950987785e-14 true resid norm 2.701359181474e-13 ||r(i)||/||b|| 2.211031433101e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
   10 SNES Function norm 8.744164020698e+00 
      0 KSP preconditioned resid norm 1.801723834183e+00 true resid norm 8.744164020698e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.866152022490e-16 true resid norm 3.526925342092e-15 ||r(i)||/||b|| 4.033462013914e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
   11 SNES Function norm 2.295191397811e-03 
      0 KSP preconditioned resid norm 3.908782878818e-04 true resid norm 2.295191397811e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.683593598286e-19 true resid norm 1.349117963796e-18 ||r(i)||/||b|| 5.878019432640e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
   12 SNES Function norm 5.560443537355e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 12
1 TS dt 0.1 time 0.1
    0 SNES Function norm 2.481890584294e+02 
      0 KSP preconditioned resid norm 4.814575218086e+01 true resid norm 2.481890584294e+02 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 7.978258231227e-15 true resid norm 1.352195787188e-13 ||r(i)||/||b|| 5.448248991091e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.266021973228e+00 
      0 KSP preconditioned resid norm 6.295150151503e-01 true resid norm 4.266021973228e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.645871455459e-16 true resid norm 1.499784027057e-15 ||r(i)||/||b|| 3.515650028221e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 3.166231966289e-03 
      0 KSP preconditioned resid norm 4.239093106351e-04 true resid norm 3.166231966289e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.125115632561e-19 true resid norm 9.826291929518e-18 ||r(i)||/||b|| 3.103465581215e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    3 SNES Function norm 2.069014172426e-09 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 3
    0 SNES Function norm 2.481890584294e+02 
      0 KSP preconditioned resid norm 5.087493331112e+01 true resid norm 2.481890584294e+02 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.313547762114e-15 true resid norm 5.407063359255e-14 ||r(i)||/||b|| 2.178606661177e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.642481941904e-01 
      0 KSP preconditioned resid norm 7.305695402277e-02 true resid norm 3.642481941904e-01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.268326858204e-17 true resid norm 9.661537133731e-17 ||r(i)||/||b|| 2.652459857819e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.024529803087e-06 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
    0 SNES Function norm 2.481890584294e+02 
      0 KSP preconditioned resid norm 5.239714364534e+01 true resid norm 2.481890584294e+02 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.330119296858e-14 true resid norm 6.280430957932e-13 ||r(i)||/||b|| 2.530502753698e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.654112168029e-03 
      0 KSP preconditioned resid norm 1.187690198844e-03 true resid norm 5.654112168029e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 6.616189272861e-19 true resid norm 2.185254248509e-17 ||r(i)||/||b|| 3.864893697838e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.308525067597e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
    0 SNES Function norm 2.481890584294e+02 
      0 KSP preconditioned resid norm 5.259449826109e+01 true resid norm 2.481890584294e+02 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 7.225264457386e-15 true resid norm 7.898672548273e-12 ||r(i)||/||b|| 3.182522468258e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.284252616442e-04 
      0 KSP preconditioned resid norm 2.617251794092e-05 true resid norm 1.284252616442e-04 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.863905206556e-21 true resid norm 5.671523044901e-18 ||r(i)||/||b|| 4.416205170455e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.002897683626e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
    0 SNES Function norm 2.481890584294e+02 
      0 KSP preconditioned resid norm 5.261690098838e+01 true resid norm 2.481890584294e+02 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.757659105582e-14 true resid norm 1.733398935306e-11 ||r(i)||/||b|| 6.984187563606e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.078387080477e-05 
      0 KSP preconditioned resid norm 1.239471400584e-06 true resid norm 1.078387080477e-05 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.847067383530e-22 true resid norm 6.198963351121e-19 ||r(i)||/||b|| 5.748365743015e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 3.213177482058e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
2 TS dt 7.6238e-05 time 0.100061
    0 SNES Function norm 9.448753356532e+01 
      0 KSP preconditioned resid norm 1.987605682962e-02 true resid norm 9.448753356532e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.226471750824e-14 true resid norm 4.938240530548e-10 ||r(i)||/||b|| 5.226340813663e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.491295456374e-05 
      0 KSP preconditioned resid norm 7.269039400395e-06 true resid norm 3.491295456374e-05 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 9.535030356460e-22 true resid norm 5.245837518513e-18 ||r(i)||/||b|| 1.502547574121e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.495520007081e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
    0 SNES Function norm 9.448753356524e+01 
      0 KSP preconditioned resid norm 1.992148519035e-03 true resid norm 9.448753356524e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.176962073470e-11 true resid norm 2.537712187769e-06 ||r(i)||/||b|| 2.685764028349e-08
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.626423438851e-06 
      0 KSP preconditioned resid norm 7.162226053898e-08 true resid norm 2.626423438851e-06 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.094114490484e-22 true resid norm 5.178780977332e-17 ||r(i)||/||b|| 1.971799710864e-11
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.626676019134e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
    0 SNES Function norm 9.448753356515e+01 
      0 KSP preconditioned resid norm 2.614583697436e-04 true resid norm 9.448753356515e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.281757288914e-11 true resid norm 2.914906640221e-05 ||r(i)||/||b|| 3.084964259557e-07
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.915317138429e-05 
      0 KSP preconditioned resid norm 8.009034597489e-09 true resid norm 2.915317138429e-05 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.424297252435e-20 true resid norm 3.283437574654e-14 ||r(i)||/||b|| 1.126271146069e-09
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.273764760818e-09 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
3 TS dt 1.89392e-06 time 0.100062
    0 SNES Function norm 9.448420198559e+01 
      0 KSP preconditioned resid norm 4.950065075557e-04 true resid norm 9.448420198559e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 9.957254999716e-12 true resid norm 4.671480815308e-06 ||r(i)||/||b|| 4.944192486296e-08
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.586494110169e-06 
      0 KSP preconditioned resid norm 2.869834662879e-08 true resid norm 4.586494110169e-06 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.638393548524e-21 true resid norm 1.345346182329e-15 ||r(i)||/||b|| 2.933277902497e-10
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 6.870452719991e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
4 TS dt 1.89392e-05 time 0.100064
    0 SNES Function norm 9.447789556025e+01 
      0 KSP preconditioned resid norm 4.946713243483e-03 true resid norm 9.447789556025e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.336781394036e-12 true resid norm 1.566413045865e-07 ||r(i)||/||b|| 1.657967756983e-09
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.167131003946e-06 
      0 KSP preconditioned resid norm 4.609216552367e-07 true resid norm 2.167131003946e-06 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.032900446192e-22 true resid norm 1.077636382835e-19 ||r(i)||/||b|| 4.972640698106e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 7.228995203392e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
5 TS dt 0.000189392 time 0.100082
    0 SNES Function norm 9.441492975737e+01 
      0 KSP preconditioned resid norm 4.916485042654e-02 true resid norm 9.441492975737e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 7.102215497961e-13 true resid norm 3.354787492100e-09 ||r(i)||/||b|| 3.553238349826e-11
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.132909828152e-04 
      0 KSP preconditioned resid norm 4.457085873508e-05 true resid norm 2.132909828152e-04 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 5.262954492816e-21 true resid norm 7.494475973218e-19 ||r(i)||/||b|| 3.513733151912e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 9.417796226665e-12 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
6 TS dt 0.000470304 time 0.100272
    0 SNES Function norm 9.379479121406e+01 
      0 KSP preconditioned resid norm 1.203930740553e-01 true resid norm 9.379479121406e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.730115663252e-14 true resid norm 3.303112014119e-11 ||r(i)||/||b|| 3.521636938858e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.274374966127e-03 
      0 KSP preconditioned resid norm 2.674315055104e-04 true resid norm 1.274374966127e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.990683235506e-20 true resid norm 1.859987379741e-17 ||r(i)||/||b|| 1.459529125399e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 5.979604035441e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
7 TS dt 0.000543268 time 0.100742
    0 SNES Function norm 9.231871046585e+01 
      0 KSP preconditioned resid norm 1.371331036236e-01 true resid norm 9.231871046585e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.414880100118e-13 true resid norm 4.022616350531e-10 ||r(i)||/||b|| 4.357314275982e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.644932065981e-03 
      0 KSP preconditioned resid norm 3.459339199337e-04 true resid norm 1.644932065981e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.060567287014e-20 true resid norm 2.269035642567e-18 ||r(i)||/||b|| 1.379409940078e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.495928558153e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
8 TS dt 0.000642798 time 0.101285
    0 SNES Function norm 9.070764347681e+01 
      0 KSP preconditioned resid norm 1.595391992596e-01 true resid norm 9.070764347681e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.169273498298e-13 true resid norm 1.651130548029e-10 ||r(i)||/||b|| 1.820277194667e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.222083595253e-03 
      0 KSP preconditioned resid norm 4.672059124694e-04 true resid norm 2.222083595253e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.066232714517e-19 true resid norm 3.464166293781e-17 ||r(i)||/||b|| 1.558972084210e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 3.184860737285e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
9 TS dt 0.000658539 time 0.101928
    0 SNES Function norm 8.891383101296e+01 
      0 KSP preconditioned resid norm 1.607234709312e-01 true resid norm 8.891383101296e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.373524345955e-14 true resid norm 1.153674595360e-10 ||r(i)||/||b|| 1.297519837147e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.254688159200e-03 
      0 KSP preconditioned resid norm 4.731246859854e-04 true resid norm 2.254688159200e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.641568792644e-19 true resid norm 2.979639026671e-17 ||r(i)||/||b|| 1.321530436266e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.953109347577e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
10 TS dt 0.000702176 time 0.102587
    0 SNES Function norm 8.718319934422e+01 
      0 KSP preconditioned resid norm 1.682512702165e-01 true resid norm 8.718319934422e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 6.270122458095e-14 true resid norm 8.105014079367e-11 ||r(i)||/||b|| 9.296532061603e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.477652837217e-03 
      0 KSP preconditioned resid norm 5.180321420845e-04 true resid norm 2.477652837217e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 5.865367075029e-20 true resid norm 1.097199972480e-17 ||r(i)||/||b|| 4.428384622730e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 3.629749949144e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
11 TS dt 0.000717437 time 0.103289
    0 SNES Function norm 8.543971302100e+01 
      0 KSP preconditioned resid norm 1.687013530854e-01 true resid norm 8.543971302100e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.995814874966e-13 true resid norm 2.527048874850e-10 ||r(i)||/||b|| 2.957698224278e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.502653637478e-03 
      0 KSP preconditioned resid norm 5.208120444490e-04 true resid norm 2.502653637478e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.893667677102e-19 true resid norm 1.443047106659e-17 ||r(i)||/||b|| 5.766068004971e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 8.161913663693e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
12 TS dt 0.000748038 time 0.104006
    0 SNES Function norm 8.375063723852e+01 
      0 KSP preconditioned resid norm 1.724051968235e-01 true resid norm 8.375063723852e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 5.354930086583e-14 true resid norm 6.514015645990e-11 ||r(i)||/||b|| 7.777869949142e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.631609341940e-03 
      0 KSP preconditioned resid norm 5.447112937552e-04 true resid norm 2.631609341940e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 7.098280889535e-20 true resid norm 1.972334648190e-17 ||r(i)||/||b|| 7.494785098825e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 6.145990072717e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
13 TS dt 0.000768527 time 0.104754
    0 SNES Function norm 8.207410973637e+01 
      0 KSP preconditioned resid norm 1.734749856068e-01 true resid norm 8.207410973637e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.635671538909e-14 true resid norm 1.020730806582e-10 ||r(i)||/||b|| 1.243669666185e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.686666220104e-03 
      0 KSP preconditioned resid norm 5.528722222494e-04 true resid norm 2.686666220104e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.310155204269e-19 true resid norm 4.830483216350e-17 ||r(i)||/||b|| 1.797946905427e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 6.801792135099e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
14 TS dt 0.000796547 time 0.105523
    0 SNES Function norm 8.042848982172e+01 
      0 KSP preconditioned resid norm 1.758892775036e-01 true resid norm 8.042848982172e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.858879945257e-14 true resid norm 5.545956074167e-11 ||r(i)||/||b|| 6.895511884483e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.789812422277e-03 
      0 KSP preconditioned resid norm 5.705277461147e-04 true resid norm 2.789812422277e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.913142296618e-19 true resid norm 3.998556107728e-18 ||r(i)||/||b|| 1.433270594037e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 4.297468971878e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
15 TS dt 0.000821178 time 0.10632
    0 SNES Function norm 7.879324106887e+01 
      0 KSP preconditioned resid norm 1.772055737326e-01 true resid norm 7.879324106887e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.000729750695e-13 true resid norm 1.107346109733e-10 ||r(i)||/||b|| 1.405382104748e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.864437597595e-03 
      0 KSP preconditioned resid norm 5.819802840658e-04 true resid norm 2.864437597595e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 6.570245323942e-20 true resid norm 9.116555987359e-18 ||r(i)||/||b|| 3.182668735745e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 8.304415356637e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
16 TS dt 0.000849708 time 0.107141
    0 SNES Function norm 7.717202202766e+01 
      0 KSP preconditioned resid norm 1.789783897696e-01 true resid norm 7.717202202766e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.916608907545e-14 true resid norm 2.042013501437e-11 ||r(i)||/||b|| 2.646054162874e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.960122998770e-03 
      0 KSP preconditioned resid norm 5.972781997712e-04 true resid norm 2.960122998770e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.215077830152e-20 true resid norm 3.599074567107e-18 ||r(i)||/||b|| 1.215853046851e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.564690943417e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
17 TS dt 0.000877541 time 0.10799
    0 SNES Function norm 7.555424443422e+01 
      0 KSP preconditioned resid norm 1.802089975312e-01 true resid norm 7.555424443422e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.811452014208e-14 true resid norm 1.880469120282e-11 ||r(i)||/||b|| 2.488899378670e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.044565370974e-03 
      0 KSP preconditioned resid norm 6.099484511065e-04 true resid norm 3.044565370974e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.386018977644e-19 true resid norm 2.881122259642e-17 ||r(i)||/||b|| 9.463164388289e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 8.739837085594e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
18 TS dt 0.000907727 time 0.108868
    0 SNES Function norm 7.393914980812e+01 
      0 KSP preconditioned resid norm 1.815000001057e-01 true resid norm 7.393914980812e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.784008470994e-13 true resid norm 1.788267374402e-10 ||r(i)||/||b|| 2.418566319795e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.137962421776e-03 
      0 KSP preconditioned resid norm 6.240826864483e-04 true resid norm 3.137962421776e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.032203146415e-20 true resid norm 5.530962097641e-18 ||r(i)||/||b|| 1.762596664402e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.127871129670e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
19 TS dt 0.000938355 time 0.109776
    0 SNES Function norm 7.232082451423e+01 
      0 KSP preconditioned resid norm 1.824396838374e-01 true resid norm 7.232082451423e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.933890699233e-15 true resid norm 8.580595300574e-12 ||r(i)||/||b|| 1.186462593341e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.226339091245e-03 
      0 KSP preconditioned resid norm 6.368425083840e-04 true resid norm 3.226339091245e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.871496403390e-20 true resid norm 2.538923370684e-17 ||r(i)||/||b|| 7.869363073378e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 3.272154252713e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
20 TS dt 0.000970716 time 0.110714
    0 SNES Function norm 7.069752274292e+01 
      0 KSP preconditioned resid norm 1.832538626878e-01 true resid norm 7.069752274292e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.110765712265e-14 true resid norm 1.039607282967e-11 ||r(i)||/||b|| 1.470500298501e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.317729064783e-03 
      0 KSP preconditioned resid norm 6.496875723688e-04 true resid norm 3.317729064783e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.175454028470e-19 true resid norm 3.471612084273e-18 ||r(i)||/||b|| 1.046382033157e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 7.922088979970e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
21 TS dt 0.00100403 time 0.111685
    0 SNES Function norm 6.906576770788e+01 
      0 KSP preconditioned resid norm 1.837669368174e-01 true resid norm 6.906576770788e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 5.220944148489e-14 true resid norm 4.739489134723e-11 ||r(i)||/||b|| 6.862284011335e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.405853725318e-03 
      0 KSP preconditioned resid norm 6.615462514101e-04 true resid norm 3.405853725318e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.472969378355e-19 true resid norm 2.674920574736e-18 ||r(i)||/||b|| 7.853891536361e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 6.478730795773e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
22 TS dt 0.00103887 time 0.112689
    0 SNES Function norm 6.742398683218e+01 
      0 KSP preconditioned resid norm 1.840565102966e-01 true resid norm 6.742398683218e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 5.129358524756e-14 true resid norm 4.495373798069e-11 ||r(i)||/||b|| 6.667321244675e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.493756411309e-03 
      0 KSP preconditioned resid norm 6.729142804055e-04 true resid norm 3.493756411309e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.250072100387e-19 true resid norm 2.474260037478e-18 ||r(i)||/||b|| 7.081947755343e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 4.809516791341e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
23 TS dt 0.00107493 time 0.113728
    0 SNES Function norm 6.577016205918e+01 
      0 KSP preconditioned resid norm 1.840430915784e-01 true resid norm 6.577016205918e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.692404099180e-14 true resid norm 2.271356589599e-11 ||r(i)||/||b|| 3.453475738064e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.578175999661e-03 
      0 KSP preconditioned resid norm 6.831979012321e-04 true resid norm 3.578175999661e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.643946865147e-19 true resid norm 1.506535397178e-17 ||r(i)||/||b|| 4.210344592667e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 6.664493188340e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
24 TS dt 0.00111249 time 0.114803
    0 SNES Function norm 6.410324565742e+01 
      0 KSP preconditioned resid norm 1.837479744571e-01 true resid norm 6.410324565742e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.024166583807e-14 true resid norm 3.289874249015e-11 ||r(i)||/||b|| 5.132149262140e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.660269437685e-03 
      0 KSP preconditioned resid norm 6.924908608255e-04 true resid norm 3.660269437685e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.102586703435e-19 true resid norm 5.776909107619e-17 ||r(i)||/||b|| 1.578274278976e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.189722567212e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
25 TS dt 0.00115146 time 0.115915
    0 SNES Function norm 6.242220974044e+01 
      0 KSP preconditioned resid norm 1.831321862998e-01 true resid norm 6.242220974044e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 5.784659764084e-14 true resid norm 4.567955909760e-11 ||r(i)||/||b|| 7.317837559345e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.737974402477e-03 
      0 KSP preconditioned resid norm 7.005633544762e-04 true resid norm 3.737974402477e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.135871084928e-19 true resid norm 2.205112955719e-17 ||r(i)||/||b|| 5.899218984106e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 3.500063882493e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
26 TS dt 0.00119202 time 0.117067
    0 SNES Function norm 6.072659080397e+01 
      0 KSP preconditioned resid norm 1.821977702436e-01 true resid norm 6.072659080397e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.649450945618e-15 true resid norm 6.484928032696e-12 ||r(i)||/||b|| 1.067889362278e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.811380158393e-03 
      0 KSP preconditioned resid norm 7.073032403448e-04 true resid norm 3.811380158393e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.611940683353e-19 true resid norm 7.622915736938e-18 ||r(i)||/||b|| 2.000040777919e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 6.615265306981e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
27 TS dt 0.00123419 time 0.118259
    0 SNES Function norm 5.901609663706e+01 
      0 KSP preconditioned resid norm 1.809247115736e-01 true resid norm 5.901609663706e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.104367388907e-13 true resid norm 8.124204151411e-11 ||r(i)||/||b|| 1.376608182234e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.879166712963e-03 
      0 KSP preconditioned resid norm 7.126046375357e-04 true resid norm 3.879166712963e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.987497893592e-19 true resid norm 1.148153465287e-17 ||r(i)||/||b|| 2.959794074976e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.085651432805e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
28 TS dt 0.00127811 time 0.119493
    0 SNES Function norm 5.729080957253e+01 
      0 KSP preconditioned resid norm 1.793104552447e-01 true resid norm 5.729080957253e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.392999707037e-15 true resid norm 1.411967987557e-12 ||r(i)||/||b|| 2.464562812241e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.941207272783e-03 
      0 KSP preconditioned resid norm 7.163891818081e-04 true resid norm 3.941207272783e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.703899868095e-19 true resid norm 5.177584205515e-17 ||r(i)||/||b|| 1.313705128190e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.064483083775e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
29 TS dt 0.00132387 time 0.120771
    0 SNES Function norm 5.555101902924e+01 
      0 KSP preconditioned resid norm 1.773454575890e-01 true resid norm 5.555101902924e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.972064780790e-14 true resid norm 6.146665917864e-11 ||r(i)||/||b|| 1.106490218411e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.996684389404e-03 
      0 KSP preconditioned resid norm 7.185434007291e-04 true resid norm 3.996684389404e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.465721333410e-19 true resid norm 1.631168355970e-17 ||r(i)||/||b|| 4.081303893534e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.283229430523e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
30 TS dt 0.00137162 time 0.122095
    0 SNES Function norm 5.379729340554e+01 
      0 KSP preconditioned resid norm 1.750283358023e-01 true resid norm 5.379729340554e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.811597060842e-14 true resid norm 1.825982097628e-11 ||r(i)||/||b|| 3.394189525229e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.045111296257e-03 
      0 KSP preconditioned resid norm 7.189930688439e-04 true resid norm 4.045111296257e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.311083818389e-19 true resid norm 9.181589259933e-19 ||r(i)||/||b|| 2.269798922079e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 9.408608380963e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
31 TS dt 0.00142151 time 0.123466
    0 SNES Function norm 5.203040668229e+01 
      0 KSP preconditioned resid norm 1.723565049165e-01 true resid norm 5.203040668229e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 9.938126289337e-14 true resid norm 6.328232306949e-11 ||r(i)||/||b|| 1.216256552748e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.085494349684e-03 
      0 KSP preconditioned resid norm 7.176026261847e-04 true resid norm 4.085494349684e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.638387173343e-19 true resid norm 1.710908942186e-18 ||r(i)||/||b|| 4.187764798447e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 4.153579340933e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
32 TS dt 0.00147373 time 0.124888
    0 SNES Function norm 5.025136211091e+01 
      0 KSP preconditioned resid norm 1.693317456694e-01 true resid norm 5.025136211091e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.106016005333e-15 true resid norm 4.915227000456e-12 ||r(i)||/||b|| 9.781281131459e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.117640472250e-03 
      0 KSP preconditioned resid norm 7.144394783544e-04 true resid norm 4.117640472250e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.530419793902e-19 true resid norm 1.326671827479e-17 ||r(i)||/||b|| 3.221922449083e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 9.263376730208e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
33 TS dt 0.00152845 time 0.126362
    0 SNES Function norm 4.846135996532e+01 
      0 KSP preconditioned resid norm 1.659569984577e-01 true resid norm 4.846135996532e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.436476651685e-14 true resid norm 4.980799829233e-11 ||r(i)||/||b|| 1.027787877352e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.140830713226e-03 
      0 KSP preconditioned resid norm 7.093467854890e-04 true resid norm 4.140830713226e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.501317005013e-19 true resid norm 7.071505221069e-19 ||r(i)||/||b|| 1.707750379286e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.148278019285e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
34 TS dt 0.0015859 time 0.12789
    0 SNES Function norm 4.666180524544e+01 
      0 KSP preconditioned resid norm 1.622382143288e-01 true resid norm 4.666180524544e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.667125473967e-14 true resid norm 9.402151340091e-12 ||r(i)||/||b|| 2.014956620438e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.154658034367e-03 
      0 KSP preconditioned resid norm 7.023795747495e-04 true resid norm 4.154658034367e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.938670869707e-19 true resid norm 6.966533905652e-17 ||r(i)||/||b|| 1.676800797569e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 6.216377104899e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
35 TS dt 0.00164633 time 0.129476
    0 SNES Function norm 4.485429437695e+01 
      0 KSP preconditioned resid norm 1.581834566910e-01 true resid norm 4.485429437695e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.964743204615e-14 true resid norm 2.162539833426e-11 ||r(i)||/||b|| 4.821254828472e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.158463601977e-03 
      0 KSP preconditioned resid norm 6.933805584414e-04 true resid norm 4.158463601977e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.318408894905e-19 true resid norm 1.764824811177e-17 ||r(i)||/||b|| 4.243934731900e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 5.456729815151e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
36 TS dt 0.00171001 time 0.131122
    0 SNES Function norm 4.304061849637e+01 
      0 KSP preconditioned resid norm 1.538034361741e-01 true resid norm 4.304061849637e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.376475633699e-15 true resid norm 2.261323269048e-12 ||r(i)||/||b|| 5.253928377537e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.151851542096e-03 
      0 KSP preconditioned resid norm 6.824445119600e-04 true resid norm 4.151851542096e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.425885470347e-19 true resid norm 6.765881539538e-18 ||r(i)||/||b|| 1.629605844751e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 4.907082171738e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
37 TS dt 0.00177725 time 0.132832
    0 SNES Function norm 4.122275891406e+01 
      0 KSP preconditioned resid norm 1.491114728610e-01 true resid norm 4.122275891406e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 9.879683010818e-14 true resid norm 4.953097338782e-11 ||r(i)||/||b|| 1.201544357841e-12
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.134246528095e-03 
      0 KSP preconditioned resid norm 6.695777997764e-04 true resid norm 4.134246528095e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.938654180469e-19 true resid norm 3.802548863157e-17 ||r(i)||/||b|| 9.197682908641e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 7.512192105957e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
38 TS dt 0.00184841 time 0.134609
    0 SNES Function norm 3.940288923310e+01 
      0 KSP preconditioned resid norm 1.441239669552e-01 true resid norm 3.940288923310e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.921749369609e-15 true resid norm 1.878506381996e-12 ||r(i)||/||b|| 4.767433095789e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.105386911109e-03 
      0 KSP preconditioned resid norm 6.547408316757e-04 true resid norm 4.105386911109e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.099997430517e-19 true resid norm 2.326129550499e-17 ||r(i)||/||b|| 5.666042204705e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 3.891555812789e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
39 TS dt 0.00192387 time 0.136458
    0 SNES Function norm 3.758337419822e+01 
      0 KSP preconditioned resid norm 1.388603566832e-01 true resid norm 3.758337419822e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.014704471424e-14 true resid norm 4.583873045369e-12 ||r(i)||/||b|| 1.219654473064e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.064868073942e-03 
      0 KSP preconditioned resid norm 6.379428735820e-04 true resid norm 4.064868073942e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.911677916926e-19 true resid norm 4.441807574955e-17 ||r(i)||/||b|| 1.092731054036e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 4.439258388149e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
40 TS dt 0.00200407 time 0.138382
    0 SNES Function norm 3.576677069546e+01 
      0 KSP preconditioned resid norm 1.333434778652e-01 true resid norm 3.576677069546e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.413357869609e-14 true resid norm 1.491936326800e-11 ||r(i)||/||b|| 4.171291670427e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.012090399066e-03 
      0 KSP preconditioned resid norm 6.192427197756e-04 true resid norm 4.012090399066e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.541488553138e-19 true resid norm 4.629529274763e-17 ||r(i)||/||b|| 1.153894557271e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.439774244093e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
41 TS dt 0.00208952 time 0.140386
    0 SNES Function norm 3.395582676376e+01 
      0 KSP preconditioned resid norm 1.275996978903e-01 true resid norm 3.395582676376e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.972608198890e-14 true resid norm 1.651953896466e-11 ||r(i)||/||b|| 4.865008612394e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.947285643748e-03 
      0 KSP preconditioned resid norm 5.988107592318e-04 true resid norm 3.947285643748e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.019377490130e-19 true resid norm 1.896150833255e-17 ||r(i)||/||b|| 4.803682845345e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 8.980558247126e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
42 TS dt 0.0021808 time 0.142475
    0 SNES Function norm 3.215348048566e+01 
      0 KSP preconditioned resid norm 1.216595009417e-01 true resid norm 3.215348048566e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.961934042537e-14 true resid norm 1.166803100820e-11 ||r(i)||/||b|| 3.628854740440e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.869587284369e-03 
      0 KSP preconditioned resid norm 5.765667069190e-04 true resid norm 3.869587284369e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.478861694077e-19 true resid norm 5.618495549418e-17 ||r(i)||/||b|| 1.451962479852e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 5.225800773743e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
43 TS dt 0.00227856 time 0.144656
    0 SNES Function norm 3.036285693864e+01 
      0 KSP preconditioned resid norm 1.155572657223e-01 true resid norm 3.036285693864e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 6.773601838534e-15 true resid norm 2.538341718583e-12 ||r(i)||/||b|| 8.360022654366e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.779178319861e-03 
      0 KSP preconditioned resid norm 5.526633444314e-04 true resid norm 3.779178319861e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.431212750593e-19 true resid norm 2.744847316321e-17 ||r(i)||/||b|| 7.263079653837e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 5.269116807128e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
44 TS dt 0.00238356 time 0.146935
    0 SNES Function norm 2.858726374370e+01 
      0 KSP preconditioned resid norm 1.093316282536e-01 true resid norm 2.858726374370e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.905253540379e-14 true resid norm 6.679589159154e-12 ||r(i)||/||b|| 2.336561210978e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.676067400328e-03 
      0 KSP preconditioned resid norm 5.272605141006e-04 true resid norm 3.676067400328e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.896877172859e-19 true resid norm 2.905273604835e-18 ||r(i)||/||b|| 7.903210927460e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.597158065852e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
45 TS dt 0.00249669 time 0.149318
    0 SNES Function norm 2.683018435110e+01 
      0 KSP preconditioned resid norm 1.030256040720e-01 true resid norm 2.683018435110e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.267508658200e-14 true resid norm 4.180982721886e-12 ||r(i)||/||b|| 1.558313080213e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.560322764375e-03 
      0 KSP preconditioned resid norm 5.004521328076e-04 true resid norm 3.560322764375e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.166343257656e-19 true resid norm 9.909003964766e-18 ||r(i)||/||b|| 2.783175745726e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 3.472525569279e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
46 TS dt 0.00261899 time 0.151815
    0 SNES Function norm 2.509526913408e+01 
      0 KSP preconditioned resid norm 9.668643676422e-02 true resid norm 2.509526913408e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.146288647649e-14 true resid norm 6.609305556959e-12 ||r(i)||/||b|| 2.633685863916e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.432214768438e-03 
      0 KSP preconditioned resid norm 4.723926942241e-04 true resid norm 3.432214768438e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.237223266951e-19 true resid norm 1.725890051207e-17 ||r(i)||/||b|| 5.028502490805e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.516272487751e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
47 TS dt 0.00275165 time 0.154434
    0 SNES Function norm 2.338632383021e+01 
      0 KSP preconditioned resid norm 9.036537337732e-02 true resid norm 2.338632383021e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.341333492884e-14 true resid norm 9.509239568656e-12 ||r(i)||/||b|| 4.066154064100e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.291769810485e-03 
      0 KSP preconditioned resid norm 4.432844230175e-04 true resid norm 3.291769810485e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.073759784149e-19 true resid norm 1.980471144303e-17 ||r(i)||/||b|| 6.016432673981e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 8.952431611147e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
48 TS dt 0.00289613 time 0.157186
    0 SNES Function norm 2.170729533126e+01 
      0 KSP preconditioned resid norm 8.411722708891e-02 true resid norm 2.170729533126e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.162495775354e-14 true resid norm 1.089668370292e-11 ||r(i)||/||b|| 5.019825610067e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.139851147417e-03 
      0 KSP preconditioned resid norm 4.133124605661e-04 true resid norm 3.139851147417e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.433212032625e-19 true resid norm 8.447065853874e-18 ||r(i)||/||b|| 2.690275894391e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.140224718289e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
49 TS dt 0.00305411 time 0.160082
    0 SNES Function norm 2.006225462307e+01 
      0 KSP preconditioned resid norm 7.799945416890e-02 true resid norm 2.006225462307e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.701286170172e-14 true resid norm 4.046252981304e-12 ||r(i)||/||b|| 2.016848583235e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.976962965743e-03 
      0 KSP preconditioned resid norm 3.827457235829e-04 true resid norm 2.976962965743e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 9.937590588351e-20 true resid norm 1.622244350506e-17 ||r(i)||/||b|| 5.449326609615e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.736153035227e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
50 TS dt 0.00322766 time 0.163136
    0 SNES Function norm 1.845537683280e+01 
      0 KSP preconditioned resid norm 7.207092681280e-02 true resid norm 1.845537683280e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.384624042607e-14 true resid norm 2.956604164574e-12 ||r(i)||/||b|| 1.602028607359e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.804276773421e-03 
      0 KSP preconditioned resid norm 3.517864257410e-04 true resid norm 2.804276773421e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.858297704886e-20 true resid norm 3.321537709925e-18 ||r(i)||/||b|| 1.184454309719e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 4.507890529838e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
51 TS dt 0.00341925 time 0.166363
    0 SNES Function norm 1.689091828562e+01 
      0 KSP preconditioned resid norm 6.638984442798e-02 true resid norm 1.689091828562e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.157676701455e-14 true resid norm 5.965462317149e-12 ||r(i)||/||b|| 3.531757253380e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.622595393251e-03 
      0 KSP preconditioned resid norm 3.207041377302e-04 true resid norm 2.622595393251e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.158566462061e-19 true resid norm 1.300688949561e-17 ||r(i)||/||b|| 4.959548670405e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 9.122703788973e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
52 TS dt 0.0036319 time 0.169783
    0 SNES Function norm 1.537319051967e+01 
      0 KSP preconditioned resid norm 6.101098059921e-02 true resid norm 1.537319051967e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.559892513249e-14 true resid norm 2.546643601844e-12 ||r(i)||/||b|| 1.656548521001e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.433493660026e-03 
      0 KSP preconditioned resid norm 2.897503342787e-04 true resid norm 2.433493660026e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.052507755130e-19 true resid norm 1.691019879489e-17 ||r(i)||/||b|| 6.948938915546e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 7.338712903651e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
53 TS dt 0.00386931 time 0.173415
    0 SNES Function norm 1.390653112094e+01 
      0 KSP preconditioned resid norm 5.598187570756e-02 true resid norm 1.390653112094e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 7.830661622063e-15 true resid norm 1.081743029539e-12 ||r(i)||/||b|| 7.778669030625e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.238300115941e-03 
      0 KSP preconditioned resid norm 2.592387164739e-04 true resid norm 2.238300115941e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.598332398216e-19 true resid norm 1.271999357011e-17 ||r(i)||/||b|| 5.682881164825e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 8.518721735734e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
54 TS dt 0.00413608 time 0.177284
    0 SNES Function norm 1.249527116146e+01 
      0 KSP preconditioned resid norm 5.133823523900e-02 true resid norm 1.249527116146e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.516687839476e-14 true resid norm 1.705228329645e-12 ||r(i)||/||b|| 1.364698938990e-13
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.039009524594e-03 
      0 KSP preconditioned resid norm 2.294361895217e-04 true resid norm 2.039009524594e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.336979964578e-19 true resid norm 2.684812172840e-17 ||r(i)||/||b|| 1.316723703571e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 5.222766661714e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
55 TS dt 0.00443797 time 0.18142
    0 SNES Function norm 1.114369887796e+01 
      0 KSP preconditioned resid norm 4.709866884497e-02 true resid norm 1.114369887796e+01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 5.419400969193e-16 true resid norm 4.237126420545e-14 ||r(i)||/||b|| 3.802262127638e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.837527167418e-03 
      0 KSP preconditioned resid norm 2.006226791308e-04 true resid norm 1.837527167418e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.276455077933e-20 true resid norm 7.361573122474e-18 ||r(i)||/||b|| 4.006239065744e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 7.160817239367e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
56 TS dt 0.00478225 time 0.185858
    0 SNES Function norm 9.856019247786e+00 
      0 KSP preconditioned resid norm 4.325975288364e-02 true resid norm 9.856019247786e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.374768273953e-14 true resid norm 8.762926950683e-13 ||r(i)||/||b|| 8.890939364441e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.636177258488e-03 
      0 KSP preconditioned resid norm 1.731037368735e-04 true resid norm 1.636177258488e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.171229523435e-20 true resid norm 1.241780574218e-18 ||r(i)||/||b|| 7.589523493105e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 3.792682661019e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
57 TS dt 0.00517824 time 0.19064
    0 SNES Function norm 8.636308870812e+00 
      0 KSP preconditioned resid norm 3.979273021195e-02 true resid norm 8.636308870812e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.861363656288e-15 true resid norm 3.642223275540e-13 ||r(i)||/||b|| 4.217337904449e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.437422283677e-03 
      0 KSP preconditioned resid norm 1.471231468375e-04 true resid norm 1.437422283677e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.267993245473e-20 true resid norm 1.667989907412e-17 ||r(i)||/||b|| 1.160403540666e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 7.188693069763e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
58 TS dt 0.00563801 time 0.195818
    0 SNES Function norm 7.488465594377e+00 
      0 KSP preconditioned resid norm 3.664329969779e-02 true resid norm 7.488465594377e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.674924374000e-15 true resid norm 7.806320331340e-14 ||r(i)||/||b|| 1.042445910041e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.244001212822e-03 
      0 KSP preconditioned resid norm 1.229480052855e-04 true resid norm 1.244001212822e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 7.166683435594e-20 true resid norm 1.947901126557e-18 ||r(i)||/||b|| 1.565835391862e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.995271673731e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
59 TS dt 0.00617738 time 0.201456
    0 SNES Function norm 6.416152382772e+00 
      0 KSP preconditioned resid norm 3.373572096240e-02 true resid norm 6.416152382772e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 7.237647103180e-15 true resid norm 3.376877578683e-14 ||r(i)||/||b|| 5.263088183115e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.058687426920e-03 
      0 KSP preconditioned resid norm 1.007867459623e-04 true resid norm 1.058687426920e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 7.957646690236e-20 true resid norm 9.797741821467e-18 ||r(i)||/||b|| 9.254612430762e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.114057033741e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
60 TS dt 0.00681743 time 0.207634
    0 SNES Function norm 5.422735240105e+00 
      0 KSP preconditioned resid norm 3.098121468871e-02 true resid norm 5.422735240105e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.039149956249e-15 true resid norm 3.469696715088e-14 ||r(i)||/||b|| 6.398425446677e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 8.841297823670e-04 
      0 KSP preconditioned resid norm 8.082490574174e-05 true resid norm 8.841297823670e-04 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.523898442649e-20 true resid norm 1.203075254732e-18 ||r(i)||/||b|| 1.360745083727e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.588771819762e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
61 TS dt 0.00758669 time 0.214451
    0 SNES Function norm 4.511215295964e+00 
      0 KSP preconditioned resid norm 2.828947721106e-02 true resid norm 4.511215295964e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.146461216638e-15 true resid norm 2.019847489533e-14 ||r(i)||/||b|| 4.477391028844e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 7.227818718433e-04 
      0 KSP preconditioned resid norm 6.319780499619e-05 true resid norm 7.227818718433e-04 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.544606931453e-20 true resid norm 6.172085956531e-18 ||r(i)||/||b|| 8.539348034269e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.693373617113e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
62 TS dt 0.00852442 time 0.222038
    0 SNES Function norm 3.684155065880e+00 
      0 KSP preconditioned resid norm 2.558122719191e-02 true resid norm 3.684155065880e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.421399607295e-15 true resid norm 3.542724819742e-14 ||r(i)||/||b|| 9.616112124465e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.765794619693e-04 
      0 KSP preconditioned resid norm 4.799275039593e-05 true resid norm 5.765794619693e-04 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.917210017870e-20 true resid norm 2.275114665599e-18 ||r(i)||/||b|| 3.945882251560e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 4.080956893516e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
63 TS dt 0.00968588 time 0.230562
    0 SNES Function norm 2.943597558153e+00 
      0 KSP preconditioned resid norm 2.279968946137e-02 true resid norm 2.943597558153e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.688891915436e-15 true resid norm 4.658056432078e-14 ||r(i)||/||b|| 1.582436572954e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.469347227783e-04 
      0 KSP preconditioned resid norm 3.522459990639e-05 true resid norm 4.469347227783e-04 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.913271436278e-20 true resid norm 1.788470624725e-18 ||r(i)||/||b|| 4.001637227037e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.327601328128e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
64 TS dt 0.0111507 time 0.240248
    0 SNES Function norm 2.290972258273e+00 
      0 KSP preconditioned resid norm 1.991943474887e-02 true resid norm 2.290972258273e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.041387078411e-16 true resid norm 4.490497948641e-15 ||r(i)||/||b|| 1.960083947951e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.344242266320e-04 
      0 KSP preconditioned resid norm 2.483429299262e-05 true resid norm 3.344242266320e-04 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.502871759649e-20 true resid norm 1.297541432592e-18 ||r(i)||/||b|| 3.879926540190e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 8.744519240953e-12 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
65 TS dt 0.0130373 time 0.251399
    0 SNES Function norm 1.726972038604e+00 
      0 KSP preconditioned resid norm 1.695158091906e-02 true resid norm 1.726972038604e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.975791012103e-16 true resid norm 1.111729584800e-14 ||r(i)||/||b|| 6.437449825178e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.392592155875e-04 
      0 KSP preconditioned resid norm 1.668555019510e-05 true resid norm 2.392592155875e-04 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 7.088396216954e-21 true resid norm 5.496514286129e-19 ||r(i)||/||b|| 2.297305151918e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 6.579404416439e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
66 TS dt 0.0155288 time 0.264436
    0 SNES Function norm 1.251369830009e+00 
      0 KSP preconditioned resid norm 1.394470950975e-02 true resid norm 1.251369830009e+00 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 4.815828028815e-16 true resid norm 1.213627164980e-14 ||r(i)||/||b|| 9.698389204178e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.613502496331e-04 
      0 KSP preconditioned resid norm 1.057030278717e-05 true resid norm 1.613502496331e-04 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 8.401765334436e-21 true resid norm 6.944496575239e-19 ||r(i)||/||b|| 4.303988739422e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.002960512866e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
67 TS dt 0.0189222 time 0.279965
    0 SNES Function norm 8.627296280253e-01 
      0 KSP preconditioned resid norm 1.098115744970e-02 true resid norm 8.627296280253e-01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.040524997250e-15 true resid norm 2.276783270205e-14 ||r(i)||/||b|| 2.639046111603e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.004787404905e-04 
      0 KSP preconditioned resid norm 6.217867528402e-06 true resid norm 1.004787404905e-04 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.769316671015e-21 true resid norm 8.855525476854e-20 ||r(i)||/||b|| 8.813332485679e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 3.760414731078e-12 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
68 TS dt 0.023731 time 0.298887
    0 SNES Function norm 5.579721026980e-01 
      0 KSP preconditioned resid norm 8.168954839547e-03 true resid norm 5.579721026980e-01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.093014577302e-16 true resid norm 3.691584819710e-15 ||r(i)||/||b|| 6.616074176218e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.612090762488e-05 
      0 KSP preconditioned resid norm 3.316790793448e-06 true resid norm 5.612090762488e-05 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.389783265668e-21 true resid norm 1.405828116276e-19 ||r(i)||/||b|| 2.504998895728e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.107601957670e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
69 TS dt 0.0309094 time 0.322618
    0 SNES Function norm 3.318078807622e-01 
      0 KSP preconditioned resid norm 5.630577405307e-03 true resid norm 3.318078807622e-01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 3.063267331490e-17 true resid norm 4.870469979815e-16 ||r(i)||/||b|| 1.467858439235e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.695020096883e-05 
      0 KSP preconditioned resid norm 1.546011182166e-06 true resid norm 2.695020096883e-05 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.793117635794e-21 true resid norm 1.357050217767e-19 ||r(i)||/||b|| 5.035399251146e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 9.864668651466e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
70 TS dt 0.0423973 time 0.353528
    0 SNES Function norm 1.761612327941e-01 
      0 KSP preconditioned resid norm 3.489583339177e-03 true resid norm 1.761612327941e-01 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.316658452387e-17 true resid norm 1.485569644921e-16 ||r(i)||/||b|| 8.433011175945e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.045148098580e-05 
      0 KSP preconditioned resid norm 5.929484721294e-07 true resid norm 1.045148098580e-05 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.828363770364e-21 true resid norm 7.752112884319e-20 ||r(i)||/||b|| 7.417238662014e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.326602314501e-13 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
71 TS dt 0.0625913 time 0.395925
    0 SNES Function norm 7.983581767239e-02 
      0 KSP preconditioned resid norm 1.852676934474e-03 true resid norm 7.983581767239e-02 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.090500314767e-17 true resid norm 2.310106089883e-16 ||r(i)||/||b|| 2.893571027684e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.964796049083e-06 
      0 KSP preconditioned resid norm 1.693900381352e-07 true resid norm 2.964796049083e-06 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 6.407935088581e-22 true resid norm 2.488733292029e-20 ||r(i)||/||b|| 8.394281599232e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.264007744504e-13 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
72 TS dt 0.102961 time 0.458516
    0 SNES Function norm 2.877453190320e-02 
      0 KSP preconditioned resid norm 7.782387666098e-04 true resid norm 2.877453190320e-02 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 9.420699403324e-18 true resid norm 6.243727619192e-17 ||r(i)||/||b|| 2.169879822961e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.249450920420e-07 
      0 KSP preconditioned resid norm 3.065901539711e-08 true resid norm 5.249450920420e-07 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 6.507185626458e-22 true resid norm 1.958685721627e-20 ||r(i)||/||b|| 3.731220181539e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.763153167418e-13 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
73 TS dt 0.199589 time 0.561477
    0 SNES Function norm 7.357133041852e-03 
      0 KSP preconditioned resid norm 2.272827711081e-04 true resid norm 7.357133041852e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.560769044703e-18 true resid norm 1.055220659460e-17 ||r(i)||/||b|| 1.434282421505e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.484151797034e-08 
      0 KSP preconditioned resid norm 2.698822392308e-09 true resid norm 4.484151797034e-08 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.024441048047e-23 true resid norm 2.694593621840e-22 ||r(i)||/||b|| 6.009148984702e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.410929782356e-13 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
74 TS dt 0.499313 time 0.761066
    0 SNES Function norm 1.108959982369e-03 
      0 KSP preconditioned resid norm 3.768770633683e-05 true resid norm 1.108959982369e-03 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.160988763768e-19 true resid norm 1.513119898651e-18 ||r(i)||/||b|| 1.364449504677e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.231447237523e-09 
      0 KSP preconditioned resid norm 7.687789000002e-11 true resid norm 1.231447237523e-09 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.618392523208e-25 true resid norm 6.085315417000e-24 ||r(i)||/||b|| 4.941596547199e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.013971887346e-13 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
75 TS dt 1.86355 time 1.26038
    0 SNES Function norm 7.351115437016e-05 
      0 KSP preconditioned resid norm 2.626294379687e-06 true resid norm 7.351115437016e-05 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 6.595461681967e-20 true resid norm 4.399208838926e-19 ||r(i)||/||b|| 5.984409953317e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.250183361938e-12 
      0 KSP preconditioned resid norm 3.428226842422e-13 true resid norm 5.250183361938e-12 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.851316643091e-27 true resid norm 6.153997546811e-26 ||r(i)||/||b|| 1.172149070340e-14
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.260177193847e-13 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
76 TS dt 12.9794 time 3.12393
    0 SNES Function norm 1.372480987605e-06 
      0 KSP preconditioned resid norm 4.983377937858e-08 true resid norm 1.372480987605e-06 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 1.459814669632e-22 true resid norm 5.715488068778e-22 ||r(i)||/||b|| 4.164347718035e-16
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.071720032080e-13 
  Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 1
77 TS dt 129.794 time 16.1033
    0 SNES Function norm 3.738924773290e-09 
      0 KSP preconditioned resid norm 1.360931234224e-10 true resid norm 3.738924773290e-09 ||r(i)||/||b|| 1.000000000000e+00
      1 KSP preconditioned resid norm 2.483867357913e-24 true resid norm 1.443180452160e-23 ||r(i)||/||b|| 3.859880954197e-15
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.423043453910e-13 
  Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 1
78 TS dt 1297.94 time 145.897

Post-processing ... Done!

Checking results ... 
	Pressure eigenvalue = -100.375, -13.6622(kg/m^3/s^2)
	Estimated strain-rate = 20.0375, 6.67916(s^-1)

Steady-state profile:

Axial velocity:
Vec Object: 1 MPI processes
  type: seq
5.
4.94981
4.79925
4.54831
4.197
3.74531
3.19325
2.54082
1.78811
0.936514
-6.10577e-17
-0.936514
-1.78811
-2.54082
-3.19325
-3.74531
-4.197
-4.54831
-4.79925
-4.94981
-5.

Spread rate:
Vec Object: 1 MPI processes
  type: seq
3.61321e-25
1.00375
2.0075
3.01125
4.015
5.01875
6.0225
7.02613
8.0279
9.00411
9.72618
9.00411
8.0279
7.02613
6.0225
5.01875
4.015
3.01125
2.0075
1.00375
0.


More information about the petsc-users mailing list