[petsc-users] Field Split PC for Fully-Coupled 3d stationary incompressible Navier-Stokes Solution Algorithm

Fabian Gabel gabel.fabian at gmail.com
Sun Feb 15 14:08:32 CST 2015


In some further testing I tried to reduce the wall clock time for my
program runs by balancing the number of solver iterations needed to
apply the preconditioner and the number of inner iterations of the
solver for the complete linear system (velocities and pressure). 

Using 

-coupledsolve_pc_fieldsplit_schur_fact_type DIAG

led to many solver iterations during the application of the
preconditioner. On the other hand

-coupledsolve_pc_fieldsplit_schur_fact_type UPPER

did not present itself as a good factorization either, because to
achieve a good preconditioning in the sense that the outermost KSP
(-coupledsolve_ksp_type) would benefit from it, too many solver
iterations during the application of the preconditioner were needed,
which negatively affected the amount of time required for the program to
finish.

I found that the following set of options led to a further notable
improvement of needed wall clock time for the program execution from
6083s to 2200s (2e6 unknowns):

-coupledsolve_fieldsplit_0_fieldsplit_ksp_type preonly
-coupledsolve_fieldsplit_0_fieldsplit_pc_type ml
-coupledsolve_fieldsplit_0_ksp_rtol 1e-2 
-coupledsolve_fieldsplit_0_ksp_type gmres
-coupledsolve_fieldsplit_0_pc_fieldsplit_block_size 3
-coupledsolve_fieldsplit_0_pc_type fieldsplit
-coupledsolve_fieldsplit_1_ksp_rtol 1e-1 
-coupledsolve_fieldsplit_1_ksp_type gmres
-coupledsolve_fieldsplit_1_pc_type ilu
-coupledsolve_fieldsplit_ksp_converged_reason
-coupledsolve_ksp_type fgmres
-coupledsolve_pc_fieldsplit_0_fields 0,1,2
-coupledsolve_pc_fieldsplit_1_fields 3
-coupledsolve_pc_fieldsplit_block_size 4
-coupledsolve_pc_fieldsplit_type schur
-coupledsolve_pc_type fieldsplit
-coupledsolve_pc_fieldsplit_schur_fact_type 
-coupledsolve_ksp_monitor

I attached the complete output at the end of my mail. Any comments on
the present performance and further suggestions are appreciated.

I wonder why the lower schur factorization approximation would perform
considerably better than the upper factorization. Is this due to the
fact, that I use the Schur complement preconditioner as a left
preconditioner for GMRES?

Furthermore, my solver is able to couple the solution process for the
Navier-Stokes equations with the solution process for a temperature
equation. The velocity-to-temperature coupling is realized through a
Boussinesq approximation, the temperature-to-velocity/pressure coupling
comes from a Newton-Raphson linearization of the convective term of the
temperature equation like in

@article{galpin86,
author = {Galpin, P. F. and Raithby, G. D.},
title = {NUMERICAL SOLUTION OF PROBLEMS IN INCOMPRESSIBLE FLUID FLOW:
TREATMENT OF THE TEMPERATURE-VELOCITY COUPLING},
journal = {Numerical Heat Transfer},
volume = {10},
number = {2},
pages = {105-129},
year = {1986},
}

Would you also suggest to precondition the resulting linear system for
velocity, pressure and temperature via a fieldsplit preconditioner? I am
thinking about a nested fieldsplit, where I use on the outermost level
a 

-coupledsolve_pc_fieldsplit_type additive
-coupledsolve_pc_fieldsplit_0_fields 0,1,2,3
-coupledsolve_pc_fieldsplit_1_fields 4


Regards,
Fabian
-------------- next part --------------
Sender: LSF System <lsfadmin at hpb0062>
Subject: Job 529769: <lower.fieldsplit_128> in cluster <lichtenberg> Done

Job <lower.fieldsplit_128> was submitted from host <hla0003> by user <gu08vomo> in cluster <lichtenberg>.
Job was executed on host(s) <hpb0062>, in queue <test_mpi2>, as user <gu08vomo> in cluster <lichtenberg>.
</home/gu08vomo> was used as the home directory.
</work/scratch/gu08vomo/thesis/singleblock/128_1_1> was used as the working directory.
Started at Sun Feb 15 19:21:29 2015
Results reported at Sun Feb 15 19:58:42 2015

Your job looked like:

------------------------------------------------------------
# LSBATCH: User input
#! /bin/sh

#BSUB -J lower.fieldsplit_128

#BSUB -o /home/gu08vomo/thesis/fieldsplit/lower_128.out.%J

#BSUB -n 1
#BSUB -W 0:40
#BSUB -x

#BSUB -q test_mpi2

#BSUB -a openmpi

module load openmpi/intel/1.8.2
export PETSC_DIR=/home/gu08vomo/soft/petsc/3.5.3/build/arch-openmpi-opt-intel-hlr
export MYWORKDIR=/work/scratch/gu08vomo/thesis/singleblock/128_1_1/
export OUTPUTDIR=/home/gu08vomo/thesis/coupling
export PETSC_OPS="-options_file ops.lower"
#cat ops.full
cat ops.lower

echo "PETSC_DIR="$PETSC_DIR
echo "MYWORKDIR="$MYWORKDIR
echo "PETSC_OPS="$PETSC_OPS
cd $MYWORKDIR
mpirun -n 1 ./caffa3d.cpld.lnx ${PETSC_OPS}


------------------------------------------------------------

Successfully completed.

Resource usage summary:

    CPU time :               2230.93 sec.
    Max Memory :             12976 MB
    Average Memory :         12440.09 MB
    Total Requested Memory : -
    Delta Memory :           -
    (Delta: the difference between total requested memory and actual max usage.)
    Max Swap :               13833 MB

    Max Processes :          6
    Max Threads :            11

The output (if any) follows:

Modules: loading gcc/4.8.4
Modules: loading intel/2015
Modules: loading openmpi/intel/1.8.2
-coupledsolve_fieldsplit_0_fieldsplit_ksp_type preonly
-coupledsolve_fieldsplit_0_fieldsplit_pc_type ml
-coupledsolve_fieldsplit_0_ksp_rtol 1e-2
-coupledsolve_fieldsplit_0_ksp_type gmres
-coupledsolve_fieldsplit_0_pc_fieldsplit_block_size 3
-coupledsolve_fieldsplit_0_pc_type fieldsplit
-coupledsolve_fieldsplit_1_ksp_rtol 1e-1
-coupledsolve_fieldsplit_1_ksp_type gmres
-coupledsolve_fieldsplit_1_pc_type ilu
-coupledsolve_fieldsplit_ksp_converged_reason
-coupledsolve_fieldsplit_schur_precondition a11
-coupledsolve_ksp_monitor
-coupledsolve_ksp_type fgmres
-coupledsolve_pc_fieldsplit_0_fields 0,1,2
-coupledsolve_pc_fieldsplit_1_fields 3
-coupledsolve_pc_fieldsplit_block_size 4
-coupledsolve_pc_fieldsplit_type schur
-coupledsolve_pc_type fieldsplit
-coupledsolve_pc_fieldsplit_schur_fact_type lower
-on_error_abort
-log_summary
PETSC_DIR=/home/gu08vomo/soft/petsc/3.5.3/build/arch-openmpi-opt-intel-hlr
MYWORKDIR=/work/scratch/gu08vomo/thesis/singleblock/128_1_1/
PETSC_OPS=-options_file ops.lower
  ENTER PROBLEM NAME (SIX CHARACTERS):  
 ****************************************************
 NAME OF PROBLEM SOLVED control
 
 ****************************************************
 ***************************************************
 CONTROL SETTINGS
 ***************************************************
 LREAD,LWRITE,LPOST,LTEST,LOUTS,LOUTE,LTIME,LGRAD
 F F T F F F F F
  IMON, JMON, KMON, MMON, RMON,  IPR,  JPR,  KPR,  MPR,NPCOR,NIGRAD 
     8     9     8     1     0     2     2     3     1     1     1
  SORMAX,     SLARGE,     ALFA
  0.1000E-07  0.1000E+31  0.9200E+00
 (URF(I),I=1,6)
  0.1000E+01  0.1000E+01  0.1000E+01  0.1000E+01  0.1000E+01  0.1000E+01
 (SOR(I),I=1,6)
  0.1000E-02  0.1000E-01  0.1000E-01  0.1000E-01  0.1000E-01  0.1000E-07
 (GDS(I),I=1,6) - BLENDING (CDS-UDS)
  0.1000E+01  0.1000E+01  0.1000E+01  0.1000E+01  0.1000E+01  0.1000E+01
 LSG
    50
 ***************************************************
 START COUPLED ALGORITHM
 ***************************************************
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.037662565552e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  1 KSP Residual norm 1.553300775148e+00 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 2.017338866144e-01 
KSP Object:(coupledsolve_) 1 MPI processes
  type: fgmres
    GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
    GMRES: happy breakdown tolerance 1e-30
  maximum iterations=10000, initial guess is zero
  tolerances:  relative=0.001, absolute=1e-50, divergence=10000
  right preconditioning
  has attached null space
  using UNPRECONDITIONED norm type for convergence test
PC Object:(coupledsolve_) 1 MPI processes
  type: fieldsplit
    FieldSplit with Schur preconditioner, blocksize = 4, factorization LOWER
    Preconditioner for the Schur complement formed from A11
    Split info:
    Split number 0 Fields  0, 1, 2
    Split number 1 Fields  3
    KSP solver for A00 block
      KSP Object:      (coupledsolve_fieldsplit_0_)       1 MPI processes
        type: gmres
          GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
          GMRES: happy breakdown tolerance 1e-30
        maximum iterations=10000, initial guess is zero
        tolerances:  relative=0.01, absolute=1e-50, divergence=10000
        left preconditioning
        using PRECONDITIONED norm type for convergence test
      PC Object:      (coupledsolve_fieldsplit_0_)       1 MPI processes
        type: fieldsplit
          FieldSplit with MULTIPLICATIVE composition: total splits = 3, blocksize = 3
          Solver info for each split is in the following KSP objects:
          Split number 0 Fields  0
          KSP Object:          (coupledsolve_fieldsplit_0_fieldsplit_0_)           1 MPI processes
            type: preonly
            maximum iterations=10000, initial guess is zero
            tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
            left preconditioning
            using NONE norm type for convergence test
          PC Object:          (coupledsolve_fieldsplit_0_fieldsplit_0_)           1 MPI processes
            type: ml
              MG: type is MULTIPLICATIVE, levels=6 cycles=v
                Cycles per PCApply=1
                Using Galerkin computed coarse grid matrices
            Coarse grid solver -- level -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_0_mg_coarse_)               1 MPI processes
                type: preonly
                maximum iterations=1, initial guess is zero
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_0_mg_coarse_)               1 MPI processes
                type: lu
                  LU: out-of-place factorization
                  tolerance for zero pivot 2.22045e-14
                  using diagonal shift on blocks to prevent zero pivot [INBLOCKS]
                  matrix ordering: nd
                  factor fill ratio given 5, needed 1
                    Factored matrix follows:
                      Mat Object:                       1 MPI processes
                        type: seqaij
                        rows=1, cols=1
                        package used to perform factorization: petsc
                        total: nonzeros=1, allocated nonzeros=1
                        total number of mallocs used during MatSetValues calls =0
                          not using I-node routines
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=1, cols=1
                  total: nonzeros=1, allocated nonzeros=1
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Down solver (pre-smoother) on level 1 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_1_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_1_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=4, cols=4
                  total: nonzeros=16, allocated nonzeros=16
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 1 nodes, limit used is 5
            Up solver (post-smoother) same as down solver (pre-smoother)
            Down solver (pre-smoother) on level 2 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_2_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_2_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=105, cols=105
                  total: nonzeros=3963, allocated nonzeros=3963
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Up solver (post-smoother) same as down solver (pre-smoother)
            Down solver (pre-smoother) on level 3 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_3_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_3_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=6667, cols=6667
                  total: nonzeros=356943, allocated nonzeros=356943
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Up solver (post-smoother) same as down solver (pre-smoother)
            Down solver (pre-smoother) on level 4 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_4_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_4_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=263552, cols=263552
                  total: nonzeros=7.74159e+06, allocated nonzeros=7.74159e+06
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Up solver (post-smoother) same as down solver (pre-smoother)
            Down solver (pre-smoother) on level 5 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_5_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_5_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                (coupledsolve_fieldsplit_0_fieldsplit_0_)                 1 MPI processes
                  type: seqaij
                  rows=2197000, cols=2197000
                  total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Up solver (post-smoother) same as down solver (pre-smoother)
            linear system matrix = precond matrix:
            Mat Object:            (coupledsolve_fieldsplit_0_fieldsplit_0_)             1 MPI processes
              type: seqaij
              rows=2197000, cols=2197000
              total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
              total number of mallocs used during MatSetValues calls =0
                not using I-node routines
          Split number 1 Fields  1
          KSP Object:          (coupledsolve_fieldsplit_0_fieldsplit_1_)           1 MPI processes
            type: preonly
            maximum iterations=10000, initial guess is zero
            tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
            left preconditioning
            using NONE norm type for convergence test
          PC Object:          (coupledsolve_fieldsplit_0_fieldsplit_1_)           1 MPI processes
            type: ml
              MG: type is MULTIPLICATIVE, levels=6 cycles=v
                Cycles per PCApply=1
                Using Galerkin computed coarse grid matrices
            Coarse grid solver -- level -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_1_mg_coarse_)               1 MPI processes
                type: preonly
                maximum iterations=1, initial guess is zero
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_1_mg_coarse_)               1 MPI processes
                type: lu
                  LU: out-of-place factorization
                  tolerance for zero pivot 2.22045e-14
                  using diagonal shift on blocks to prevent zero pivot [INBLOCKS]
                  matrix ordering: nd
                  factor fill ratio given 5, needed 1
                    Factored matrix follows:
                      Mat Object:                       1 MPI processes
                        type: seqaij
                        rows=1, cols=1
                        package used to perform factorization: petsc
                        total: nonzeros=1, allocated nonzeros=1
                        total number of mallocs used during MatSetValues calls =0
                          not using I-node routines
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=1, cols=1
                  total: nonzeros=1, allocated nonzeros=1
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Down solver (pre-smoother) on level 1 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_1_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_1_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=4, cols=4
                  total: nonzeros=16, allocated nonzeros=16
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 1 nodes, limit used is 5
            Up solver (post-smoother) same as down solver (pre-smoother)
            Down solver (pre-smoother) on level 2 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_2_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_2_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=105, cols=105
                  total: nonzeros=3963, allocated nonzeros=3963
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Up solver (post-smoother) same as down solver (pre-smoother)
            Down solver (pre-smoother) on level 3 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_3_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_3_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=6667, cols=6667
                  total: nonzeros=356943, allocated nonzeros=356943
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Up solver (post-smoother) same as down solver (pre-smoother)
            Down solver (pre-smoother) on level 4 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_4_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_4_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=263552, cols=263552
                  total: nonzeros=7.74159e+06, allocated nonzeros=7.74159e+06
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Up solver (post-smoother) same as down solver (pre-smoother)
            Down solver (pre-smoother) on level 5 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_5_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_5_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                (coupledsolve_fieldsplit_0_fieldsplit_1_)                 1 MPI processes
                  type: seqaij
                  rows=2197000, cols=2197000
                  total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Up solver (post-smoother) same as down solver (pre-smoother)
            linear system matrix = precond matrix:
            Mat Object:            (coupledsolve_fieldsplit_0_fieldsplit_1_)             1 MPI processes
              type: seqaij
              rows=2197000, cols=2197000
              total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
              total number of mallocs used during MatSetValues calls =0
                not using I-node routines
          Split number 2 Fields  2
          KSP Object:          (coupledsolve_fieldsplit_0_fieldsplit_2_)           1 MPI processes
            type: preonly
            maximum iterations=10000, initial guess is zero
            tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
            left preconditioning
            using NONE norm type for convergence test
          PC Object:          (coupledsolve_fieldsplit_0_fieldsplit_2_)           1 MPI processes
            type: ml
              MG: type is MULTIPLICATIVE, levels=6 cycles=v
                Cycles per PCApply=1
                Using Galerkin computed coarse grid matrices
            Coarse grid solver -- level -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_2_mg_coarse_)               1 MPI processes
                type: preonly
                maximum iterations=1, initial guess is zero
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_2_mg_coarse_)               1 MPI processes
                type: lu
                  LU: out-of-place factorization
                  tolerance for zero pivot 2.22045e-14
                  using diagonal shift on blocks to prevent zero pivot [INBLOCKS]
                  matrix ordering: nd
                  factor fill ratio given 5, needed 1
                    Factored matrix follows:
                      Mat Object:                       1 MPI processes
                        type: seqaij
                        rows=1, cols=1
                        package used to perform factorization: petsc
                        total: nonzeros=1, allocated nonzeros=1
                        total number of mallocs used during MatSetValues calls =0
                          not using I-node routines
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=1, cols=1
                  total: nonzeros=1, allocated nonzeros=1
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Down solver (pre-smoother) on level 1 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_1_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_1_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=4, cols=4
                  total: nonzeros=16, allocated nonzeros=16
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 1 nodes, limit used is 5
            Up solver (post-smoother) same as down solver (pre-smoother)
            Down solver (pre-smoother) on level 2 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_2_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_2_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=105, cols=105
                  total: nonzeros=3963, allocated nonzeros=3963
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Up solver (post-smoother) same as down solver (pre-smoother)
            Down solver (pre-smoother) on level 3 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_3_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_3_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=6667, cols=6667
                  total: nonzeros=356943, allocated nonzeros=356943
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Up solver (post-smoother) same as down solver (pre-smoother)
            Down solver (pre-smoother) on level 4 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_4_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_4_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                 1 MPI processes
                  type: seqaij
                  rows=263552, cols=263552
                  total: nonzeros=7.74159e+06, allocated nonzeros=7.74159e+06
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Up solver (post-smoother) same as down solver (pre-smoother)
            Down solver (pre-smoother) on level 5 -------------------------------
              KSP Object:              (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_5_)               1 MPI processes
                type: richardson
                  Richardson: damping factor=1
                maximum iterations=2
                tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                left preconditioning
                using nonzero initial guess
                using NONE norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_5_)               1 MPI processes
                type: sor
                  SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                linear system matrix = precond matrix:
                Mat Object:                (coupledsolve_fieldsplit_0_fieldsplit_2_)                 1 MPI processes
                  type: seqaij
                  rows=2197000, cols=2197000
                  total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            Up solver (post-smoother) same as down solver (pre-smoother)
            linear system matrix = precond matrix:
            Mat Object:            (coupledsolve_fieldsplit_0_fieldsplit_2_)             1 MPI processes
              type: seqaij
              rows=2197000, cols=2197000
              total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
              total number of mallocs used during MatSetValues calls =0
                not using I-node routines
        linear system matrix = precond matrix:
        Mat Object:        (coupledsolve_fieldsplit_0_)         1 MPI processes
          type: seqaij
          rows=6591000, cols=6591000
          total: nonzeros=4.40448e+07, allocated nonzeros=4.40448e+07
          total number of mallocs used during MatSetValues calls =0
            not using I-node routines
    KSP solver for S = A11 - A10 inv(A00) A01 
      KSP Object:      (coupledsolve_fieldsplit_1_)       1 MPI processes
        type: gmres
          GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
          GMRES: happy breakdown tolerance 1e-30
        maximum iterations=10000, initial guess is zero
        tolerances:  relative=0.1, absolute=1e-50, divergence=10000
        left preconditioning
        using PRECONDITIONED norm type for convergence test
      PC Object:      (coupledsolve_fieldsplit_1_)       1 MPI processes
        type: ilu
          ILU: out-of-place factorization
          0 levels of fill
          tolerance for zero pivot 2.22045e-14
          using diagonal shift on blocks to prevent zero pivot [INBLOCKS]
          matrix ordering: natural
          factor fill ratio given 1, needed 1
            Factored matrix follows:
              Mat Object:               1 MPI processes
                type: seqaij
                rows=2197000, cols=2197000
                package used to perform factorization: petsc
                total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
                total number of mallocs used during MatSetValues calls =0
                  not using I-node routines
        linear system matrix followed by preconditioner matrix:
        Mat Object:        (coupledsolve_fieldsplit_1_)         1 MPI processes
          type: schurcomplement
          rows=2197000, cols=2197000
            Schur complement A11 - A10 inv(A00) A01
            A11
              Mat Object:              (coupledsolve_fieldsplit_1_)               1 MPI processes
                type: seqaij
                rows=2197000, cols=2197000
                total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
                total number of mallocs used during MatSetValues calls =0
                  not using I-node routines
            A10
              Mat Object:               1 MPI processes
                type: seqaij
                rows=2197000, cols=6591000
                total: nonzeros=4.37453e+07, allocated nonzeros=4.37453e+07
                total number of mallocs used during MatSetValues calls =0
                  not using I-node routines
            KSP of A00
              KSP Object:              (coupledsolve_fieldsplit_0_)               1 MPI processes
                type: gmres
                  GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement
                  GMRES: happy breakdown tolerance 1e-30
                maximum iterations=10000, initial guess is zero
                tolerances:  relative=0.01, absolute=1e-50, divergence=10000
                left preconditioning
                using PRECONDITIONED norm type for convergence test
              PC Object:              (coupledsolve_fieldsplit_0_)               1 MPI processes
                type: fieldsplit
                  FieldSplit with MULTIPLICATIVE composition: total splits = 3, blocksize = 3
                  Solver info for each split is in the following KSP objects:
                  Split number 0 Fields  0
                  KSP Object:                  (coupledsolve_fieldsplit_0_fieldsplit_0_)                   1 MPI processes
                    type: preonly
                    maximum iterations=10000, initial guess is zero
                    tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                    left preconditioning
                    using NONE norm type for convergence test
                  PC Object:                  (coupledsolve_fieldsplit_0_fieldsplit_0_)                   1 MPI processes
                    type: ml
                      MG: type is MULTIPLICATIVE, levels=6 cycles=v
                        Cycles per PCApply=1
                        Using Galerkin computed coarse grid matrices
                    Coarse grid solver -- level -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_0_mg_coarse_)                       1 MPI processes
                        type: preonly
                        maximum iterations=1, initial guess is zero
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_0_mg_coarse_)                       1 MPI processes
                        type: lu
                          LU: out-of-place factorization
                          tolerance for zero pivot 2.22045e-14
                          using diagonal shift on blocks to prevent zero pivot [INBLOCKS]
                          matrix ordering: nd
                          factor fill ratio given 5, needed 1
                            Factored matrix follows:
                              Mat Object:                               1 MPI processes
                                type: seqaij
                                rows=1, cols=1
                                package used to perform factorization: petsc
                                total: nonzeros=1, allocated nonzeros=1
                                total number of mallocs used during MatSetValues calls =0
                                  not using I-node routines
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=1, cols=1
                          total: nonzeros=1, allocated nonzeros=1
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Down solver (pre-smoother) on level 1 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_1_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_1_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=4, cols=4
                          total: nonzeros=16, allocated nonzeros=16
                          total number of mallocs used during MatSetValues calls =0
                            using I-node routines: found 1 nodes, limit used is 5
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    Down solver (pre-smoother) on level 2 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_2_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_2_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=105, cols=105
                          total: nonzeros=3963, allocated nonzeros=3963
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    Down solver (pre-smoother) on level 3 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_3_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_3_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=6667, cols=6667
                          total: nonzeros=356943, allocated nonzeros=356943
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    Down solver (pre-smoother) on level 4 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_4_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_4_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=263552, cols=263552
                          total: nonzeros=7.74159e+06, allocated nonzeros=7.74159e+06
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    Down solver (pre-smoother) on level 5 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_5_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_0_mg_levels_5_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                        (coupledsolve_fieldsplit_0_fieldsplit_0_)                         1 MPI processes
                          type: seqaij
                          rows=2197000, cols=2197000
                          total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    linear system matrix = precond matrix:
                    Mat Object:                    (coupledsolve_fieldsplit_0_fieldsplit_0_)                     1 MPI processes
                      type: seqaij
                      rows=2197000, cols=2197000
                      total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
                      total number of mallocs used during MatSetValues calls =0
                        not using I-node routines
                  Split number 1 Fields  1
                  KSP Object:                  (coupledsolve_fieldsplit_0_fieldsplit_1_)                   1 MPI processes
                    type: preonly
                    maximum iterations=10000, initial guess is zero
                    tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                    left preconditioning
                    using NONE norm type for convergence test
                  PC Object:                  (coupledsolve_fieldsplit_0_fieldsplit_1_)                   1 MPI processes
                    type: ml
                      MG: type is MULTIPLICATIVE, levels=6 cycles=v
                        Cycles per PCApply=1
                        Using Galerkin computed coarse grid matrices
                    Coarse grid solver -- level -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_1_mg_coarse_)                       1 MPI processes
                        type: preonly
                        maximum iterations=1, initial guess is zero
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_1_mg_coarse_)                       1 MPI processes
                        type: lu
                          LU: out-of-place factorization
                          tolerance for zero pivot 2.22045e-14
                          using diagonal shift on blocks to prevent zero pivot [INBLOCKS]
                          matrix ordering: nd
                          factor fill ratio given 5, needed 1
                            Factored matrix follows:
                              Mat Object:                               1 MPI processes
                                type: seqaij
                                rows=1, cols=1
                                package used to perform factorization: petsc
                                total: nonzeros=1, allocated nonzeros=1
                                total number of mallocs used during MatSetValues calls =0
                                  not using I-node routines
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=1, cols=1
                          total: nonzeros=1, allocated nonzeros=1
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Down solver (pre-smoother) on level 1 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_1_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_1_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=4, cols=4
                          total: nonzeros=16, allocated nonzeros=16
                          total number of mallocs used during MatSetValues calls =0
                            using I-node routines: found 1 nodes, limit used is 5
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    Down solver (pre-smoother) on level 2 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_2_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_2_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=105, cols=105
                          total: nonzeros=3963, allocated nonzeros=3963
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    Down solver (pre-smoother) on level 3 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_3_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_3_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=6667, cols=6667
                          total: nonzeros=356943, allocated nonzeros=356943
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    Down solver (pre-smoother) on level 4 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_4_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_4_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=263552, cols=263552
                          total: nonzeros=7.74159e+06, allocated nonzeros=7.74159e+06
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    Down solver (pre-smoother) on level 5 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_5_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_1_mg_levels_5_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                        (coupledsolve_fieldsplit_0_fieldsplit_1_)                         1 MPI processes
                          type: seqaij
                          rows=2197000, cols=2197000
                          total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    linear system matrix = precond matrix:
                    Mat Object:                    (coupledsolve_fieldsplit_0_fieldsplit_1_)                     1 MPI processes
                      type: seqaij
                      rows=2197000, cols=2197000
                      total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
                      total number of mallocs used during MatSetValues calls =0
                        not using I-node routines
                  Split number 2 Fields  2
                  KSP Object:                  (coupledsolve_fieldsplit_0_fieldsplit_2_)                   1 MPI processes
                    type: preonly
                    maximum iterations=10000, initial guess is zero
                    tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                    left preconditioning
                    using NONE norm type for convergence test
                  PC Object:                  (coupledsolve_fieldsplit_0_fieldsplit_2_)                   1 MPI processes
                    type: ml
                      MG: type is MULTIPLICATIVE, levels=6 cycles=v
                        Cycles per PCApply=1
                        Using Galerkin computed coarse grid matrices
                    Coarse grid solver -- level -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_2_mg_coarse_)                       1 MPI processes
                        type: preonly
                        maximum iterations=1, initial guess is zero
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_2_mg_coarse_)                       1 MPI processes
                        type: lu
                          LU: out-of-place factorization
                          tolerance for zero pivot 2.22045e-14
                          using diagonal shift on blocks to prevent zero pivot [INBLOCKS]
                          matrix ordering: nd
                          factor fill ratio given 5, needed 1
                            Factored matrix follows:
                              Mat Object:                               1 MPI processes
                                type: seqaij
                                rows=1, cols=1
                                package used to perform factorization: petsc
                                total: nonzeros=1, allocated nonzeros=1
                                total number of mallocs used during MatSetValues calls =0
                                  not using I-node routines
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=1, cols=1
                          total: nonzeros=1, allocated nonzeros=1
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Down solver (pre-smoother) on level 1 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_1_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_1_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=4, cols=4
                          total: nonzeros=16, allocated nonzeros=16
                          total number of mallocs used during MatSetValues calls =0
                            using I-node routines: found 1 nodes, limit used is 5
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    Down solver (pre-smoother) on level 2 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_2_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_2_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=105, cols=105
                          total: nonzeros=3963, allocated nonzeros=3963
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    Down solver (pre-smoother) on level 3 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_3_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_3_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=6667, cols=6667
                          total: nonzeros=356943, allocated nonzeros=356943
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    Down solver (pre-smoother) on level 4 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_4_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_4_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                         1 MPI processes
                          type: seqaij
                          rows=263552, cols=263552
                          total: nonzeros=7.74159e+06, allocated nonzeros=7.74159e+06
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    Down solver (pre-smoother) on level 5 -------------------------------
                      KSP Object:                      (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_5_)                       1 MPI processes
                        type: richardson
                          Richardson: damping factor=1
                        maximum iterations=2
                        tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
                        left preconditioning
                        using nonzero initial guess
                        using NONE norm type for convergence test
                      PC Object:                      (coupledsolve_fieldsplit_0_fieldsplit_2_mg_levels_5_)                       1 MPI processes
                        type: sor
                          SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1
                        linear system matrix = precond matrix:
                        Mat Object:                        (coupledsolve_fieldsplit_0_fieldsplit_2_)                         1 MPI processes
                          type: seqaij
                          rows=2197000, cols=2197000
                          total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
                          total number of mallocs used during MatSetValues calls =0
                            not using I-node routines
                    Up solver (post-smoother) same as down solver (pre-smoother)
                    linear system matrix = precond matrix:
                    Mat Object:                    (coupledsolve_fieldsplit_0_fieldsplit_2_)                     1 MPI processes
                      type: seqaij
                      rows=2197000, cols=2197000
                      total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
                      total number of mallocs used during MatSetValues calls =0
                        not using I-node routines
                linear system matrix = precond matrix:
                Mat Object:                (coupledsolve_fieldsplit_0_)                 1 MPI processes
                  type: seqaij
                  rows=6591000, cols=6591000
                  total: nonzeros=4.40448e+07, allocated nonzeros=4.40448e+07
                  total number of mallocs used during MatSetValues calls =0
                    not using I-node routines
            A01
              Mat Object:               1 MPI processes
                type: seqaij
                rows=6591000, cols=2197000
                total: nonzeros=4.37453e+07, allocated nonzeros=4.37453e+07
                total number of mallocs used during MatSetValues calls =0
                  using I-node routines: found 2170168 nodes, limit used is 5
        Mat Object:        (coupledsolve_fieldsplit_1_)         1 MPI processes
          type: seqaij
          rows=2197000, cols=2197000
          total: nonzeros=1.46816e+07, allocated nonzeros=1.46816e+07
          total number of mallocs used during MatSetValues calls =0
            not using I-node routines
  linear system matrix = precond matrix:
  Mat Object:   1 MPI processes
    type: seqaij
    rows=8788000, cols=8788000
    total: nonzeros=1.46217e+08, allocated nonzeros=1.46217e+08
    total number of mallocs used during MatSetValues calls =0
      not using I-node routines
 0000001  0.1000E+01  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 1.028233530004e+04 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 1.606838014009e+00 
 0000002  0.2344E+00  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 5.023800983596e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 7.425469191822e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 3.755849579991e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  3 KSP Residual norm 5.743572058002e-03 
 0000003  0.5924E-01  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.866212850470e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 4.177990847114e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.660417610500e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 3.132317311252e-03 
 0000004  0.2121E-01  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.343607579183e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.875574578166e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 3.584207775217e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.932340791868e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.591545837209e-04 
 0000005  0.5494E-02  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.371702246940e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 3.123261193022e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.306370439136e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.539759362219e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.769178046009e-04 
 0000006  0.2255E-02  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.338827190981e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.973320832166e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.237610611667e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.599425547566e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.867219746999e-04 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  5 KSP Residual norm 6.421260647843e-05 
 0000007  0.5761E-03  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.340189527798e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.996199585312e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.316958897219e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.553781931326e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.836621746595e-04 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  5 KSP Residual norm 6.421110608885e-05 
 0000008  0.2498E-03  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.337586153246e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.984071587460e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.312404640336e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.560118557314e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.844610397581e-04 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  5 KSP Residual norm 6.432302924294e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  6 KSP Residual norm 1.222419066738e-05 
 0000009  0.6187E-04  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.337917307386e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.986690345162e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.318268305495e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.553209668954e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.841345464525e-04 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  5 KSP Residual norm 6.428292062041e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  6 KSP Residual norm 1.222368753058e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  7 KSP Residual norm 1.375577072665e-06 
 0000010  0.2762E-04  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.337739325955e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.986270165904e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.323893440466e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.556775335866e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.846815409723e-04 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  5 KSP Residual norm 6.432816928730e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  6 KSP Residual norm 1.223887358372e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  7 KSP Residual norm 1.379043084412e-06 
 0000011  0.7066E-05  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.337775679923e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.986184744669e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.318965553962e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.554287389364e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.844989110986e-04 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  5 KSP Residual norm 6.432217417272e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  6 KSP Residual norm 1.222905917426e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  7 KSP Residual norm 1.376095357288e-06 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 4
  8 KSP Residual norm 1.503544978257e-07 
 0000012  0.3120E-05  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.337771098018e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.984850895132e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.299992865481e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.543700557738e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.825323062426e-04 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  5 KSP Residual norm 6.412082595270e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  6 KSP Residual norm 1.216648626849e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  7 KSP Residual norm 1.364409498341e-06 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 4
  8 KSP Residual norm 1.487213324224e-07 
 0000013  0.8620E-06  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.337773446173e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.986810561561e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.323978790588e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.556003828193e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.847922642024e-04 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  5 KSP Residual norm 6.433247419446e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  6 KSP Residual norm 1.223084365730e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  7 KSP Residual norm 1.377689534658e-06 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 4
  8 KSP Residual norm 1.505324250977e-07 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  9 KSP Residual norm 1.619232539991e-08 
 0000014  0.3704E-06  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.337773685833e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.986487648392e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.320852529537e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.554903725565e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.846350555775e-04 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  5 KSP Residual norm 6.432444915169e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  6 KSP Residual norm 1.223086617641e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  7 KSP Residual norm 1.377051343103e-06 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 4
  8 KSP Residual norm 1.504441967446e-07 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  9 KSP Residual norm 1.616472685210e-08 
 0000015  0.1094E-06  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.337773332937e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.986023728455e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.316768161054e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.552117009388e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.839757998817e-04 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  5 KSP Residual norm 6.426910696189e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  6 KSP Residual norm 1.222118287831e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  7 KSP Residual norm 1.375320747467e-06 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 4
  8 KSP Residual norm 1.502808448276e-07 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  9 KSP Residual norm 1.614609627040e-08 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 4
 10 KSP Residual norm 3.541413251773e-09 
 0000016  0.4662E-07  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.337773277429e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.985267475687e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.304539520997e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.545819623557e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.829675232413e-04 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  5 KSP Residual norm 6.416772602773e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  6 KSP Residual norm 1.218105119348e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  7 KSP Residual norm 1.367882303005e-06 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 4
  8 KSP Residual norm 1.490864693800e-07 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  9 KSP Residual norm 1.602654189916e-08 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 4
 10 KSP Residual norm 3.542736180343e-09 
 0000017  0.1465E-07  0.0000E+00
  Residual norms for coupledsolve_ solve.
  0 KSP Residual norm 3.337773332735e+02 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  1 KSP Residual norm 2.985366827171e+01 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  2 KSP Residual norm 4.310215432202e-02 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  3 KSP Residual norm 2.549090410787e-03 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  4 KSP Residual norm 6.834130919436e-04 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  5 KSP Residual norm 6.423278758870e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  6 KSP Residual norm 1.220938587219e-05 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  7 KSP Residual norm 1.371836693851e-06 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 4
  8 KSP Residual norm 1.498846959266e-07 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
  9 KSP Residual norm 1.609018063623e-08 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 4
 10 KSP Residual norm 3.554071111304e-09 
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 4
 11 KSP Residual norm 2.396591915816e-09 
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 2
  Linear solve converged due to CONVERGED_RTOL iterations 3
  Linear solve converged due to CONVERGED_RTOL iterations 3
 12 KSP Residual norm 1.947579109991e-09 
 0000018  0.6254E-08  0.0000E+00
TIME FOR CALCULATION:  0.2201E+04
 L2-NORM ERROR U    VELOCITY  2.804052375769966E-005
 L2-NORM ERROR V    VELOCITY  2.790892741001562E-005
 L2-NORM ERROR W    VELOCITY  2.917276753520388E-005
 L2-NORM ERROR ABS. VELOCITY  3.168726795771020E-005
 L2-NORM ERROR      PRESSURE  1.392941064435226E-003
      *** CALCULATION FINISHED - SEE RESULTS ***
************************************************************************************************************************
***             WIDEN YOUR WINDOW TO 120 CHARACTERS.  Use 'enscript -r -fCourier9' to print this document            ***
************************************************************************************************************************

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

./caffa3d.cpld.lnx on a arch-openmpi-opt-intel-hlr-ext named hpb0062 with 1 processor, by gu08vomo Sun Feb 15 19:58:42 2015
Using Petsc Release Version 3.5.3, Jan, 31, 2015 

                         Max       Max/Min        Avg      Total 
Time (sec):           2.230e+03      1.00000   2.230e+03
Objects:              3.157e+03      1.00000   3.157e+03
Flops:                2.167e+12      1.00000   2.167e+12  2.167e+12
Flops/sec:            9.717e+08      1.00000   9.717e+08  9.717e+08
MPI Messages:         0.000e+00      0.00000   0.000e+00  0.000e+00
MPI Message Lengths:  0.000e+00      0.00000   0.000e+00  0.000e+00
MPI Reductions:       0.000e+00      0.00000

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

Summary of Stages:   ----- Time ------  ----- Flops -----  --- Messages ---  -- Message Lengths --  -- Reductions --
                        Avg     %Total     Avg     %Total   counts   %Total     Avg         %Total   counts   %Total 
 0:      Main Stage: 1.0491e+02   4.7%  2.6364e+07   0.0%  0.000e+00   0.0%  0.000e+00        0.0%  0.000e+00   0.0% 
 1:        CPLD_SOL: 2.1255e+03  95.3%  2.1672e+12 100.0%  0.000e+00   0.0%  0.000e+00        0.0%  0.000e+00   0.0% 

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

--- Event Stage 0: Main Stage

ThreadCommRunKer       5 1.0 5.0068e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecNorm                1 1.0 2.3196e-01 1.0 1.76e+07 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0 67  0  0  0    76
VecScale               1 1.0 6.8851e-03 1.0 8.79e+06 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0 33  0  0  0  1276
VecSet               623 1.0 6.3973e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   1  0  0  0  0     0
VecScatterBegin      663 1.0 1.8907e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecNormalize           1 1.0 6.8860e-03 1.0 8.79e+06 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0 33  0  0  0  1276
MatAssemblyBegin      36 1.0 1.2398e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatAssemblyEnd        36 1.0 1.8623e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   2  0  0  0  0     0
MatZeroEntries        18 1.0 1.3840e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   1  0  0  0  0     0
PetscBarrier          72 1.0 5.6267e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0

--- Event Stage 1: CPLD_SOL

VecMDot             1683 1.0 1.5884e+01 1.0 4.20e+10 1.0 0.0e+00 0.0e+00 0.0e+00  1  2  0  0  0   1  2  0  0  0  2642
VecNorm             2293 1.0 7.7025e+00 1.0 2.68e+10 1.0 0.0e+00 0.0e+00 0.0e+00  0  1  0  0  0   0  1  0  0  0  3483
VecScale            6102 1.0 1.6482e+01 1.0 2.17e+10 1.0 0.0e+00 0.0e+00 0.0e+00  1  1  0  0  0   1  1  0  0  0  1314
VecCopy              610 1.0 3.1824e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecSet             44223 1.0 2.0095e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  1  0  0  0  0   1  0  0  0  0     0
VecAXPY              610 1.0 4.4378e+00 1.0 7.21e+09 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0  1624
VecAYPX            25245 1.0 1.4943e+01 1.0 1.25e+10 1.0 0.0e+00 0.0e+00 0.0e+00  1  1  0  0  0   1  1  0  0  0   834
VecMAXPY            2275 1.0 2.5839e+01 1.0 6.16e+10 1.0 0.0e+00 0.0e+00 0.0e+00  1  3  0  0  0   1  3  0  0  0  2384
VecScatterBegin    10550 1.0 6.0145e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  3  0  0  0  0   3  0  0  0  0     0
VecNormalize        2144 1.0 1.6139e+01 1.0 3.63e+10 1.0 0.0e+00 0.0e+00 0.0e+00  1  2  0  0  0   1  2  0  0  0  2250
MatMult            15110 1.0 1.4587e+03 1.0 1.74e+12 1.0 0.0e+00 0.0e+00 0.0e+00 65 80  0  0  0  69 80  0  0  0  1192
MatMultAdd         25593 1.0 7.8538e+01 1.0 1.00e+11 1.0 0.0e+00 0.0e+00 0.0e+00  4  5  0  0  0   4  5  0  0  0  1274
MatSolve            5510 1.0 1.3219e+01 1.0 1.25e+10 1.0 0.0e+00 0.0e+00 0.0e+00  1  1  0  0  0   1  1  0  0  0   947
MatSOR             50490 1.0 1.2115e+03 1.0 1.27e+12 1.0 0.0e+00 0.0e+00 0.0e+00 54 58  0  0  0  57 58  0  0  0  1045
MatLUFactorSym        54 1.0 3.5882e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatLUFactorNum        72 1.0 1.9253e+00 1.0 8.23e+08 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0   427
MatILUFactorSym        1 1.0 8.5662e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatResidual        25245 1.0 1.4386e+02 1.0 2.30e+11 1.0 0.0e+00 0.0e+00 0.0e+00  6 11  0  0  0   7 11  0  0  0  1599
MatAssemblyBegin     990 1.0 1.5211e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatAssemblyEnd       990 1.0 8.5273e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatGetRowIJ           55 1.0 5.7697e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatGetSubMatrice     180 1.0 3.9237e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  2  0  0  0  0   2  0  0  0  0     0
MatGetOrdering        55 1.0 9.5439e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatZeroEntries        51 1.0 3.1331e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatView               29 1.0 1.4956e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
KSPGMRESOrthog      1683 1.0 3.4213e+01 1.0 8.39e+10 1.0 0.0e+00 0.0e+00 0.0e+00  2  4  0  0  0   2  4  0  0  0  2453
KSPSetUp             432 1.0 1.5358e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
KSPSolve              18 1.0 2.1205e+03 1.0 2.16e+12 1.0 0.0e+00 0.0e+00 0.0e+00 95100  0  0  0 100100  0  0  0  1019
PCSetUp              108 1.0 2.7390e+02 1.0 1.55e+10 1.0 0.0e+00 0.0e+00 0.0e+00 12  1  0  0  0  13  1  0  0  0    57
PCApply              113 1.0 2.0665e+03 1.0 2.11e+12 1.0 0.0e+00 0.0e+00 0.0e+00 93 97  0  0  0  97 97  0  0  0  1019

--- Event Stage 2: Unknown

------------------------------------------------------------------------------------------------------------------------

Memory usage is given in bytes:

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

--- Event Stage 0: Main Stage

              Vector    71            257   4813507096     0
      Vector Scatter     4              8         5216     0
           Index Set    12             30     17599784     0
   IS L to G Mapping     4              3     79093788     0
              Matrix     2             62   6128226616     0
       Krylov Solver     0             25        83112     0
      Preconditioner     0             25        28000     0
    Distributed Mesh     0              1         4448     0
Star Forest Bipartite Graph     0              2         1632     0
     Discrete System     0              1          800     0

--- Event Stage 1: CPLD_SOL

              Vector  1838           1649   6224809880     0
      Vector Scatter     5              0            0     0
           Index Set   270            248       196824     0
              Matrix   876            816   6070886592     0
   Matrix Null Space    18              0            0     0
       Krylov Solver    26              1         1328     0
      Preconditioner    26              1         1016     0
              Viewer     1              0            0     0
    Distributed Mesh     1              0            0     0
Star Forest Bipartite Graph     2              0            0     0
     Discrete System     1              0            0     0

--- Event Stage 2: Unknown

========================================================================================================================
Average time to get PetscTime(): 0
#PETSc Option Table entries:
-coupledsolve_fieldsplit_0_fieldsplit_ksp_type preonly
-coupledsolve_fieldsplit_0_fieldsplit_pc_type ml
-coupledsolve_fieldsplit_0_ksp_rtol 1e-2
-coupledsolve_fieldsplit_0_ksp_type gmres
-coupledsolve_fieldsplit_0_pc_fieldsplit_block_size 3
-coupledsolve_fieldsplit_0_pc_type fieldsplit
-coupledsolve_fieldsplit_1_ksp_rtol 1e-1
-coupledsolve_fieldsplit_1_ksp_type gmres
-coupledsolve_fieldsplit_1_pc_type ilu
-coupledsolve_fieldsplit_ksp_converged_reason
-coupledsolve_fieldsplit_schur_precondition a11
-coupledsolve_ksp_monitor
-coupledsolve_ksp_type fgmres
-coupledsolve_pc_fieldsplit_0_fields 0,1,2
-coupledsolve_pc_fieldsplit_1_fields 3
-coupledsolve_pc_fieldsplit_block_size 4
-coupledsolve_pc_fieldsplit_schur_fact_type lower
-coupledsolve_pc_fieldsplit_type schur
-coupledsolve_pc_type fieldsplit
-log_summary
-on_error_abort
#End of PETSc Option Table entries
Compiled without FORTRAN kernels
Compiled with full precision matrices (default)
sizeof(short) 2 sizeof(int) 4 sizeof(long) 8 sizeof(void*) 8 sizeof(PetscScalar) 8 sizeof(PetscInt) 4
Configure options: PETSC_ARCH=arch-openmpi-opt-intel-hlr-ext PETSC_DIR=/home/gu08vomo/soft/petsc/3.5.3 -prefix=/home/gu08vomo/soft/petsc/3.5.3/build/arch-openmpi-opt-intel-hlr-ext --with-blas-lapack-dir=/shared/apps/intel/2015/composer_xe_2015/mkl/lib/intel64/ --with-mpi-dir=/shared/apps/openmpi/1.8.2_intel COPTFLAGS="-O3 -xHost" FOPTFLAGS="-O3 -xHost" CXXOPTFLAGS="-O3 -xHost" --with-debugging=0 --download-hypre --download-ml
-----------------------------------------
Libraries compiled on Sun Feb  1 16:09:22 2015 on hla0003 
Machine characteristics: Linux-3.0.101-0.40-default-x86_64-with-SuSE-11-x86_64
Using PETSc directory: /home/gu08vomo/soft/petsc/3.5.3
Using PETSc arch: arch-openmpi-opt-intel-hlr-ext
-----------------------------------------

Using C compiler: /shared/apps/openmpi/1.8.2_intel/bin/mpicc  -fPIC -wd1572 -O3 -xHost  ${COPTFLAGS} ${CFLAGS}
Using Fortran compiler: /shared/apps/openmpi/1.8.2_intel/bin/mpif90  -fPIC -O3 -xHost   ${FOPTFLAGS} ${FFLAGS} 
-----------------------------------------

Using include paths: -I/home/gu08vomo/soft/petsc/3.5.3/arch-openmpi-opt-intel-hlr-ext/include -I/home/gu08vomo/soft/petsc/3.5.3/include -I/home/gu08vomo/soft/petsc/3.5.3/include -I/home/gu08vomo/soft/petsc/3.5.3/arch-openmpi-opt-intel-hlr-ext/include -I/shared/apps/openmpi/1.8.2_intel/include
-----------------------------------------

Using C linker: /shared/apps/openmpi/1.8.2_intel/bin/mpicc
Using Fortran linker: /shared/apps/openmpi/1.8.2_intel/bin/mpif90
Using libraries: -Wl,-rpath,/home/gu08vomo/soft/petsc/3.5.3/arch-openmpi-opt-intel-hlr-ext/lib -L/home/gu08vomo/soft/petsc/3.5.3/arch-openmpi-opt-intel-hlr-ext/lib -lpetsc -Wl,-rpath,/home/gu08vomo/soft/petsc/3.5.3/arch-openmpi-opt-intel-hlr-ext/lib -L/home/gu08vomo/soft/petsc/3.5.3/arch-openmpi-opt-intel-hlr-ext/lib -lHYPRE -Wl,-rpath,/shared/apps/openmpi/1.8.2_intel/lib -L/shared/apps/openmpi/1.8.2_intel/lib -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/ipp/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/ipp/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/mkl/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/mkl/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/tbb/lib/intel64/gcc4.4 -L/shared/apps/intel/2015/composer_xe_2015.0.090/tbb/lib/intel64/gcc4.4 -Wl,-rpath,/shared/apps/gcc/4.8.3/lib/gcc/x86_64-unknown-linux-gnu/4.8.3 -L/shared/apps/gcc/4.8.3/lib/gcc/x86_64-unknown-linux-gnu/4.8.3 -Wl,-rpath,/shared/apps/gcc/4.8.3/lib64 -L/shared/apps/gcc/4.8.3/lib64 -Wl,-rpath,/shared/apps/gcc/4.8.3/lib -L/shared/apps/gcc/4.8.3/lib -lmpi_cxx -lml -lmpi_cxx -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015/mkl/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015/mkl/lib/intel64 -lmkl_intel_lp64 -lmkl_sequential -lmkl_core -lpthread -lm -lX11 -lpthread -lssl -lcrypto -lmpi_usempi_ignore_tkr -lmpi_mpifh -lifport -lifcore -lm -lmpi_cxx -ldl -Wl,-rpath,/shared/apps/openmpi/1.8.2_intel/lib -L/shared/apps/openmpi/1.8.2_intel/lib -lmpi -Wl,-rpath,/shared/apps/openmpi/1.8.2_intel/lib -L/shared/apps/openmpi/1.8.2_intel/lib -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/ipp/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/ipp/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/mkl/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/mkl/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/tbb/lib/intel64/gcc4.4 -L/shared/apps/intel/2015/composer_xe_2015.0.090/tbb/lib/intel64/gcc4.4 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -Wl,-rpath,/shared/apps/gcc/4.8.3/lib/gcc/x86_64-unknown-linux-gnu/4.8.3 -L/shared/apps/gcc/4.8.3/lib/gcc/x86_64-unknown-linux-gnu/4.8.3 -Wl,-rpath,/shared/apps/gcc/4.8.3/lib64 -L/shared/apps/gcc/4.8.3/lib64 -Wl,-rpath,/shared/apps/gcc/4.8.3/lib64 -L/shared/apps/gcc/4.8.3/lib64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/ipp/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/ipp/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/mkl/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/mkl/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/tbb/lib/intel64/gcc4.4 -L/shared/apps/intel/2015/composer_xe_2015.0.090/tbb/lib/intel64/gcc4.4 -Wl,-rpath,/shared/apps/gcc/4.8.3/lib -L/shared/apps/gcc/4.8.3/lib -Wl,-rpath,/shared/apps/openmpi/1.8.2_intel/lib -limf -lsvml -lirng -lipgo -ldecimal -lcilkrts -lstdc++ -lgcc_s -lirc -lpthread -lirc_s -Wl,-rpath,/shared/apps/openmpi/1.8.2_intel/lib -L/shared/apps/openmpi/1.8.2_intel/lib -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/ipp/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/ipp/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/mkl/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/mkl/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/tbb/lib/intel64/gcc4.4 -L/shared/apps/intel/2015/composer_xe_2015.0.090/tbb/lib/intel64/gcc4.4 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -Wl,-rpath,/shared/apps/gcc/4.8.3/lib/gcc/x86_64-unknown-linux-gnu/4.8.3 -L/shared/apps/gcc/4.8.3/lib/gcc/x86_64-unknown-linux-gnu/4.8.3 -Wl,-rpath,/shared/apps/gcc/4.8.3/lib64 -L/shared/apps/gcc/4.8.3/lib64 -Wl,-rpath,/shared/apps/gcc/4.8.3/lib64 -L/shared/apps/gcc/4.8.3/lib64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/compiler/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/ipp/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/ipp/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/mkl/lib/intel64 -L/shared/apps/intel/2015/composer_xe_2015.0.090/mkl/lib/intel64 -Wl,-rpath,/shared/apps/intel/2015/composer_xe_2015.0.090/tbb/lib/intel64/gcc4.4 -L/shared/apps/intel/2015/composer_xe_2015.0.090/tbb/lib/intel64/gcc4.4 -Wl,-rpath,/shared/apps/gcc/4.8.3/lib -L/shared/apps/gcc/4.8.3/lib -ldl  
-----------------------------------------



More information about the petsc-users mailing list