[petsc-users] BoomerAMG Hypre options

sthavishtha bhopalam sthavishthabr at gmail.com
Sun Apr 11 12:36:52 CDT 2021


Hello PETSc users

I am trying to experiment with Hypre's BoomerAMG preconditioner which
continually yields the error message "Linear solve did not converge due to
DIVERGED_DTOL iterations 1". I would appreciate if someone can suggest some
ways I could get BoomerAMG to yield converged results - the attached output
shows a snippet of the error message. *Command Line options I used for
BoomerAMG* : *-pc_type hypre -pc_hypre_type boomeramg -pchypreboomeramgtol
1.0e-3 -pchypreboomeramgstrongthreshold 0.25 -ksp_type richardson
-pc_hypre_boomeramg_max_iter 6 -snes_rtol 1.0e-3 -ksp_rtol 1.0e-3 -ksp_view
-snes_view -ksp_monitor -snes_monitor -ksp_max_it 100 -ksp_converged_reason
-snes_converged_reason*

I also tried using *-ksp_type gmres*, different values of
*-pc_hypre_boomeramg_max_iter*, *-pchypreboomeramgstrongthreshold*,
*-ksp_initial_guess_nonzero* but all yielded the same error message.

However, the direct solver converges as required - the attached output
shows a snippet of the norms from the SNES and KSP.
*Command Line options I used for the direct solver* : *-ksp_type gmres
-pc_type lu -pc_factor_shift_type nonzero -pc_factor_mat_solver_type mumps
-snes_converged_reason -ksp_converged_reason -ksp_rtol 1e-3 -snes_rtol 1e-3
-ksp_monitor -snes_monitor*

There is no particular reason for using the AMG here, but I just wanted to
familiarize with it's options to see which of them need to be particularly
tuned to yield converged and correct results.

Thanks
-------------------------------------------
Regards

Sthavishtha
-------------- next part --------------
An HTML attachment was scrubbed...
URL: <http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20210411/f6d78209/attachment-0001.html>
-------------- next part --------------
Partition - MPI: processors=[4,6,1] total=24
Partition - nnp: sum=65536 min=2688 max=2752 max/min=1.02381
Partition - nel: sum=65536 min=2688 max=2752 max/min=1.02381
0.000000e+00 1.000000e-02 -2.7004615480427790e-01
    0 SNES Function norm 6.145506780035e-04 
      0 KSP Residual norm 2.013603254316e+41 
      1 KSP Residual norm 8.120156893817e+87 
    Linear solve did not converge due to DIVERGED_DTOL iterations 1
KSP Object: 24 MPI processes
  type: richardson
    damping factor=1.
  maximum iterations=100, initial guess is zero
  tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 24 MPI processes
  type: hypre
    HYPRE BoomerAMG preconditioning
      Cycle type V
      Maximum number of levels 25
      Maximum number of iterations PER hypre call 6
      Convergence tolerance PER hypre call 0.
      Threshold for strong coupling 0.25
      Interpolation truncation factor 0.
      Interpolation: max elements per row 0
      Number of levels of aggressive coarsening 0
      Number of paths for aggressive coarsening 1
      Maximum row sums 0.9
      Sweeps down         1
      Sweeps up           1
      Sweeps on coarse    1
      Relax down          symmetric-SOR/Jacobi
      Relax up            symmetric-SOR/Jacobi
      Relax on coarse     Gaussian-elimination
      Relax weight  (all)      1.
      Outer relax weight (all) 1.
      Using CF-relaxation
      Not using more complex smoothers.
      Measure type        local
      Coarsen type        Falgout
      Interpolation type  classical
  linear system matrix = precond matrix:
  Mat Object: 24 MPI processes
    type: mpibaij
    rows=196608, cols=196608, bs=3
    total: nonzeros=14745600, allocated nonzeros=14745600
    total number of mallocs used during MatSetValues calls=0
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
SNES Object: 24 MPI processes
  type: newtonls
  maximum iterations=50, maximum function evaluations=10000
  tolerances: relative=0.001, absolute=1e-50, solution=1e-08
  total number of linear solver iterations=1
  total number of function evaluations=1
  norm schedule ALWAYS
  SNESLineSearch Object: 24 MPI processes
    type: bt
      interpolation: cubic
      alpha=1.000000e-04
    maxstep=1.000000e+08, minlambda=1.000000e-12
    tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08
    maximum iterations=40
  KSP Object: 24 MPI processes
    type: richardson
      damping factor=1.
    maximum iterations=100, initial guess is zero
    tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
    left preconditioning
    using PRECONDITIONED norm type for convergence test
  PC Object: 24 MPI processes
    type: hypre
      HYPRE BoomerAMG preconditioning
        Cycle type V
        Maximum number of levels 25
        Maximum number of iterations PER hypre call 6
        Convergence tolerance PER hypre call 0.
        Threshold for strong coupling 0.25
        Interpolation truncation factor 0.
        Interpolation: max elements per row 0
        Number of levels of aggressive coarsening 0
        Number of paths for aggressive coarsening 1
        Maximum row sums 0.9
        Sweeps down         1
        Sweeps up           1
        Sweeps on coarse    1
        Relax down          symmetric-SOR/Jacobi
        Relax up            symmetric-SOR/Jacobi
        Relax on coarse     Gaussian-elimination
        Relax weight  (all)      1.
        Outer relax weight (all) 1.
        Using CF-relaxation
        Not using more complex smoothers.
        Measure type        local
        Coarsen type        Falgout
        Interpolation type  classical
    linear system matrix = precond matrix:
    Mat Object: 24 MPI processes
      type: mpibaij
      rows=196608, cols=196608, bs=3
      total: nonzeros=14745600, allocated nonzeros=14745600
      total number of mallocs used during MatSetValues calls=0
    0 SNES Function norm 6.145506780035e-04 
      0 KSP Residual norm 2.013603254315e+41 
      1 KSP Residual norm 8.120156893816e+87 
    Linear solve did not converge due to DIVERGED_DTOL iterations 1
KSP Object: 24 MPI processes
  type: richardson
    damping factor=1.
  maximum iterations=100, initial guess is zero
  tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 24 MPI processes
  type: hypre
    HYPRE BoomerAMG preconditioning
      Cycle type V
      Maximum number of levels 25
      Maximum number of iterations PER hypre call 6
      Convergence tolerance PER hypre call 0.
      Threshold for strong coupling 0.25
      Interpolation truncation factor 0.
      Interpolation: max elements per row 0
      Number of levels of aggressive coarsening 0
      Number of paths for aggressive coarsening 1
      Maximum row sums 0.9
      Sweeps down         1
      Sweeps up           1
      Sweeps on coarse    1
      Relax down          symmetric-SOR/Jacobi
      Relax up            symmetric-SOR/Jacobi
      Relax on coarse     Gaussian-elimination
      Relax weight  (all)      1.
      Outer relax weight (all) 1.
      Using CF-relaxation
      Not using more complex smoothers.
      Measure type        local
      Coarsen type        Falgout
      Interpolation type  classical
  linear system matrix = precond matrix:
  Mat Object: 24 MPI processes
    type: mpibaij
    rows=196608, cols=196608, bs=3
    total: nonzeros=14745600, allocated nonzeros=14745600
    total number of mallocs used during MatSetValues calls=0
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
SNES Object: 24 MPI processes
  type: newtonls
  maximum iterations=50, maximum function evaluations=10000
  tolerances: relative=0.001, absolute=1e-50, solution=1e-08
  total number of linear solver iterations=1
  total number of function evaluations=1
  norm schedule ALWAYS
  SNESLineSearch Object: 24 MPI processes
    type: bt
      interpolation: cubic
      alpha=1.000000e-04
    maxstep=1.000000e+08, minlambda=1.000000e-12
    tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08
    maximum iterations=40
  KSP Object: 24 MPI processes
    type: richardson
      damping factor=1.
    maximum iterations=100, initial guess is zero
    tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
    left preconditioning
    using PRECONDITIONED norm type for convergence test
  PC Object: 24 MPI processes
    type: hypre
      HYPRE BoomerAMG preconditioning
        Cycle type V
        Maximum number of levels 25
        Maximum number of iterations PER hypre call 6
        Convergence tolerance PER hypre call 0.
        Threshold for strong coupling 0.25
        Interpolation truncation factor 0.
        Interpolation: max elements per row 0
        Number of levels of aggressive coarsening 0
        Number of paths for aggressive coarsening 1
        Maximum row sums 0.9
        Sweeps down         1
        Sweeps up           1
        Sweeps on coarse    1
        Relax down          symmetric-SOR/Jacobi
        Relax up            symmetric-SOR/Jacobi
        Relax on coarse     Gaussian-elimination
        Relax weight  (all)      1.
        Outer relax weight (all) 1.
        Using CF-relaxation
        Not using more complex smoothers.
        Measure type        local
        Coarsen type        Falgout
        Interpolation type  classical
    linear system matrix = precond matrix:
    Mat Object: 24 MPI processes
      type: mpibaij
      rows=196608, cols=196608, bs=3
      total: nonzeros=14745600, allocated nonzeros=14745600
      total number of mallocs used during MatSetValues calls=0
    0 SNES Function norm 6.145506780035e-04 
      0 KSP Residual norm 2.013603254316e+41 
      1 KSP Residual norm 8.120156893817e+87 
    Linear solve did not converge due to DIVERGED_DTOL iterations 1
KSP Object: 24 MPI processes
  type: richardson
    damping factor=1.
  maximum iterations=100, initial guess is zero
  tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 24 MPI processes
  type: hypre
    HYPRE BoomerAMG preconditioning
      Cycle type V
      Maximum number of levels 25
      Maximum number of iterations PER hypre call 6
      Convergence tolerance PER hypre call 0.
      Threshold for strong coupling 0.25
      Interpolation truncation factor 0.
      Interpolation: max elements per row 0
      Number of levels of aggressive coarsening 0
      Number of paths for aggressive coarsening 1
      Maximum row sums 0.9
      Sweeps down         1
      Sweeps up           1
      Sweeps on coarse    1
      Relax down          symmetric-SOR/Jacobi
      Relax up            symmetric-SOR/Jacobi
      Relax on coarse     Gaussian-elimination
      Relax weight  (all)      1.
      Outer relax weight (all) 1.
      Using CF-relaxation
      Not using more complex smoothers.
      Measure type        local
      Coarsen type        Falgout
      Interpolation type  classical
  linear system matrix = precond matrix:
  Mat Object: 24 MPI processes
    type: mpibaij
    rows=196608, cols=196608, bs=3
    total: nonzeros=14745600, allocated nonzeros=14745600
    total number of mallocs used during MatSetValues calls=0
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
SNES Object: 24 MPI processes
  type: newtonls
  maximum iterations=50, maximum function evaluations=10000
  tolerances: relative=0.001, absolute=1e-50, solution=1e-08
  total number of linear solver iterations=1
  total number of function evaluations=1
  norm schedule ALWAYS
  SNESLineSearch Object: 24 MPI processes
    type: bt
      interpolation: cubic
      alpha=1.000000e-04
    maxstep=1.000000e+08, minlambda=1.000000e-12
    tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08
    maximum iterations=40
  KSP Object: 24 MPI processes
    type: richardson
      damping factor=1.
    maximum iterations=100, initial guess is zero
    tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
    left preconditioning
    using PRECONDITIONED norm type for convergence test
  PC Object: 24 MPI processes
    type: hypre
      HYPRE BoomerAMG preconditioning
        Cycle type V
        Maximum number of levels 25
        Maximum number of iterations PER hypre call 6
        Convergence tolerance PER hypre call 0.
        Threshold for strong coupling 0.25
        Interpolation truncation factor 0.
        Interpolation: max elements per row 0
        Number of levels of aggressive coarsening 0
        Number of paths for aggressive coarsening 1
        Maximum row sums 0.9
        Sweeps down         1
        Sweeps up           1
        Sweeps on coarse    1
        Relax down          symmetric-SOR/Jacobi
        Relax up            symmetric-SOR/Jacobi
        Relax on coarse     Gaussian-elimination
        Relax weight  (all)      1.
        Outer relax weight (all) 1.
        Using CF-relaxation
        Not using more complex smoothers.
        Measure type        local
        Coarsen type        Falgout
        Interpolation type  classical
    linear system matrix = precond matrix:
    Mat Object: 24 MPI processes
      type: mpibaij
      rows=196608, cols=196608, bs=3
      total: nonzeros=14745600, allocated nonzeros=14745600
      total number of mallocs used during MatSetValues calls=0
    0 SNES Function norm 6.145506780035e-04 
      0 KSP Residual norm 2.013603254316e+41 
      1 KSP Residual norm 8.120156893817e+87 
    Linear solve did not converge due to DIVERGED_DTOL iterations 1
KSP Object: 24 MPI processes
  type: richardson
    damping factor=1.
  maximum iterations=100, initial guess is zero
  tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 24 MPI processes
  type: hypre
    HYPRE BoomerAMG preconditioning
      Cycle type V
      Maximum number of levels 25
      Maximum number of iterations PER hypre call 6
      Convergence tolerance PER hypre call 0.
      Threshold for strong coupling 0.25
      Interpolation truncation factor 0.
      Interpolation: max elements per row 0
      Number of levels of aggressive coarsening 0
      Number of paths for aggressive coarsening 1
      Maximum row sums 0.9
      Sweeps down         1
      Sweeps up           1
      Sweeps on coarse    1
      Relax down          symmetric-SOR/Jacobi
      Relax up            symmetric-SOR/Jacobi
      Relax on coarse     Gaussian-elimination
      Relax weight  (all)      1.
      Outer relax weight (all) 1.
      Using CF-relaxation
      Not using more complex smoothers.
      Measure type        local
      Coarsen type        Falgout
      Interpolation type  classical
  linear system matrix = precond matrix:
  Mat Object: 24 MPI processes
    type: mpibaij
    rows=196608, cols=196608, bs=3
    total: nonzeros=14745600, allocated nonzeros=14745600
    total number of mallocs used during MatSetValues calls=0
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
SNES Object: 24 MPI processes
  type: newtonls
  maximum iterations=50, maximum function evaluations=10000
  tolerances: relative=0.001, absolute=1e-50, solution=1e-08
  total number of linear solver iterations=1
  total number of function evaluations=1
  norm schedule ALWAYS
  SNESLineSearch Object: 24 MPI processes
    type: bt
      interpolation: cubic
      alpha=1.000000e-04
    maxstep=1.000000e+08, minlambda=1.000000e-12
    tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08
    maximum iterations=40
  KSP Object: 24 MPI processes
    type: richardson
      damping factor=1.
    maximum iterations=100, initial guess is zero
    tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
    left preconditioning
    using PRECONDITIONED norm type for convergence test
  PC Object: 24 MPI processes
    type: hypre
      HYPRE BoomerAMG preconditioning
        Cycle type V
        Maximum number of levels 25
        Maximum number of iterations PER hypre call 6
        Convergence tolerance PER hypre call 0.
        Threshold for strong coupling 0.25
        Interpolation truncation factor 0.
        Interpolation: max elements per row 0
        Number of levels of aggressive coarsening 0
        Number of paths for aggressive coarsening 1
        Maximum row sums 0.9
        Sweeps down         1
        Sweeps up           1
        Sweeps on coarse    1
        Relax down          symmetric-SOR/Jacobi
        Relax up            symmetric-SOR/Jacobi
        Relax on coarse     Gaussian-elimination
        Relax weight  (all)      1.
        Outer relax weight (all) 1.
        Using CF-relaxation
        Not using more complex smoothers.
        Measure type        local
        Coarsen type        Falgout
        Interpolation type  classical
    linear system matrix = precond matrix:
    Mat Object: 24 MPI processes
      type: mpibaij
      rows=196608, cols=196608, bs=3
      total: nonzeros=14745600, allocated nonzeros=14745600
      total number of mallocs used during MatSetValues calls=0
    0 SNES Function norm 6.145506780035e-04 
      0 KSP Residual norm 2.013603254316e+41 
      1 KSP Residual norm 8.120156893817e+87 
    Linear solve did not converge due to DIVERGED_DTOL iterations 1
KSP Object: 24 MPI processes
  type: richardson
    damping factor=1.
  maximum iterations=100, initial guess is zero
  tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 24 MPI processes
  type: hypre
    HYPRE BoomerAMG preconditioning
      Cycle type V
      Maximum number of levels 25
      Maximum number of iterations PER hypre call 6
      Convergence tolerance PER hypre call 0.
      Threshold for strong coupling 0.25
      Interpolation truncation factor 0.
      Interpolation: max elements per row 0
      Number of levels of aggressive coarsening 0
      Number of paths for aggressive coarsening 1
      Maximum row sums 0.9
      Sweeps down         1
      Sweeps up           1
      Sweeps on coarse    1
      Relax down          symmetric-SOR/Jacobi
      Relax up            symmetric-SOR/Jacobi
      Relax on coarse     Gaussian-elimination
      Relax weight  (all)      1.
      Outer relax weight (all) 1.
      Using CF-relaxation
      Not using more complex smoothers.
      Measure type        local
      Coarsen type        Falgout
      Interpolation type  classical
  linear system matrix = precond matrix:
  Mat Object: 24 MPI processes
    type: mpibaij
    rows=196608, cols=196608, bs=3
    total: nonzeros=14745600, allocated nonzeros=14745600
    total number of mallocs used during MatSetValues calls=0
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
SNES Object: 24 MPI processes
  type: newtonls
  maximum iterations=50, maximum function evaluations=10000
  tolerances: relative=0.001, absolute=1e-50, solution=1e-08
  total number of linear solver iterations=1
  total number of function evaluations=1
  norm schedule ALWAYS
  SNESLineSearch Object: 24 MPI processes
    type: bt
      interpolation: cubic
      alpha=1.000000e-04
    maxstep=1.000000e+08, minlambda=1.000000e-12
    tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08
    maximum iterations=40
  KSP Object: 24 MPI processes
    type: richardson
      damping factor=1.
    maximum iterations=100, initial guess is zero
    tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
    left preconditioning
    using PRECONDITIONED norm type for convergence test
  PC Object: 24 MPI processes
    type: hypre
      HYPRE BoomerAMG preconditioning
        Cycle type V
        Maximum number of levels 25
        Maximum number of iterations PER hypre call 6
        Convergence tolerance PER hypre call 0.
        Threshold for strong coupling 0.25
        Interpolation truncation factor 0.
        Interpolation: max elements per row 0
        Number of levels of aggressive coarsening 0
        Number of paths for aggressive coarsening 1
        Maximum row sums 0.9
        Sweeps down         1
        Sweeps up           1
        Sweeps on coarse    1
        Relax down          symmetric-SOR/Jacobi
        Relax up            symmetric-SOR/Jacobi
        Relax on coarse     Gaussian-elimination
        Relax weight  (all)      1.
        Outer relax weight (all) 1.
        Using CF-relaxation
        Not using more complex smoothers.
        Measure type        local
        Coarsen type        Falgout
        Interpolation type  classical
    linear system matrix = precond matrix:
    Mat Object: 24 MPI processes
      type: mpibaij
      rows=196608, cols=196608, bs=3
      total: nonzeros=14745600, allocated nonzeros=14745600
      total number of mallocs used during MatSetValues calls=0
    0 SNES Function norm 6.145506780035e-04 
      0 KSP Residual norm 2.013603254316e+41 
      1 KSP Residual norm 8.120156893817e+87 
    Linear solve did not converge due to DIVERGED_DTOL iterations 1
KSP Object: 24 MPI processes
  type: richardson
    damping factor=1.
  maximum iterations=100, initial guess is zero
  tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 24 MPI processes
  type: hypre
    HYPRE BoomerAMG preconditioning
      Cycle type V
      Maximum number of levels 25
      Maximum number of iterations PER hypre call 6
      Convergence tolerance PER hypre call 0.
      Threshold for strong coupling 0.25
      Interpolation truncation factor 0.
      Interpolation: max elements per row 0
      Number of levels of aggressive coarsening 0
      Number of paths for aggressive coarsening 1
      Maximum row sums 0.9
      Sweeps down         1
      Sweeps up           1
      Sweeps on coarse    1
      Relax down          symmetric-SOR/Jacobi
      Relax up            symmetric-SOR/Jacobi
      Relax on coarse     Gaussian-elimination
      Relax weight  (all)      1.
      Outer relax weight (all) 1.
      Using CF-relaxation
      Not using more complex smoothers.
      Measure type        local
      Coarsen type        Falgout
      Interpolation type  classical
  linear system matrix = precond matrix:
  Mat Object: 24 MPI processes
    type: mpibaij
    rows=196608, cols=196608, bs=3
    total: nonzeros=14745600, allocated nonzeros=14745600
    total number of mallocs used during MatSetValues calls=0
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
SNES Object: 24 MPI processes
  type: newtonls
  maximum iterations=50, maximum function evaluations=10000
  tolerances: relative=0.001, absolute=1e-50, solution=1e-08
  total number of linear solver iterations=1
  total number of function evaluations=1
  norm schedule ALWAYS
  SNESLineSearch Object: 24 MPI processes
    type: bt
      interpolation: cubic
      alpha=1.000000e-04
    maxstep=1.000000e+08, minlambda=1.000000e-12
    tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08
    maximum iterations=40
  KSP Object: 24 MPI processes
    type: richardson
      damping factor=1.
    maximum iterations=100, initial guess is zero
    tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
    left preconditioning
    using PRECONDITIONED norm type for convergence test
  PC Object: 24 MPI processes
    type: hypre
      HYPRE BoomerAMG preconditioning
        Cycle type V
        Maximum number of levels 25
        Maximum number of iterations PER hypre call 6
        Convergence tolerance PER hypre call 0.
        Threshold for strong coupling 0.25
        Interpolation truncation factor 0.
        Interpolation: max elements per row 0
        Number of levels of aggressive coarsening 0
        Number of paths for aggressive coarsening 1
        Maximum row sums 0.9
        Sweeps down         1
        Sweeps up           1
        Sweeps on coarse    1
        Relax down          symmetric-SOR/Jacobi
        Relax up            symmetric-SOR/Jacobi
        Relax on coarse     Gaussian-elimination
        Relax weight  (all)      1.
        Outer relax weight (all) 1.
        Using CF-relaxation
        Not using more complex smoothers.
        Measure type        local
        Coarsen type        Falgout
        Interpolation type  classical
    linear system matrix = precond matrix:
    Mat Object: 24 MPI processes
      type: mpibaij
      rows=196608, cols=196608, bs=3
      total: nonzeros=14745600, allocated nonzeros=14745600
      total number of mallocs used during MatSetValues calls=0
    0 SNES Function norm 6.145506780035e-04 
      0 KSP Residual norm 2.013603254316e+41 
      1 KSP Residual norm 8.120156893817e+87 
    Linear solve did not converge due to DIVERGED_DTOL iterations 1
KSP Object: 24 MPI processes
  type: richardson
    damping factor=1.
  maximum iterations=100, initial guess is zero
  tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 24 MPI processes
  type: hypre
    HYPRE BoomerAMG preconditioning
      Cycle type V
      Maximum number of levels 25
      Maximum number of iterations PER hypre call 6
      Convergence tolerance PER hypre call 0.
      Threshold for strong coupling 0.25
      Interpolation truncation factor 0.
      Interpolation: max elements per row 0
      Number of levels of aggressive coarsening 0
      Number of paths for aggressive coarsening 1
      Maximum row sums 0.9
      Sweeps down         1
      Sweeps up           1
      Sweeps on coarse    1
      Relax down          symmetric-SOR/Jacobi
      Relax up            symmetric-SOR/Jacobi
      Relax on coarse     Gaussian-elimination
      Relax weight  (all)      1.
      Outer relax weight (all) 1.
      Using CF-relaxation
      Not using more complex smoothers.
      Measure type        local
      Coarsen type        Falgout
      Interpolation type  classical
  linear system matrix = precond matrix:
  Mat Object: 24 MPI processes
    type: mpibaij
    rows=196608, cols=196608, bs=3
    total: nonzeros=14745600, allocated nonzeros=14745600
    total number of mallocs used during MatSetValues calls=0
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
SNES Object: 24 MPI processes
  type: newtonls
  maximum iterations=50, maximum function evaluations=10000
  tolerances: relative=0.001, absolute=1e-50, solution=1e-08
  total number of linear solver iterations=1
  total number of function evaluations=1
  norm schedule ALWAYS
  SNESLineSearch Object: 24 MPI processes
    type: bt
      interpolation: cubic
      alpha=1.000000e-04
    maxstep=1.000000e+08, minlambda=1.000000e-12
    tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08
    maximum iterations=40
  KSP Object: 24 MPI processes
    type: richardson
      damping factor=1.
    maximum iterations=100, initial guess is zero
    tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
    left preconditioning
    using PRECONDITIONED norm type for convergence test
  PC Object: 24 MPI processes
    type: hypre
      HYPRE BoomerAMG preconditioning
        Cycle type V
        Maximum number of levels 25
        Maximum number of iterations PER hypre call 6
        Convergence tolerance PER hypre call 0.
        Threshold for strong coupling 0.25
        Interpolation truncation factor 0.
        Interpolation: max elements per row 0
        Number of levels of aggressive coarsening 0
        Number of paths for aggressive coarsening 1
        Maximum row sums 0.9
        Sweeps down         1
        Sweeps up           1
        Sweeps on coarse    1
        Relax down          symmetric-SOR/Jacobi
        Relax up            symmetric-SOR/Jacobi
        Relax on coarse     Gaussian-elimination
        Relax weight  (all)      1.
        Outer relax weight (all) 1.
        Using CF-relaxation
        Not using more complex smoothers.
        Measure type        local
        Coarsen type        Falgout
        Interpolation type  classical
    linear system matrix = precond matrix:
    Mat Object: 24 MPI processes
      type: mpibaij
      rows=196608, cols=196608, bs=3
      total: nonzeros=14745600, allocated nonzeros=14745600
      total number of mallocs used during MatSetValues calls=0
    0 SNES Function norm 6.145506780035e-04 
      0 KSP Residual norm 2.013603254316e+41 
      1 KSP Residual norm 8.120156893817e+87 
    Linear solve did not converge due to DIVERGED_DTOL iterations 1
KSP Object: 24 MPI processes
  type: richardson
    damping factor=1.
  maximum iterations=100, initial guess is zero
  tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 24 MPI processes
  type: hypre
    HYPRE BoomerAMG preconditioning
      Cycle type V
      Maximum number of levels 25
      Maximum number of iterations PER hypre call 6
      Convergence tolerance PER hypre call 0.
      Threshold for strong coupling 0.25
      Interpolation truncation factor 0.
      Interpolation: max elements per row 0
      Number of levels of aggressive coarsening 0
      Number of paths for aggressive coarsening 1
      Maximum row sums 0.9
      Sweeps down         1
      Sweeps up           1
      Sweeps on coarse    1
      Relax down          symmetric-SOR/Jacobi
      Relax up            symmetric-SOR/Jacobi
      Relax on coarse     Gaussian-elimination
      Relax weight  (all)      1.
      Outer relax weight (all) 1.
      Using CF-relaxation
      Not using more complex smoothers.
      Measure type        local
      Coarsen type        Falgout
      Interpolation type  classical
  linear system matrix = precond matrix:
  Mat Object: 24 MPI processes
    type: mpibaij
    rows=196608, cols=196608, bs=3
    total: nonzeros=14745600, allocated nonzeros=14745600
    total number of mallocs used during MatSetValues calls=0
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
SNES Object: 24 MPI processes
  type: newtonls
  maximum iterations=50, maximum function evaluations=10000
  tolerances: relative=0.001, absolute=1e-50, solution=1e-08
  total number of linear solver iterations=1
  total number of function evaluations=1
  norm schedule ALWAYS
  SNESLineSearch Object: 24 MPI processes
    type: bt
      interpolation: cubic
      alpha=1.000000e-04
    maxstep=1.000000e+08, minlambda=1.000000e-12
    tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08
    maximum iterations=40
  KSP Object: 24 MPI processes
    type: richardson
      damping factor=1.
    maximum iterations=100, initial guess is zero
    tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
    left preconditioning
    using PRECONDITIONED norm type for convergence test
  PC Object: 24 MPI processes
    type: hypre
      HYPRE BoomerAMG preconditioning
        Cycle type V
        Maximum number of levels 25
        Maximum number of iterations PER hypre call 6
        Convergence tolerance PER hypre call 0.
        Threshold for strong coupling 0.25
        Interpolation truncation factor 0.
        Interpolation: max elements per row 0
        Number of levels of aggressive coarsening 0
        Number of paths for aggressive coarsening 1
        Maximum row sums 0.9
        Sweeps down         1
        Sweeps up           1
        Sweeps on coarse    1
        Relax down          symmetric-SOR/Jacobi
        Relax up            symmetric-SOR/Jacobi
        Relax on coarse     Gaussian-elimination
        Relax weight  (all)      1.
        Outer relax weight (all) 1.
        Using CF-relaxation
        Not using more complex smoothers.
        Measure type        local
        Coarsen type        Falgout
        Interpolation type  classical
    linear system matrix = precond matrix:
    Mat Object: 24 MPI processes
      type: mpibaij
      rows=196608, cols=196608, bs=3
      total: nonzeros=14745600, allocated nonzeros=14745600
      total number of mallocs used during MatSetValues calls=0
    0 SNES Function norm 6.145506780035e-04 
      0 KSP Residual norm 2.013603254316e+41 
      1 KSP Residual norm 8.120156893817e+87 
    Linear solve did not converge due to DIVERGED_DTOL iterations 1
KSP Object: 24 MPI processes
  type: richardson
    damping factor=1.
  maximum iterations=100, initial guess is zero
  tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 24 MPI processes
  type: hypre
    HYPRE BoomerAMG preconditioning
      Cycle type V
      Maximum number of levels 25
      Maximum number of iterations PER hypre call 6
      Convergence tolerance PER hypre call 0.
      Threshold for strong coupling 0.25
      Interpolation truncation factor 0.
      Interpolation: max elements per row 0
      Number of levels of aggressive coarsening 0
      Number of paths for aggressive coarsening 1
      Maximum row sums 0.9
      Sweeps down         1
      Sweeps up           1
      Sweeps on coarse    1
      Relax down          symmetric-SOR/Jacobi
      Relax up            symmetric-SOR/Jacobi
      Relax on coarse     Gaussian-elimination
      Relax weight  (all)      1.
      Outer relax weight (all) 1.
      Using CF-relaxation
      Not using more complex smoothers.
      Measure type        local
      Coarsen type        Falgout
      Interpolation type  classical
  linear system matrix = precond matrix:
  Mat Object: 24 MPI processes
    type: mpibaij
    rows=196608, cols=196608, bs=3
    total: nonzeros=14745600, allocated nonzeros=14745600
    total number of mallocs used during MatSetValues calls=0
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
SNES Object: 24 MPI processes
  type: newtonls
  maximum iterations=50, maximum function evaluations=10000
  tolerances: relative=0.001, absolute=1e-50, solution=1e-08
  total number of linear solver iterations=1
  total number of function evaluations=1
  norm schedule ALWAYS
  SNESLineSearch Object: 24 MPI processes
    type: bt
      interpolation: cubic
      alpha=1.000000e-04
    maxstep=1.000000e+08, minlambda=1.000000e-12
    tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08
    maximum iterations=40
  KSP Object: 24 MPI processes
    type: richardson
      damping factor=1.
    maximum iterations=100, initial guess is zero
    tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
    left preconditioning
    using PRECONDITIONED norm type for convergence test
  PC Object: 24 MPI processes
    type: hypre
      HYPRE BoomerAMG preconditioning
        Cycle type V
        Maximum number of levels 25
        Maximum number of iterations PER hypre call 6
        Convergence tolerance PER hypre call 0.
        Threshold for strong coupling 0.25
        Interpolation truncation factor 0.
        Interpolation: max elements per row 0
        Number of levels of aggressive coarsening 0
        Number of paths for aggressive coarsening 1
        Maximum row sums 0.9
        Sweeps down         1
        Sweeps up           1
        Sweeps on coarse    1
        Relax down          symmetric-SOR/Jacobi
        Relax up            symmetric-SOR/Jacobi
        Relax on coarse     Gaussian-elimination
        Relax weight  (all)      1.
        Outer relax weight (all) 1.
        Using CF-relaxation
        Not using more complex smoothers.
        Measure type        local
        Coarsen type        Falgout
        Interpolation type  classical
    linear system matrix = precond matrix:
    Mat Object: 24 MPI processes
      type: mpibaij
      rows=196608, cols=196608, bs=3
      total: nonzeros=14745600, allocated nonzeros=14745600
      total number of mallocs used during MatSetValues calls=0
    0 SNES Function norm 6.145506780035e-04 
      0 KSP Residual norm 2.013603254315e+41 
      1 KSP Residual norm 8.120156893816e+87 
    Linear solve did not converge due to DIVERGED_DTOL iterations 1
KSP Object: 24 MPI processes
  type: richardson
    damping factor=1.
  maximum iterations=100, initial guess is zero
  tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 24 MPI processes
  type: hypre
    HYPRE BoomerAMG preconditioning
      Cycle type V
      Maximum number of levels 25
      Maximum number of iterations PER hypre call 6
      Convergence tolerance PER hypre call 0.
      Threshold for strong coupling 0.25
      Interpolation truncation factor 0.
      Interpolation: max elements per row 0
      Number of levels of aggressive coarsening 0
      Number of paths for aggressive coarsening 1
      Maximum row sums 0.9
      Sweeps down         1
      Sweeps up           1
      Sweeps on coarse    1
      Relax down          symmetric-SOR/Jacobi
      Relax up            symmetric-SOR/Jacobi
      Relax on coarse     Gaussian-elimination
      Relax weight  (all)      1.
      Outer relax weight (all) 1.
      Using CF-relaxation
      Not using more complex smoothers.
      Measure type        local
      Coarsen type        Falgout
      Interpolation type  classical
  linear system matrix = precond matrix:
  Mat Object: 24 MPI processes
    type: mpibaij
    rows=196608, cols=196608, bs=3
    total: nonzeros=14745600, allocated nonzeros=14745600
    total number of mallocs used during MatSetValues calls=0
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
SNES Object: 24 MPI processes
  type: newtonls
  maximum iterations=50, maximum function evaluations=10000
  tolerances: relative=0.001, absolute=1e-50, solution=1e-08
  total number of linear solver iterations=1
  total number of function evaluations=1
  norm schedule ALWAYS
  SNESLineSearch Object: 24 MPI processes
    type: bt
      interpolation: cubic
      alpha=1.000000e-04
    maxstep=1.000000e+08, minlambda=1.000000e-12
    tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08
    maximum iterations=40
  KSP Object: 24 MPI processes
    type: richardson
      damping factor=1.
    maximum iterations=100, initial guess is zero
    tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
    left preconditioning
    using PRECONDITIONED norm type for convergence test
  PC Object: 24 MPI processes
    type: hypre
      HYPRE BoomerAMG preconditioning
        Cycle type V
        Maximum number of levels 25
        Maximum number of iterations PER hypre call 6
        Convergence tolerance PER hypre call 0.
        Threshold for strong coupling 0.25
        Interpolation truncation factor 0.
        Interpolation: max elements per row 0
        Number of levels of aggressive coarsening 0
        Number of paths for aggressive coarsening 1
        Maximum row sums 0.9
        Sweeps down         1
        Sweeps up           1
        Sweeps on coarse    1
        Relax down          symmetric-SOR/Jacobi
        Relax up            symmetric-SOR/Jacobi
        Relax on coarse     Gaussian-elimination
        Relax weight  (all)      1.
        Outer relax weight (all) 1.
        Using CF-relaxation
        Not using more complex smoothers.
        Measure type        local
        Coarsen type        Falgout
        Interpolation type  classical
    linear system matrix = precond matrix:
    Mat Object: 24 MPI processes
      type: mpibaij
      rows=196608, cols=196608, bs=3
      total: nonzeros=14745600, allocated nonzeros=14745600
      total number of mallocs used during MatSetValues calls=0
    0 SNES Function norm 6.145506780035e-04 
      0 KSP Residual norm 2.013603254316e+41 
      1 KSP Residual norm 8.120156893817e+87 
    Linear solve did not converge due to DIVERGED_DTOL iterations 1
KSP Object: 24 MPI processes
  type: richardson
    damping factor=1.
  maximum iterations=100, initial guess is zero
  tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
  left preconditioning
  using PRECONDITIONED norm type for convergence test
PC Object: 24 MPI processes
  type: hypre
    HYPRE BoomerAMG preconditioning
      Cycle type V
      Maximum number of levels 25
      Maximum number of iterations PER hypre call 6
      Convergence tolerance PER hypre call 0.
      Threshold for strong coupling 0.25
      Interpolation truncation factor 0.
      Interpolation: max elements per row 0
      Number of levels of aggressive coarsening 0
      Number of paths for aggressive coarsening 1
      Maximum row sums 0.9
      Sweeps down         1
      Sweeps up           1
      Sweeps on coarse    1
      Relax down          symmetric-SOR/Jacobi
      Relax up            symmetric-SOR/Jacobi
      Relax on coarse     Gaussian-elimination
      Relax weight  (all)      1.
      Outer relax weight (all) 1.
      Using CF-relaxation
      Not using more complex smoothers.
      Measure type        local
      Coarsen type        Falgout
      Interpolation type  classical
  linear system matrix = precond matrix:
  Mat Object: 24 MPI processes
    type: mpibaij
    rows=196608, cols=196608, bs=3
    total: nonzeros=14745600, allocated nonzeros=14745600
    total number of mallocs used during MatSetValues calls=0
  Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 0
SNES Object: 24 MPI processes
  type: newtonls
  maximum iterations=50, maximum function evaluations=10000
  tolerances: relative=0.001, absolute=1e-50, solution=1e-08
  total number of linear solver iterations=1
  total number of function evaluations=1
  norm schedule ALWAYS
  SNESLineSearch Object: 24 MPI processes
    type: bt
      interpolation: cubic
      alpha=1.000000e-04
    maxstep=1.000000e+08, minlambda=1.000000e-12
    tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08
    maximum iterations=40
  KSP Object: 24 MPI processes
    type: richardson
      damping factor=1.
    maximum iterations=100, initial guess is zero
    tolerances:  relative=0.001, absolute=1e-50, divergence=10000.
    left preconditioning
    using PRECONDITIONED norm type for convergence test
  PC Object: 24 MPI processes
    type: hypre
      HYPRE BoomerAMG preconditioning
        Cycle type V
        Maximum number of levels 25
        Maximum number of iterations PER hypre call 6
        Convergence tolerance PER hypre call 0.
        Threshold for strong coupling 0.25
        Interpolation truncation factor 0.
        Interpolation: max elements per row 0
        Number of levels of aggressive coarsening 0
        Number of paths for aggressive coarsening 1
        Maximum row sums 0.9
        Sweeps down         1
        Sweeps up           1
        Sweeps on coarse    1
        Relax down          symmetric-SOR/Jacobi
        Relax up            symmetric-SOR/Jacobi
        Relax on coarse     Gaussian-elimination
        Relax weight  (all)      1.
        Outer relax weight (all) 1.
        Using CF-relaxation
        Not using more complex smoothers.
        Measure type        local
        Coarsen type        Falgout
        Interpolation type  classical
    linear system matrix = precond matrix:
    Mat Object: 24 MPI processes
      type: mpibaij
      rows=196608, cols=196608, bs=3
      total: nonzeros=14745600, allocated nonzeros=14745600
      total number of mallocs used during MatSetValues calls=0
-------------- next part --------------
Partition - MPI: processors=[4,6,1] total=24
Partition - nnp: sum=65536 min=2688 max=2752 max/min=1.02381
Partition - nel: sum=65536 min=2688 max=2752 max/min=1.02381
0.000000e+00 1.000000e-02 -2.7004615480427790e-01
    0 SNES Function norm 6.145506780035e-04 
      0 KSP Residual norm 2.467690988498e-01 
      1 KSP Residual norm 3.208632265318e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.159970025650e-06 
      0 KSP Residual norm 5.998538450768e-04 
      1 KSP Residual norm 6.803411703442e-19 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.266194875448e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
    0 SNES Function norm 3.248633099046e-04 
      0 KSP Residual norm 1.745403464293e-01 
      1 KSP Residual norm 2.001693179615e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.210324220384e-06 
      0 KSP Residual norm 4.314173563148e-04 
      1 KSP Residual norm 3.909359644921e-19 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 6.714674239029e-12 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
    0 SNES Function norm 1.150046595471e-03 
      0 KSP Residual norm 5.242410726919e-01 
      1 KSP Residual norm 4.954256062574e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.532994996897e-06 
      0 KSP Residual norm 2.028605345400e-03 
      1 KSP Residual norm 2.261149331930e-18 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.512086723173e-10 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
1.000000e-02 1.000000e-02 -2.7004588784832795e-01  WARNING: Free energy increased!
    0 SNES Function norm 7.591062985933e-04 
      0 KSP Residual norm 3.287803563592e-01 
      1 KSP Residual norm 5.169868036180e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.531165993654e-06 
      0 KSP Residual norm 1.070968172611e-03 
      1 KSP Residual norm 9.462701139627e-19 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 2.395348918045e-11 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
2.000000e-02 1.000000e-02 -2.7004617851812329e-01
    0 SNES Function norm 6.007503755134e-04 
      0 KSP Residual norm 2.469978989151e-01 
      1 KSP Residual norm 3.940889864296e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.302228760782e-06 
      0 KSP Residual norm 6.009909795290e-04 
      1 KSP Residual norm 4.354239772483e-19 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 6.529234018968e-12 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
3.000000e-02 1.000000e-02 -2.7004646359665729e-01
    0 SNES Function norm 4.791389262094e-04 
      0 KSP Residual norm 1.896170646295e-01 
      1 KSP Residual norm 3.210646390696e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 6.321536487274e-07 
      0 KSP Residual norm 3.661904806549e-04 
      1 KSP Residual norm 2.361244578263e-19 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 1.345193578786e-12 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
4.000000e-02 1.000000e-02 -2.7004678220354794e-01
    0 SNES Function norm 4.003687929896e-04 
      0 KSP Residual norm 1.567958022324e-01 
      1 KSP Residual norm 2.488676816606e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.161072993641e-07 
      0 KSP Residual norm 2.664535404548e-04 
      1 KSP Residual norm 1.671830377000e-19 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    2 SNES Function norm 6.525157241518e-13 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 2
5.000000e-02 1.000000e-02 -2.7004708793855237e-01
    0 SNES Function norm 3.372836999172e-04 
      0 KSP Residual norm 1.333835327365e-01 
      1 KSP Residual norm 2.227890503762e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.233372127781e-07 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
6.000000e-02 1.000000e-02 -2.7004740476604228e-01
    0 SNES Function norm 2.933474333335e-04 
      0 KSP Residual norm 1.170857439015e-01 
      1 KSP Residual norm 1.845632132730e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.474862133898e-07 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
7.000000e-02 1.000000e-02 -2.7004771464539384e-01
    0 SNES Function norm 2.603471247970e-04 
      0 KSP Residual norm 1.052219964815e-01 
      1 KSP Residual norm 1.676308472852e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 2.007548970621e-07 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
8.000000e-02 1.000000e-02 -2.7004801191626626e-01
    0 SNES Function norm 2.346988133115e-04 
      0 KSP Residual norm 9.610009924959e-02 
      1 KSP Residual norm 1.474946106159e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.685669414258e-07 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
9.000000e-02 1.000000e-02 -2.7004829280624509e-01
    0 SNES Function norm 2.141624974060e-04 
      0 KSP Residual norm 8.881561787668e-02 
      1 KSP Residual norm 1.339116024798e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.454895134863e-07 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
1.000000e-01 1.000000e-02 -2.7004855432439340e-01
    0 SNES Function norm 1.974483572852e-04 
      0 KSP Residual norm 8.282926200244e-02 
      1 KSP Residual norm 1.215461964754e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.265226161117e-07 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
1.100000e-01 1.000000e-02 -2.7004879480237326e-01
    0 SNES Function norm 1.838653084775e-04 
      0 KSP Residual norm 7.781403714700e-02 
      1 KSP Residual norm 1.140719255191e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 1.099474270398e-07 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
1.200000e-01 1.000000e-02 -2.7004901352218080e-01
    0 SNES Function norm 1.729251800419e-04 
      0 KSP Residual norm 7.357787474302e-02 
      1 KSP Residual norm 1.024948972065e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 9.565660812051e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
1.300000e-01 1.000000e-02 -2.7004921072504423e-01
    0 SNES Function norm 1.641815136708e-04 
      0 KSP Residual norm 7.001052131663e-02 
      1 KSP Residual norm 1.011196586556e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 8.363812975764e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
1.400000e-01 1.000000e-02 -2.7004938719295291e-01
    0 SNES Function norm 1.570910889969e-04 
      0 KSP Residual norm 6.701731919072e-02 
      1 KSP Residual norm 9.548358988976e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 7.365697247817e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
1.500000e-01 1.000000e-02 -2.7004954380218116e-01
    0 SNES Function norm 1.510687308838e-04 
      0 KSP Residual norm 6.446188926037e-02 
      1 KSP Residual norm 9.088302628113e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 6.532387304711e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
1.600000e-01 1.000000e-02 -2.7004968135803631e-01
    0 SNES Function norm 1.457336273547e-04 
      0 KSP Residual norm 6.218598393081e-02 
      1 KSP Residual norm 8.563753183479e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.823179252520e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
1.700000e-01 1.000000e-02 -2.7004980080251972e-01
    0 SNES Function norm 1.410789383854e-04 
      0 KSP Residual norm 6.008463420507e-02 
      1 KSP Residual norm 8.287384045411e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.212537398103e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
1.800000e-01 1.000000e-02 -2.7004990354815506e-01
    0 SNES Function norm 1.373469317049e-04 
      0 KSP Residual norm 5.814458724398e-02 
      1 KSP Residual norm 8.633531587111e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.710714720681e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
1.900000e-01 1.000000e-02 -2.7004999159660076e-01
    0 SNES Function norm 1.347263698247e-04 
      0 KSP Residual norm 5.641195479399e-02 
      1 KSP Residual norm 8.372152834470e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.332858597561e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
2.000000e-01 1.000000e-02 -2.7005006734794823e-01
    0 SNES Function norm 1.331523690922e-04 
      0 KSP Residual norm 5.493374114707e-02 
      1 KSP Residual norm 7.879378380256e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.050103465582e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
2.100000e-01 1.000000e-02 -2.7005013324932536e-01
    0 SNES Function norm 1.323313848283e-04 
      0 KSP Residual norm 5.372191614143e-02 
      1 KSP Residual norm 8.198827054457e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.806282162630e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
2.200000e-01 1.000000e-02 -2.7005019147919740e-01
    0 SNES Function norm 1.318989952835e-04 
      0 KSP Residual norm 5.275195771538e-02 
      1 KSP Residual norm 8.448186921168e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.571515769706e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
2.300000e-01 1.000000e-02 -2.7005024377280235e-01
    0 SNES Function norm 1.315633914376e-04 
      0 KSP Residual norm 5.198101206365e-02 
      1 KSP Residual norm 8.240461942629e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.357534019221e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
2.400000e-01 1.000000e-02 -2.7005029139026404e-01
    0 SNES Function norm 1.311650874622e-04 
      0 KSP Residual norm 5.136690520685e-02 
      1 KSP Residual norm 8.192896055038e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.191606579713e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
2.500000e-01 1.000000e-02 -2.7005033517586113e-01
    0 SNES Function norm 1.306653180012e-04 
      0 KSP Residual norm 5.087837015180e-02 
      1 KSP Residual norm 8.449072897194e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.087737051540e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
2.600000e-01 1.000000e-02 -2.7005037565358103e-01
    0 SNES Function norm 1.301034651541e-04 
      0 KSP Residual norm 5.049631916533e-02 
      1 KSP Residual norm 8.517231122475e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.039296127298e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
2.700000e-01 1.000000e-02 -2.7005041312421701e-01
    0 SNES Function norm 1.295541790023e-04 
      0 KSP Residual norm 5.021015596196e-02 
      1 KSP Residual norm 8.053087689770e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.029470303347e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
2.800000e-01 1.000000e-02 -2.7005044775034825e-01
    0 SNES Function norm 1.290967225945e-04 
      0 KSP Residual norm 5.001291003342e-02 
      1 KSP Residual norm 8.384029958122e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.043116987888e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
2.900000e-01 1.000000e-02 -2.7005047962752554e-01
    0 SNES Function norm 1.287966652681e-04 
      0 KSP Residual norm 4.989722846542e-02 
      1 KSP Residual norm 8.517551464858e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.071058150712e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
3.000000e-01 1.000000e-02 -2.7005050884310866e-01
    0 SNES Function norm 1.286955059863e-04 
      0 KSP Residual norm 4.985282653164e-02 
      1 KSP Residual norm 8.670317467195e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.108562491958e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
3.100000e-01 1.000000e-02 -2.7005053552239677e-01
    0 SNES Function norm 1.288045817528e-04 
      0 KSP Residual norm 4.986534524878e-02 
      1 KSP Residual norm 9.275273321225e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.152595335856e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
3.200000e-01 1.000000e-02 -2.7005055985937509e-01
    0 SNES Function norm 1.291023720874e-04 
      0 KSP Residual norm 4.991643524405e-02 
      1 KSP Residual norm 8.034694783757e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.200444969065e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
3.300000e-01 1.000000e-02 -2.7005058212902999e-01
    0 SNES Function norm 1.295363926364e-04 
      0 KSP Residual norm 4.998490776124e-02 
      1 KSP Residual norm 8.515228954109e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.250066566775e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
3.400000e-01 1.000000e-02 -2.7005060268034065e-01
    0 SNES Function norm 1.300309141299e-04 
      0 KSP Residual norm 5.004874882830e-02 
      1 KSP Residual norm 8.145355340255e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.301137406651e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
3.500000e-01 1.000000e-02 -2.7005062191269247e-01
    0 SNES Function norm 1.304999321438e-04 
      0 KSP Residual norm 5.008764985580e-02 
      1 KSP Residual norm 8.935280448379e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.355429613498e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
3.600000e-01 1.000000e-02 -2.7005064024177028e-01
    0 SNES Function norm 1.308625321931e-04 
      0 KSP Residual norm 5.008554862110e-02 
      1 KSP Residual norm 8.669004052215e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.415702498721e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
3.700000e-01 1.000000e-02 -2.7005065806249778e-01
    0 SNES Function norm 1.310566023361e-04 
      0 KSP Residual norm 5.003260861702e-02 
      1 KSP Residual norm 8.245542680760e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.483556195501e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
3.800000e-01 1.000000e-02 -2.7005067571583746e-01
    0 SNES Function norm 1.310474371268e-04 
      0 KSP Residual norm 4.992616181110e-02 
      1 KSP Residual norm 8.566497297356e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.557647601642e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
3.900000e-01 1.000000e-02 -2.7005069346394039e-01
    0 SNES Function norm 1.308297082280e-04 
      0 KSP Residual norm 4.977039181209e-02 
      1 KSP Residual norm 8.513024223404e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.633494520842e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
4.000000e-01 1.000000e-02 -2.7005071147540105e-01
    0 SNES Function norm 1.304234924997e-04 
      0 KSP Residual norm 4.957486134057e-02 
      1 KSP Residual norm 8.126656972635e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.704942786060e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
4.100000e-01 1.000000e-02 -2.7005072982036926e-01
    0 SNES Function norm 1.298666063106e-04 
      0 KSP Residual norm 4.935227946486e-02 
      1 KSP Residual norm 8.676124888013e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.766319628151e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
4.200000e-01 1.000000e-02 -2.7005074847427774e-01
    0 SNES Function norm 1.292059690102e-04 
      0 KSP Residual norm 4.911606768633e-02 
      1 KSP Residual norm 9.403987745979e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.814130732184e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
4.300000e-01 1.000000e-02 -2.7005076732885325e-01
    0 SNES Function norm 1.284902059917e-04 
      0 KSP Residual norm 4.887827592446e-02 
      1 KSP Residual norm 8.261715122863e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.847699288623e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
4.400000e-01 1.000000e-02 -2.7005078620918233e-01
    0 SNES Function norm 1.277646277340e-04 
      0 KSP Residual norm 4.864823502395e-02 
      1 KSP Residual norm 8.322894266924e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.868784661888e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
4.500000e-01 1.000000e-02 -2.7005080489553290e-01
    0 SNES Function norm 1.270686052783e-04 
      0 KSP Residual norm 4.843207832248e-02 
      1 KSP Residual norm 7.658181739634e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.880590816856e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
4.600000e-01 1.000000e-02 -2.7005082314820794e-01
    0 SNES Function norm 1.264346160880e-04 
      0 KSP Residual norm 4.823301451898e-02 
      1 KSP Residual norm 8.267194572463e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.886649761279e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
4.700000e-01 1.000000e-02 -2.7005084073311914e-01
    0 SNES Function norm 1.258880291622e-04 
      0 KSP Residual norm 4.805206985149e-02 
      1 KSP Residual norm 8.103431246181e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.889951598881e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
4.800000e-01 1.000000e-02 -2.7005085744537749e-01
    0 SNES Function norm 1.254469489918e-04 
      0 KSP Residual norm 4.788897666655e-02 
      1 KSP Residual norm 8.288306137134e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.892505254666e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
4.900000e-01 1.000000e-02 -2.7005087312826392e-01
    0 SNES Function norm 1.251218969828e-04 
      0 KSP Residual norm 4.774295057537e-02 
      1 KSP Residual norm 8.472336124586e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.895334276006e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
5.000000e-01 1.000000e-02 -2.7005088768555835e-01
    0 SNES Function norm 1.249155146203e-04 
      0 KSP Residual norm 4.761321714496e-02 
      1 KSP Residual norm 8.734848200853e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.898783605389e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
5.100000e-01 1.000000e-02 -2.7005090108621255e-01
    0 SNES Function norm 1.248226639088e-04 
      0 KSP Residual norm 4.749926592208e-02 
      1 KSP Residual norm 9.506133548068e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.902950684200e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
5.200000e-01 1.000000e-02 -2.7005091336153747e-01
    0 SNES Function norm 1.248312527233e-04 
      0 KSP Residual norm 4.740088930468e-02 
      1 KSP Residual norm 7.863890388042e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.908058792495e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
5.300000e-01 1.000000e-02 -2.7005092459613034e-01
    0 SNES Function norm 1.249239031515e-04 
      0 KSP Residual norm 4.731809700195e-02 
      1 KSP Residual norm 8.266581306332e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.914652343837e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
5.400000e-01 1.000000e-02 -2.7005093491453891e-01
    0 SNES Function norm 1.250803261973e-04 
      0 KSP Residual norm 4.725099249852e-02 
      1 KSP Residual norm 7.712409754454e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.923586184615e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
5.500000e-01 1.000000e-02 -2.7005094446601197e-01
    0 SNES Function norm 1.252800663150e-04 
      0 KSP Residual norm 4.719967231351e-02 
      1 KSP Residual norm 8.966941531231e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.935864472337e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
5.600000e-01 1.000000e-02 -2.7005095340963958e-01
    0 SNES Function norm 1.255051875639e-04 
      0 KSP Residual norm 4.716417743399e-02 
      1 KSP Residual norm 9.142312638670e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.952426812397e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
5.700000e-01 1.000000e-02 -2.7005096190183120e-01
    0 SNES Function norm 1.257424935142e-04 
      0 KSP Residual norm 4.714449989190e-02 
      1 KSP Residual norm 8.529124097943e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 3.973971797813e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
5.800000e-01 1.000000e-02 -2.7005097008744949e-01
    0 SNES Function norm 1.259849748576e-04 
      0 KSP Residual norm 4.714063098675e-02 
      1 KSP Residual norm 8.523907811359e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.000867914970e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
5.900000e-01 1.000000e-02 -2.7005097809524015e-01
    0 SNES Function norm 1.262323193457e-04 
      0 KSP Residual norm 4.715263090545e-02 
      1 KSP Residual norm 8.227859785206e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.033156341940e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
6.000000e-01 1.000000e-02 -2.7005098603747701e-01
    0 SNES Function norm 1.264904622458e-04 
      0 KSP Residual norm 4.718069908482e-02 
      1 KSP Residual norm 8.687273977620e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.070619766229e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
6.100000e-01 1.000000e-02 -2.7005099401312771e-01
    0 SNES Function norm 1.267702815506e-04 
      0 KSP Residual norm 4.722522680154e-02 
      1 KSP Residual norm 8.614293952871e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.112881128888e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
6.200000e-01 1.000000e-02 -2.7005100211338434e-01
    0 SNES Function norm 1.270856439716e-04 
      0 KSP Residual norm 4.728681612875e-02 
      1 KSP Residual norm 8.040894664707e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.159500060636e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
6.300000e-01 1.000000e-02 -2.7005101042816793e-01
    0 SNES Function norm 1.274510837735e-04 
      0 KSP Residual norm 4.736625289203e-02 
      1 KSP Residual norm 9.397625576922e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.210044648043e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
6.400000e-01 1.000000e-02 -2.7005101905214601e-01
    0 SNES Function norm 1.278794422750e-04 
      0 KSP Residual norm 4.746442712593e-02 
      1 KSP Residual norm 8.596976452407e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.264127944224e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
6.500000e-01 1.000000e-02 -2.7005102808903919e-01
    0 SNES Function norm 1.283798016497e-04 
      0 KSP Residual norm 4.758220362686e-02 
      1 KSP Residual norm 8.578580653565e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.321411173433e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
6.600000e-01 1.000000e-02 -2.7005103765334981e-01
    0 SNES Function norm 1.289560027062e-04 
      0 KSP Residual norm 4.772025641348e-02 
      1 KSP Residual norm 8.784443585062e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.381586693981e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
6.700000e-01 1.000000e-02 -2.7005104786913470e-01
    0 SNES Function norm 1.296059415503e-04 
      0 KSP Residual norm 4.787889129234e-02 
      1 KSP Residual norm 9.253262060992e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.444359129050e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
6.800000e-01 1.000000e-02 -2.7005105886598729e-01
    0 SNES Function norm 1.303217083497e-04 
      0 KSP Residual norm 4.805788681056e-02 
      1 KSP Residual norm 9.264822660641e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.509439438075e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
6.900000e-01 1.000000e-02 -2.7005107077283075e-01
    0 SNES Function norm 1.310904903667e-04 
      0 KSP Residual norm 4.825638327865e-02 
      1 KSP Residual norm 8.764872625434e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.576555773462e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
7.000000e-01 1.000000e-02 -2.7005108371044267e-01
    0 SNES Function norm 1.318960433272e-04 
      0 KSP Residual norm 4.847284203751e-02 
      1 KSP Residual norm 1.018892594898e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.645473090798e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
7.100000e-01 1.000000e-02 -2.7005109778378011e-01
    0 SNES Function norm 1.327204654184e-04 
      0 KSP Residual norm 4.870508467882e-02 
      1 KSP Residual norm 9.189208839778e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.716007396770e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
7.200000e-01 1.000000e-02 -2.7005111307512530e-01
    0 SNES Function norm 1.335459968351e-04 
      0 KSP Residual norm 4.895040782835e-02 
      1 KSP Residual norm 9.289650049374e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.788023033976e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
7.300000e-01 1.000000e-02 -2.7005112963886052e-01
    0 SNES Function norm 1.343566082352e-04 
      0 KSP Residual norm 4.920575683694e-02 
      1 KSP Residual norm 8.927806856972e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.861410230823e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
7.400000e-01 1.000000e-02 -2.7005114749841053e-01
    0 SNES Function norm 1.351392154082e-04 
      0 KSP Residual norm 4.946793384165e-02 
      1 KSP Residual norm 1.018505713166e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 4.936050069226e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
7.500000e-01 1.000000e-02 -2.7005116664555817e-01
    0 SNES Function norm 1.358844426474e-04 
      0 KSP Residual norm 4.973381319266e-02 
      1 KSP Residual norm 9.737486275461e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.011780090823e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
7.600000e-01 1.000000e-02 -2.7005118704201703e-01
    0 SNES Function norm 1.365869344230e-04 
      0 KSP Residual norm 5.000053969143e-02 
      1 KSP Residual norm 1.014613095956e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.088373597196e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
7.700000e-01 1.000000e-02 -2.7005120862294485e-01
    0 SNES Function norm 1.372452715520e-04 
      0 KSP Residual norm 5.026569087223e-02 
      1 KSP Residual norm 8.827215131078e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.165540079199e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
7.800000e-01 1.000000e-02 -2.7005123130188396e-01
    0 SNES Function norm 1.378615795742e-04 
      0 KSP Residual norm 5.052739169296e-02 
      1 KSP Residual norm 1.016012142529e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.242946169072e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
7.900000e-01 1.000000e-02 -2.7005125497659077e-01
    0 SNES Function norm 1.384409255344e-04 
      0 KSP Residual norm 5.078437673926e-02 
      1 KSP Residual norm 9.081152901723e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.320249623696e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
8.000000e-01 1.000000e-02 -2.7005127953517338e-01
    0 SNES Function norm 1.389905912012e-04 
      0 KSP Residual norm 5.103600032377e-02 
      1 KSP Residual norm 8.863669324018e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.397135581892e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
8.100000e-01 1.000000e-02 -2.7005130486207074e-01
    0 SNES Function norm 1.395192940170e-04 
      0 KSP Residual norm 5.128219842052e-02 
      1 KSP Residual norm 9.449028896830e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.473345210711e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
8.200000e-01 1.000000e-02 -2.7005133084343758e-01
    0 SNES Function norm 1.400364091644e-04 
      0 KSP Residual norm 5.152340858920e-02 
      1 KSP Residual norm 9.608628537343e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.548690646637e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
8.300000e-01 1.000000e-02 -2.7005135737165498e-01
    0 SNES Function norm 1.405512320529e-04 
      0 KSP Residual norm 5.176045558073e-02 
      1 KSP Residual norm 8.882830074779e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.623054877347e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
8.400000e-01 1.000000e-02 -2.7005138434876008e-01
    0 SNES Function norm 1.410723121011e-04 
      0 KSP Residual norm 5.199441174979e-02 
      1 KSP Residual norm 1.114403906834e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.696379171515e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
8.500000e-01 1.000000e-02 -2.7005141168871116e-01
    0 SNES Function norm 1.416068848354e-04 
      0 KSP Residual norm 5.222644295406e-02 
      1 KSP Residual norm 8.691117930668e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.768642944382e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
8.600000e-01 1.000000e-02 -2.7005143931849895e-01
    0 SNES Function norm 1.421604271681e-04 
      0 KSP Residual norm 5.245765209338e-02 
      1 KSP Residual norm 9.521861884279e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.839841476011e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
8.700000e-01 1.000000e-02 -2.7005146717819661e-01
    0 SNES Function norm 1.427363571207e-04 
      0 KSP Residual norm 5.268893333062e-02 
      1 KSP Residual norm 1.003328992888e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.909966088984e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
8.800000e-01 1.000000e-02 -2.7005149522011740e-01
    0 SNES Function norm 1.433358921294e-04 
      0 KSP Residual norm 5.292084978043e-02 
      1 KSP Residual norm 9.818390126493e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 5.978989811110e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
8.900000e-01 1.000000e-02 -2.7005152340729488e-01
    0 SNES Function norm 1.439580691225e-04 
      0 KSP Residual norm 5.315354568499e-02 
      1 KSP Residual norm 1.073728372628e-16 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 6.046859720620e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
9.000000e-01 1.000000e-02 -2.7005155171152762e-01
    0 SNES Function norm 1.445999162462e-04 
      0 KSP Residual norm 5.338670081657e-02 
      1 KSP Residual norm 9.850553430970e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 6.113495515629e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
9.100000e-01 1.000000e-02 -2.7005158011124175e-01
    0 SNES Function norm 1.452567529338e-04 
      0 KSP Residual norm 5.361953044491e-02 
      1 KSP Residual norm 9.238102234324e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 6.178792687624e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
9.200000e-01 1.000000e-02 -2.7005160858937483e-01
    0 SNES Function norm 1.459225845647e-04 
      0 KSP Residual norm 5.385082935781e-02 
      1 KSP Residual norm 9.863290726348e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 6.242628177069e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
9.300000e-01 1.000000e-02 -2.7005163713148278e-01
    0 SNES Function norm 1.465905520774e-04 
      0 KSP Residual norm 5.407905389764e-02 
      1 KSP Residual norm 9.560191825428e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 6.304866528941e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
9.400000e-01 1.000000e-02 -2.7005166572417771e-01
    0 SNES Function norm 1.472533962569e-04 
      0 KSP Residual norm 5.430243244530e-02 
      1 KSP Residual norm 9.159757006481e-17 
    Linear solve converged due to CONVERGED_RTOL iterations 1
    1 SNES Function norm 6.365365151593e-08 
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 1
9.500000e-01 1.000000e-02 -2.7005169435396781e-01
    0 SNES Function norm 1.479039004674e-04 


More information about the petsc-users mailing list