[petsc-users] Fieldsplit with sub pc MUMPS in parallel

Karin&NiKo niko.karin at gmail.com
Fri Jan 6 05:17:07 CST 2017


Barry,

you are goddamn right - there was something wrong with the numbering. I
fixed it and look what I get. The residuals of outer iterations are exactly
the same.

Thanks again for your insight and perseverance.

Nicolas

2017-01-05 20:17 GMT+01:00 Barry Smith <bsmith at mcs.anl.gov>:

>
>     This is not good. Something is out of whack.
>
>      First run 1 and 2 processes with -ksp_view_mat binary -ksp_view_rhs
> binary in each case this will generate a file called binaryoutput . Send
> both files to petsc-maint at mcs.anl.gov   I want to confirm that the
> matrices are the same in both cases.
>
>     Barry
>
> > On Jan 5, 2017, at 10:36 AM, Karin&NiKo <niko.karin at gmail.com> wrote:
> >
> > Dave,
> >
> > Indeed the residual histories differ. Concerning the IS's, I have
> checked them on small cases, so that I am quite sure they are OK.
> > What could I do with PETSc to evaluate the ill-conditioning of the
> system or of the sub-systems?
> >
> > Thanks again for your help,
> > Nicolas
> >
> > 2017-01-05 15:46 GMT+01:00 Barry Smith <bsmith at mcs.anl.gov>:
> >
> > > On Jan 5, 2017, at 5:58 AM, Dave May <dave.mayhem23 at gmail.com> wrote:
> > >
> > > Do you now see identical residual histories for a job using 1 rank and
> 4 ranks?
> >
> >    Please send the residual histories with the extra options, I'm
> curious too, because a Krylov method should not be needed in the inner
> solve, I just asked for it so we can see what the residuals look like.
> >
> >    Barry
> >
> > >
> > > If not, I am inclined to believe that the IS's you are defining for
> the splits in the parallel case are incorrect. The operator created to
> approximate the Schur complement with selfp should not depend on  the
> number of ranks.
> > >
> > > Or possibly your problem is horribly I'll-conditioned. If it is, then
> this could result in slightly different residual histories when using
> different numbers of ranks - even if the operators are in fact identical
> > >
> > >
> > > Thanks,
> > >   Dave
> > >
> > >
> > >
> > >
> > > On Thu, 5 Jan 2017 at 12:14, Karin&NiKo <niko.karin at gmail.com> wrote:
> > > Dear Barry, dear Dave,
> > >
> > > THANK YOU!
> > > You two pointed out the right problem.By using the options you
> provided (-fieldsplit_0_ksp_type gmres -fieldsplit_0_ksp_pc_side right
> -fieldsplit_1_ksp_type gmres -fieldsplit_1_ksp_pc_side right), the solver
> converges in 3 iterations whatever the size of the communicator.
> > > All the trick is in the precise resolution of the Schur complement, by
> using a Krylov method (and not only preonly) *and* applying the
> preconditioner on the right (so evaluating the convergence on the
> unpreconditioned residual).
> > >
> > > @Barry : the difference you see on the nonzero allocations for the
> different runs is just an artefact : when using more than one proc, we
> slighly over-estimate the number of non-zero terms. If I run the same
> problem with the -info option, I get extra information :
> > > [2] MatAssemblyEnd_SeqAIJ(): Matrix size: 110 X 110; storage space: 0
> unneeded,5048 used
> > > [1] MatAssemblyEnd_SeqAIJ(): Matrix size: 271 X 271; storage space:
> 4249 unneeded,26167 used
> > > [0] MatAssemblyEnd_SeqAIJ(): Matrix size: 307 X 307; storage space:
> 7988 unneeded,31093 used
> > > [2] MatAssemblyEnd_SeqAIJ(): Matrix size: 110 X 244; storage space: 0
> unneeded,6194 used
> > > [1] MatAssemblyEnd_SeqAIJ(): Matrix size: 271 X 233; storage space:
> 823 unneeded,9975 used
> > > [0] MatAssemblyEnd_SeqAIJ(): Matrix size: 307 X 197; storage space:
> 823 unneeded,8263 used
> > > And 5048+26167+31093+6194+9975+8263=86740 which is the number of
> exactly estimated nonzero terms for 1 proc.
> > >
> > >
> > > Thank you again!
> > >
> > > Best regards,
> > > Nicolas
> > >
> > >
> > > 2017-01-05 1:36 GMT+01:00 Barry Smith <bsmith at mcs.anl.gov>:
> > >
> > >
> > >
> > >    There is something wrong with your set up.
> > >
> > >
> > >
> > >
> > >
> > > 1 process
> > >
> > >
> > >
> > >
> > >
> > >            total: nonzeros=140616, allocated nonzeros=140616
> > >
> > >
> > >           total: nonzeros=68940, allocated nonzeros=68940
> > >
> > >
> > >                 total: nonzeros=3584, allocated nonzeros=3584
> > >
> > >
> > >                 total: nonzeros=1000, allocated nonzeros=1000
> > >
> > >
> > >                 total: nonzeros=8400, allocated nonzeros=8400
> > >
> > >
> > >
> > >
> > >
> > > 2 processes
> > >
> > >
> > >                 total: nonzeros=146498, allocated nonzeros=146498
> > >
> > >
> > >           total: nonzeros=73470, allocated nonzeros=73470
> > >
> > >
> > >                 total: nonzeros=3038, allocated nonzeros=3038
> > >
> > >
> > >                 total: nonzeros=1110, allocated nonzeros=1110
> > >
> > >
> > >                 total: nonzeros=6080, allocated nonzeros=6080
> > >
> > >
> > >                         total: nonzeros=146498, allocated
> nonzeros=146498
> > >
> > >
> > >                   total: nonzeros=73470, allocated nonzeros=73470
> > >
> > >
> > >                 total: nonzeros=6080, allocated nonzeros=6080
> > >
> > >
> > >           total: nonzeros=2846, allocated nonzeros=2846
> > >
> > >
> > >     total: nonzeros=86740, allocated nonzeros=94187
> > >
> > >
> > >
> > >
> > >
> > >   It looks like you are setting up the problem differently in parallel
> and seq. If it is suppose to be an identical problem then the number
> nonzeros should be the same in at least the first two matrices.
> > >
> > >
> > >
> > >
> > >
> > >
> > >
> > >
> > >
> > >
> > >
> > > > On Jan 4, 2017, at 3:39 PM, Karin&NiKo <niko.karin at gmail.com> wrote:
> > >
> > >
> > > >
> > >
> > >
> > > > Dear Petsc team,
> > >
> > >
> > > >
> > >
> > >
> > > > I am (still) trying to solve Biot's poroelasticity problem :
> > >
> > >
> > > >  <image.png>
> > >
> > >
> > > >
> > >
> > >
> > > > I am using a mixed P2-P1 finite element discretization. The matrix
> of the discretized system in binary format is attached to this email.
> > >
> > >
> > > >
> > >
> > >
> > > > I am using the fieldsplit framework to solve the linear system.
> Since I am facing some troubles, I have decided to go back to simple
> things. Here are the options I am using :
> > >
> > >
> > > >
> > >
> > >
> > > > -ksp_rtol 1.0e-5
> > >
> > >
> > > > -ksp_type fgmres
> > >
> > >
> > > > -pc_type fieldsplit
> > >
> > >
> > > > -pc_fieldsplit_schur_factorization_type full
> > >
> > >
> > > > -pc_fieldsplit_type schur
> > >
> > >
> > > > -pc_fieldsplit_schur_precondition selfp
> > >
> > >
> > > > -fieldsplit_0_pc_type lu
> > >
> > >
> > > > -fieldsplit_0_pc_factor_mat_solver_package mumps
> > >
> > >
> > > > -fieldsplit_0_ksp_type preonly
> > >
> > >
> > > > -fieldsplit_0_ksp_converged_reason
> > >
> > >
> > > > -fieldsplit_1_pc_type lu
> > >
> > >
> > > > -fieldsplit_1_pc_factor_mat_solver_package mumps
> > >
> > >
> > > > -fieldsplit_1_ksp_type preonly
> > >
> > >
> > > > -fieldsplit_1_ksp_converged_reason
> > >
> > >
> > > >
> > >
> > >
> > > > On a single proc, everything runs fine : the solver converges in 3
> iterations, according to the theory (see Run-1-proc.txt [contains
> -log_view]).
> > >
> > >
> > > >
> > >
> > >
> > > > On 2 procs, the solver converges in 28 iterations (see
> Run-2-proc.txt).
> > >
> > >
> > > >
> > >
> > >
> > > > On 3 procs, the solver converges in 91 iterations (see
> Run-3-proc.txt).
> > >
> > >
> > > >
> > >
> > >
> > > > I do not understand this behavior : since MUMPS is a parallel direct
> solver, shouldn't the solver converge in max 3 iterations whatever the
> number of procs?
> > >
> > >
> > > >
> > >
> > >
> > > >
> > >
> > >
> > > > Thanks for your precious help,
> > >
> > >
> > > > Nicolas
> > >
> > >
> > > >
> > >
> > >
> > > > <Run-1-proc.txt><Run-2-proc.txt><Run-3-proc.txt><1_Warning.txt>
> > >
> > >
> > >
> > >
> > >
> > >
> > >
> > >
> >
> >
> > <Run-1-proc.txt><Run-2-proc.txt><Run-3-proc.txt><Run-4-proc.txt>
>
>
-------------- next part --------------
An HTML attachment was scrubbed...
URL: <http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20170106/5bf807df/attachment-0001.html>
-------------- next part --------------
  0 KSP unpreconditioned resid norm 2.375592557658e+10 true resid norm 2.375592557658e+10 ||r(i)||/||b|| 1.000000000000e+00
    Residual norms for fieldsplit_1_ solve.
    0 KSP Residual norm 0.000000000000e+00 
  Linear fieldsplit_1_ solve converged due to CONVERGED_ATOL iterations 0
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 1.000000000000e+00 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 1.000000000000e+00 
    1 KSP Residual norm 4.313410630558e-15 
    1 KSP Residual norm 4.313410630558e-15 
  1 KSP unpreconditioned resid norm 6.190344827565e+04 true resid norm 6.190344827565e+04 ||r(i)||/||b|| 2.605810835536e-06
    Residual norms for fieldsplit_1_ solve.
    0 KSP Residual norm 1.000000000000e+00 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.407021980813e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.407021980813e+05 
    1 KSP Residual norm 1.553056052550e-09 
    1 KSP Residual norm 1.553056052550e-09 
    1 KSP Residual norm 1.810321861046e-01 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.443756559170e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.443756559170e+05 
    1 KSP Residual norm 6.852859005090e-10 
    1 KSP Residual norm 6.852859005090e-10 
    2 KSP Residual norm 4.110160641015e-02 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.459077029344e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.459077029344e+05 
    1 KSP Residual norm 3.391519472149e-10 
    1 KSP Residual norm 3.391519472149e-10 
    3 KSP Residual norm 9.399363055282e-03 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.045754196688e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.045754196688e+05 
    1 KSP Residual norm 4.488756555375e-10 
    1 KSP Residual norm 4.488756555375e-10 
    4 KSP Residual norm 1.571092856159e-03 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.162336928973e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.162336928973e+05 
    1 KSP Residual norm 2.684362494425e-10 
    1 KSP Residual norm 2.684362494425e-10 
    5 KSP Residual norm 1.963417150656e-04 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.145763546913e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.145763546913e+05 
    1 KSP Residual norm 1.680082274413e-10 
    1 KSP Residual norm 1.680082274413e-10 
    6 KSP Residual norm 2.086077021964e-05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.507749963975e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.507749963975e+05 
    1 KSP Residual norm 1.773409123937e-10 
    1 KSP Residual norm 1.773409123937e-10 
    7 KSP Residual norm 2.638900162683e-06 
  Linear fieldsplit_1_ solve converged due to CONVERGED_RTOL iterations 7
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.087534725346e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.087534725346e+05 
    1 KSP Residual norm 8.396841831477e-10 
    1 KSP Residual norm 8.396841831477e-10 
  2 KSP unpreconditioned resid norm 1.633570314420e-01 true resid norm 1.633570534028e-01 ||r(i)||/||b|| 6.876476055467e-12
KSP Object: 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=1000, initial guess is zero
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000.
  right preconditioning
  using UNPRECONDITIONED norm type for convergence test
PC Object: 1 MPI processes
  type: fieldsplit
    FieldSplit with Schur preconditioner, factorization UPPER
    Preconditioner for the Schur complement formed from Sp, an assembled approximation to S, which uses (lumped, if requested) A00's diagonal's inverse
    Split info:
    Split number 0 Defined by IS
    Split number 1 Defined by IS
    KSP solver for A00 block
      KSP Object:      (fieldsplit_0_)       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=1e-05, absolute=1e-50, divergence=10000.
        right preconditioning
        using UNPRECONDITIONED norm type for convergence test
      PC Object:      (fieldsplit_0_)       1 MPI processes
        type: lu
          LU: out-of-place factorization
          tolerance for zero pivot 2.22045e-14
          matrix ordering: nd
          factor fill ratio given 0., needed 0.
            Factored matrix follows:
              Mat Object:               1 MPI processes
                type: seqaij
                rows=624, cols=624
                package used to perform factorization: mumps
                total: nonzeros=140616, allocated nonzeros=140616
                total number of mallocs used during MatSetValues calls =0
                  MUMPS run parameters:
                    SYM (matrix type):                   0 
                    PAR (host participation):            1 
                    ICNTL(1) (output for error):         6 
                    ICNTL(2) (output of diagnostic msg): 0 
                    ICNTL(3) (output for global info):   0 
                    ICNTL(4) (level of printing):        0 
                    ICNTL(5) (input mat struct):         0 
                    ICNTL(6) (matrix prescaling):        7 
                    ICNTL(7) (sequentia matrix ordering):7 
                    ICNTL(8) (scalling strategy):        77 
                    ICNTL(10) (max num of refinements):  0 
                    ICNTL(11) (error analysis):          0 
                    ICNTL(12) (efficiency control):                         1 
                    ICNTL(13) (efficiency control):                         0 
                    ICNTL(14) (percentage of estimated workspace increase): 20 
                    ICNTL(18) (input mat struct):                           0 
                    ICNTL(19) (Shur complement info):                       0 
                    ICNTL(20) (rhs sparse pattern):                         0 
                    ICNTL(21) (solution struct):                            0 
                    ICNTL(22) (in-core/out-of-core facility):               0 
                    ICNTL(23) (max size of memory can be allocated locally):0 
                    ICNTL(24) (detection of null pivot rows):               0 
                    ICNTL(25) (computation of a null space basis):          0 
                    ICNTL(26) (Schur options for rhs or solution):          0 
                    ICNTL(27) (experimental parameter):                     -32 
                    ICNTL(28) (use parallel or sequential ordering):        1 
                    ICNTL(29) (parallel ordering):                          0 
                    ICNTL(30) (user-specified set of entries in inv(A)):    0 
                    ICNTL(31) (factors is discarded in the solve phase):    0 
                    ICNTL(33) (compute determinant):                        0 
                    CNTL(1) (relative pivoting threshold):      0.01 
                    CNTL(2) (stopping criterion of refinement): 1.49012e-08 
                    CNTL(3) (absolute pivoting threshold):      0. 
                    CNTL(4) (value of static pivoting):         -1. 
                    CNTL(5) (fixation for null pivots):         0. 
                    RINFO(1) (local estimated flops for the elimination after analysis): 
                      [0] 1.99982e+07 
                    RINFO(2) (local estimated flops for the assembly after factorization): 
                      [0]  153549. 
                    RINFO(3) (local estimated flops for the elimination after factorization): 
                      [0]  1.99982e+07 
                    INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): 
                    [0] 3 
                    INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): 
                      [0] 3 
                    INFO(23) (num of pivots eliminated on this processor after factorization): 
                      [0] 624 
                    RINFOG(1) (global estimated flops for the elimination after analysis): 1.99982e+07 
                    RINFOG(2) (global estimated flops for the assembly after factorization): 153549. 
                    RINFOG(3) (global estimated flops for the elimination after factorization): 1.99982e+07 
                    (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
                    INFOG(3) (estimated real workspace for factors on all processors after analysis): 140616 
                    INFOG(4) (estimated integer workspace for factors on all processors after analysis): 4995 
                    INFOG(5) (estimated maximum front size in the complete tree): 252 
                    INFOG(6) (number of nodes in the complete tree): 23 
                    INFOG(7) (ordering option effectively use after analysis): 2 
                    INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 
                    INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 140616 
                    INFOG(10) (total integer space store the matrix factors after factorization): 4995 
                    INFOG(11) (order of largest frontal matrix after factorization): 252 
                    INFOG(12) (number of off-diagonal pivots): 0 
                    INFOG(13) (number of delayed pivots after factorization): 0 
                    INFOG(14) (number of memory compress after factorization): 0 
                    INFOG(15) (number of steps of iterative refinement after solution): 0 
                    INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 3 
                    INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 3 
                    INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 3 
                    INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 3 
                    INFOG(20) (estimated number of entries in the factors): 140616 
                    INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 3 
                    INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 3 
                    INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 
                    INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 
                    INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 
                    INFOG(28) (after factorization: number of null pivots encountered): 0
                    INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 140616
                    INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 2, 2
                    INFOG(32) (after analysis: type of analysis done): 1
                    INFOG(33) (value used for ICNTL(8)): 7
                    INFOG(34) (exponent of the determinant if determinant is requested): 0
        linear system matrix = precond matrix:
        Mat Object:        (fieldsplit_0_)         1 MPI processes
          type: seqaij
          rows=624, cols=624
          total: nonzeros=68940, allocated nonzeros=68940
          total number of mallocs used during MatSetValues calls =0
            using I-node routines: found 208 nodes, limit used is 5
    KSP solver for S = A11 - A10 inv(A00) A01 
      KSP Object:      (fieldsplit_1_)       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=1e-05, absolute=1e-50, divergence=10000.
        right preconditioning
        using UNPRECONDITIONED norm type for convergence test
      PC Object:      (fieldsplit_1_)       1 MPI processes
        type: lu
          LU: out-of-place factorization
          tolerance for zero pivot 2.22045e-14
          matrix ordering: nd
          factor fill ratio given 0., needed 0.
            Factored matrix follows:
              Mat Object:               1 MPI processes
                type: seqaij
                rows=64, cols=64
                package used to perform factorization: mumps
                total: nonzeros=3584, allocated nonzeros=3584
                total number of mallocs used during MatSetValues calls =0
                  MUMPS run parameters:
                    SYM (matrix type):                   0 
                    PAR (host participation):            1 
                    ICNTL(1) (output for error):         6 
                    ICNTL(2) (output of diagnostic msg): 0 
                    ICNTL(3) (output for global info):   0 
                    ICNTL(4) (level of printing):        0 
                    ICNTL(5) (input mat struct):         0 
                    ICNTL(6) (matrix prescaling):        7 
                    ICNTL(7) (sequentia matrix ordering):7 
                    ICNTL(8) (scalling strategy):        77 
                    ICNTL(10) (max num of refinements):  0 
                    ICNTL(11) (error analysis):          0 
                    ICNTL(12) (efficiency control):                         1 
                    ICNTL(13) (efficiency control):                         0 
                    ICNTL(14) (percentage of estimated workspace increase): 20 
                    ICNTL(18) (input mat struct):                           0 
                    ICNTL(19) (Shur complement info):                       0 
                    ICNTL(20) (rhs sparse pattern):                         0 
                    ICNTL(21) (solution struct):                            0 
                    ICNTL(22) (in-core/out-of-core facility):               0 
                    ICNTL(23) (max size of memory can be allocated locally):0 
                    ICNTL(24) (detection of null pivot rows):               0 
                    ICNTL(25) (computation of a null space basis):          0 
                    ICNTL(26) (Schur options for rhs or solution):          0 
                    ICNTL(27) (experimental parameter):                     -32 
                    ICNTL(28) (use parallel or sequential ordering):        1 
                    ICNTL(29) (parallel ordering):                          0 
                    ICNTL(30) (user-specified set of entries in inv(A)):    0 
                    ICNTL(31) (factors is discarded in the solve phase):    0 
                    ICNTL(33) (compute determinant):                        0 
                    CNTL(1) (relative pivoting threshold):      0.01 
                    CNTL(2) (stopping criterion of refinement): 1.49012e-08 
                    CNTL(3) (absolute pivoting threshold):      0. 
                    CNTL(4) (value of static pivoting):         -1. 
                    CNTL(5) (fixation for null pivots):         0. 
                    RINFO(1) (local estimated flops for the elimination after analysis): 
                      [0] 123808. 
                    RINFO(2) (local estimated flops for the assembly after factorization): 
                      [0]  1024. 
                    RINFO(3) (local estimated flops for the elimination after factorization): 
                      [0]  123808. 
                    INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): 
                    [0] 1 
                    INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): 
                      [0] 1 
                    INFO(23) (num of pivots eliminated on this processor after factorization): 
                      [0] 64 
                    RINFOG(1) (global estimated flops for the elimination after analysis): 123808. 
                    RINFOG(2) (global estimated flops for the assembly after factorization): 1024. 
                    RINFOG(3) (global estimated flops for the elimination after factorization): 123808. 
                    (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
                    INFOG(3) (estimated real workspace for factors on all processors after analysis): 3584 
                    INFOG(4) (estimated integer workspace for factors on all processors after analysis): 222 
                    INFOG(5) (estimated maximum front size in the complete tree): 48 
                    INFOG(6) (number of nodes in the complete tree): 2 
                    INFOG(7) (ordering option effectively use after analysis): 2 
                    INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 
                    INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 3584 
                    INFOG(10) (total integer space store the matrix factors after factorization): 222 
                    INFOG(11) (order of largest frontal matrix after factorization): 48 
                    INFOG(12) (number of off-diagonal pivots): 0 
                    INFOG(13) (number of delayed pivots after factorization): 0 
                    INFOG(14) (number of memory compress after factorization): 0 
                    INFOG(15) (number of steps of iterative refinement after solution): 0 
                    INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 1 
                    INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 1 
                    INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 1 
                    INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 1 
                    INFOG(20) (estimated number of entries in the factors): 3584 
                    INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 1 
                    INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 1 
                    INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 
                    INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 
                    INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 
                    INFOG(28) (after factorization: number of null pivots encountered): 0
                    INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 3584
                    INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 0, 0
                    INFOG(32) (after analysis: type of analysis done): 1
                    INFOG(33) (value used for ICNTL(8)): 7
                    INFOG(34) (exponent of the determinant if determinant is requested): 0
        linear system matrix followed by preconditioner matrix:
        Mat Object:        (fieldsplit_1_)         1 MPI processes
          type: schurcomplement
          rows=64, cols=64
            Schur complement A11 - A10 inv(A00) A01
            A11
              Mat Object:              (fieldsplit_1_)               1 MPI processes
                type: seqaij
                rows=64, cols=64
                total: nonzeros=1000, allocated nonzeros=1000
                total number of mallocs used during MatSetValues calls =0
                  not using I-node routines
            A10
              Mat Object:               1 MPI processes
                type: seqaij
                rows=64, cols=624
                total: nonzeros=8400, allocated nonzeros=8400
                total number of mallocs used during MatSetValues calls =0
                  not using I-node routines
            KSP of A00
              KSP Object:              (fieldsplit_0_)               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=1e-05, absolute=1e-50, divergence=10000.
                right preconditioning
                using UNPRECONDITIONED norm type for convergence test
              PC Object:              (fieldsplit_0_)               1 MPI processes
                type: lu
                  LU: out-of-place factorization
                  tolerance for zero pivot 2.22045e-14
                  matrix ordering: nd
                  factor fill ratio given 0., needed 0.
                    Factored matrix follows:
                      Mat Object:                       1 MPI processes
                        type: seqaij
                        rows=624, cols=624
                        package used to perform factorization: mumps
                        total: nonzeros=140616, allocated nonzeros=140616
                        total number of mallocs used during MatSetValues calls =0
                          MUMPS run parameters:
                            SYM (matrix type):                   0 
                            PAR (host participation):            1 
                            ICNTL(1) (output for error):         6 
                            ICNTL(2) (output of diagnostic msg): 0 
                            ICNTL(3) (output for global info):   0 
                            ICNTL(4) (level of printing):        0 
                            ICNTL(5) (input mat struct):         0 
                            ICNTL(6) (matrix prescaling):        7 
                            ICNTL(7) (sequentia matrix ordering):7 
                            ICNTL(8) (scalling strategy):        77 
                            ICNTL(10) (max num of refinements):  0 
                            ICNTL(11) (error analysis):          0 
                            ICNTL(12) (efficiency control):                         1 
                            ICNTL(13) (efficiency control):                         0 
                            ICNTL(14) (percentage of estimated workspace increase): 20 
                            ICNTL(18) (input mat struct):                           0 
                            ICNTL(19) (Shur complement info):                       0 
                            ICNTL(20) (rhs sparse pattern):                         0 
                            ICNTL(21) (solution struct):                            0 
                            ICNTL(22) (in-core/out-of-core facility):               0 
                            ICNTL(23) (max size of memory can be allocated locally):0 
                            ICNTL(24) (detection of null pivot rows):               0 
                            ICNTL(25) (computation of a null space basis):          0 
                            ICNTL(26) (Schur options for rhs or solution):          0 
                            ICNTL(27) (experimental parameter):                     -32 
                            ICNTL(28) (use parallel or sequential ordering):        1 
                            ICNTL(29) (parallel ordering):                          0 
                            ICNTL(30) (user-specified set of entries in inv(A)):    0 
                            ICNTL(31) (factors is discarded in the solve phase):    0 
                            ICNTL(33) (compute determinant):                        0 
                            CNTL(1) (relative pivoting threshold):      0.01 
                            CNTL(2) (stopping criterion of refinement): 1.49012e-08 
                            CNTL(3) (absolute pivoting threshold):      0. 
                            CNTL(4) (value of static pivoting):         -1. 
                            CNTL(5) (fixation for null pivots):         0. 
                            RINFO(1) (local estimated flops for the elimination after analysis): 
                              [0] 1.99982e+07 
                            RINFO(2) (local estimated flops for the assembly after factorization): 
                              [0]  153549. 
                            RINFO(3) (local estimated flops for the elimination after factorization): 
                              [0]  1.99982e+07 
                            INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): 
                            [0] 3 
                            INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): 
                              [0] 3 
                            INFO(23) (num of pivots eliminated on this processor after factorization): 
                              [0] 624 
                            RINFOG(1) (global estimated flops for the elimination after analysis): 1.99982e+07 
                            RINFOG(2) (global estimated flops for the assembly after factorization): 153549. 
                            RINFOG(3) (global estimated flops for the elimination after factorization): 1.99982e+07 
                            (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
                            INFOG(3) (estimated real workspace for factors on all processors after analysis): 140616 
                            INFOG(4) (estimated integer workspace for factors on all processors after analysis): 4995 
                            INFOG(5) (estimated maximum front size in the complete tree): 252 
                            INFOG(6) (number of nodes in the complete tree): 23 
                            INFOG(7) (ordering option effectively use after analysis): 2 
                            INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 
                            INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 140616 
                            INFOG(10) (total integer space store the matrix factors after factorization): 4995 
                            INFOG(11) (order of largest frontal matrix after factorization): 252 
                            INFOG(12) (number of off-diagonal pivots): 0 
                            INFOG(13) (number of delayed pivots after factorization): 0 
                            INFOG(14) (number of memory compress after factorization): 0 
                            INFOG(15) (number of steps of iterative refinement after solution): 0 
                            INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 3 
                            INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 3 
                            INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 3 
                            INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 3 
                            INFOG(20) (estimated number of entries in the factors): 140616 
                            INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 3 
                            INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 3 
                            INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 
                            INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 
                            INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 
                            INFOG(28) (after factorization: number of null pivots encountered): 0
                            INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 140616
                            INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 2, 2
                            INFOG(32) (after analysis: type of analysis done): 1
                            INFOG(33) (value used for ICNTL(8)): 7
                            INFOG(34) (exponent of the determinant if determinant is requested): 0
                linear system matrix = precond matrix:
                Mat Object:                (fieldsplit_0_)                 1 MPI processes
                  type: seqaij
                  rows=624, cols=624
                  total: nonzeros=68940, allocated nonzeros=68940
                  total number of mallocs used during MatSetValues calls =0
                    using I-node routines: found 208 nodes, limit used is 5
            A01
              Mat Object:               1 MPI processes
                type: seqaij
                rows=624, cols=64
                total: nonzeros=8400, allocated nonzeros=8400
                total number of mallocs used during MatSetValues calls =0
                  using I-node routines: found 208 nodes, limit used is 5
        Mat Object:         1 MPI processes
          type: seqaij
          rows=64, cols=64
          total: nonzeros=2744, allocated nonzeros=2744
          total number of mallocs used during MatSetValues calls =0
            using I-node routines: found 28 nodes, limit used is 5
  linear system matrix = precond matrix:
  Mat Object:   1 MPI processes
    type: seqaij
    rows=688, cols=688
    total: nonzeros=86740, allocated nonzeros=86740
    total number of mallocs used during MatSetValues calls =0
      using I-node routines: found 208 nodes, limit used is 5
-------------- next part --------------
  0 KSP unpreconditioned resid norm 2.375592557658e+10 true resid norm 2.375592557658e+10 ||r(i)||/||b|| 1.000000000000e+00
    Residual norms for fieldsplit_1_ solve.
    0 KSP Residual norm 0.000000000000e+00 
  Linear fieldsplit_1_ solve converged due to CONVERGED_ATOL iterations 0
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 1.000000000000e+00 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 1.000000000000e+00 
    1 KSP Residual norm 5.153232313369e-15 
    1 KSP Residual norm 5.153232313369e-15 
  1 KSP unpreconditioned resid norm 6.190344827565e+04 true resid norm 6.190344827565e+04 ||r(i)||/||b|| 2.605810835536e-06
    Residual norms for fieldsplit_1_ solve.
    0 KSP Residual norm 1.000000000000e+00 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.407021980813e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.407021980813e+05 
    1 KSP Residual norm 1.656008198025e-09 
    1 KSP Residual norm 1.656008198025e-09 
    1 KSP Residual norm 1.810321861046e-01 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.443756559170e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.443756559170e+05 
    1 KSP Residual norm 8.800214973038e-10 
    1 KSP Residual norm 8.800214973038e-10 
    2 KSP Residual norm 4.110160641015e-02 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.459077029344e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.459077029344e+05 
    1 KSP Residual norm 3.905900670485e-10 
    1 KSP Residual norm 3.905900670485e-10 
    3 KSP Residual norm 9.399363055282e-03 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.045754196688e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.045754196688e+05 
    1 KSP Residual norm 5.032293180728e-10 
    1 KSP Residual norm 5.032293180728e-10 
    4 KSP Residual norm 1.571092856159e-03 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.162336928973e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.162336928973e+05 
    1 KSP Residual norm 3.602474304247e-10 
    1 KSP Residual norm 3.602474304247e-10 
    5 KSP Residual norm 1.963417150656e-04 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.145763546913e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.145763546913e+05 
    1 KSP Residual norm 1.976198090797e-10 
    1 KSP Residual norm 1.976198090797e-10 
    6 KSP Residual norm 2.086077021964e-05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.507749963978e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.507749963978e+05 
    1 KSP Residual norm 1.812230342781e-10 
    1 KSP Residual norm 1.812230342781e-10 
    7 KSP Residual norm 2.638900162683e-06 
  Linear fieldsplit_1_ solve converged due to CONVERGED_RTOL iterations 7
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.087534725346e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.087534725346e+05 
    1 KSP Residual norm 8.130910373979e-10 
    1 KSP Residual norm 8.130910373979e-10 
  2 KSP unpreconditioned resid norm 1.633570291986e-01 true resid norm 1.633570660459e-01 ||r(i)||/||b|| 6.876476587674e-12
KSP Object: 2 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=1000, initial guess is zero
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000.
  right preconditioning
  using UNPRECONDITIONED norm type for convergence test
PC Object: 2 MPI processes
  type: fieldsplit
    FieldSplit with Schur preconditioner, factorization UPPER
    Preconditioner for the Schur complement formed from Sp, an assembled approximation to S, which uses (lumped, if requested) A00's diagonal's inverse
    Split info:
    Split number 0 Defined by IS
    Split number 1 Defined by IS
    KSP solver for A00 block
      KSP Object:      (fieldsplit_0_)       2 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=1e-05, absolute=1e-50, divergence=10000.
        right preconditioning
        using UNPRECONDITIONED norm type for convergence test
      PC Object:      (fieldsplit_0_)       2 MPI processes
        type: lu
          LU: out-of-place factorization
          tolerance for zero pivot 2.22045e-14
          matrix ordering: natural
          factor fill ratio given 0., needed 0.
            Factored matrix follows:
              Mat Object:               2 MPI processes
                type: mpiaij
                rows=624, cols=624
                package used to perform factorization: mumps
                total: nonzeros=140616, allocated nonzeros=140616
                total number of mallocs used during MatSetValues calls =0
                  MUMPS run parameters:
                    SYM (matrix type):                   0 
                    PAR (host participation):            1 
                    ICNTL(1) (output for error):         6 
                    ICNTL(2) (output of diagnostic msg): 0 
                    ICNTL(3) (output for global info):   0 
                    ICNTL(4) (level of printing):        0 
                    ICNTL(5) (input mat struct):         0 
                    ICNTL(6) (matrix prescaling):        7 
                    ICNTL(7) (sequentia matrix ordering):7 
                    ICNTL(8) (scalling strategy):        77 
                    ICNTL(10) (max num of refinements):  0 
                    ICNTL(11) (error analysis):          0 
                    ICNTL(12) (efficiency control):                         1 
                    ICNTL(13) (efficiency control):                         0 
                    ICNTL(14) (percentage of estimated workspace increase): 20 
                    ICNTL(18) (input mat struct):                           3 
                    ICNTL(19) (Shur complement info):                       0 
                    ICNTL(20) (rhs sparse pattern):                         0 
                    ICNTL(21) (solution struct):                            1 
                    ICNTL(22) (in-core/out-of-core facility):               0 
                    ICNTL(23) (max size of memory can be allocated locally):0 
                    ICNTL(24) (detection of null pivot rows):               0 
                    ICNTL(25) (computation of a null space basis):          0 
                    ICNTL(26) (Schur options for rhs or solution):          0 
                    ICNTL(27) (experimental parameter):                     -32 
                    ICNTL(28) (use parallel or sequential ordering):        1 
                    ICNTL(29) (parallel ordering):                          0 
                    ICNTL(30) (user-specified set of entries in inv(A)):    0 
                    ICNTL(31) (factors is discarded in the solve phase):    0 
                    ICNTL(33) (compute determinant):                        0 
                    CNTL(1) (relative pivoting threshold):      0.01 
                    CNTL(2) (stopping criterion of refinement): 1.49012e-08 
                    CNTL(3) (absolute pivoting threshold):      0. 
                    CNTL(4) (value of static pivoting):         -1. 
                    CNTL(5) (fixation for null pivots):         0. 
                    RINFO(1) (local estimated flops for the elimination after analysis): 
                      [0] 1.07031e+07 
                      [1] 9.29512e+06 
                    RINFO(2) (local estimated flops for the assembly after factorization): 
                      [0]  61713. 
                      [1]  91836. 
                    RINFO(3) (local estimated flops for the elimination after factorization): 
                      [0]  1.07031e+07 
                      [1]  9.29512e+06 
                    INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): 
                    [0] 7 
                    [1] 7 
                    INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): 
                      [0] 7 
                      [1] 7 
                    INFO(23) (num of pivots eliminated on this processor after factorization): 
                      [0] 249 
                      [1] 375 
                    RINFOG(1) (global estimated flops for the elimination after analysis): 1.99982e+07 
                    RINFOG(2) (global estimated flops for the assembly after factorization): 153549. 
                    RINFOG(3) (global estimated flops for the elimination after factorization): 1.99982e+07 
                    (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
                    INFOG(3) (estimated real workspace for factors on all processors after analysis): 140616 
                    INFOG(4) (estimated integer workspace for factors on all processors after analysis): 4995 
                    INFOG(5) (estimated maximum front size in the complete tree): 252 
                    INFOG(6) (number of nodes in the complete tree): 23 
                    INFOG(7) (ordering option effectively use after analysis): 2 
                    INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 
                    INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 140616 
                    INFOG(10) (total integer space store the matrix factors after factorization): 4995 
                    INFOG(11) (order of largest frontal matrix after factorization): 252 
                    INFOG(12) (number of off-diagonal pivots): 0 
                    INFOG(13) (number of delayed pivots after factorization): 0 
                    INFOG(14) (number of memory compress after factorization): 0 
                    INFOG(15) (number of steps of iterative refinement after solution): 0 
                    INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 7 
                    INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 14 
                    INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 7 
                    INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 14 
                    INFOG(20) (estimated number of entries in the factors): 140616 
                    INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 7 
                    INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 14 
                    INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 
                    INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 
                    INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 
                    INFOG(28) (after factorization: number of null pivots encountered): 0
                    INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 140616
                    INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 1, 2
                    INFOG(32) (after analysis: type of analysis done): 1
                    INFOG(33) (value used for ICNTL(8)): 7
                    INFOG(34) (exponent of the determinant if determinant is requested): 0
        linear system matrix = precond matrix:
        Mat Object:        (fieldsplit_0_)         2 MPI processes
          type: mpiaij
          rows=624, cols=624
          total: nonzeros=68940, allocated nonzeros=68940
          total number of mallocs used during MatSetValues calls =0
            using I-node (on process 0) routines: found 94 nodes, limit used is 5
    KSP solver for S = A11 - A10 inv(A00) A01 
      KSP Object:      (fieldsplit_1_)       2 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=1e-05, absolute=1e-50, divergence=10000.
        right preconditioning
        using UNPRECONDITIONED norm type for convergence test
      PC Object:      (fieldsplit_1_)       2 MPI processes
        type: lu
          LU: out-of-place factorization
          tolerance for zero pivot 2.22045e-14
          matrix ordering: natural
          factor fill ratio given 0., needed 0.
            Factored matrix follows:
              Mat Object:               2 MPI processes
                type: mpiaij
                rows=64, cols=64
                package used to perform factorization: mumps
                total: nonzeros=3584, allocated nonzeros=3584
                total number of mallocs used during MatSetValues calls =0
                  MUMPS run parameters:
                    SYM (matrix type):                   0 
                    PAR (host participation):            1 
                    ICNTL(1) (output for error):         6 
                    ICNTL(2) (output of diagnostic msg): 0 
                    ICNTL(3) (output for global info):   0 
                    ICNTL(4) (level of printing):        0 
                    ICNTL(5) (input mat struct):         0 
                    ICNTL(6) (matrix prescaling):        7 
                    ICNTL(7) (sequentia matrix ordering):7 
                    ICNTL(8) (scalling strategy):        77 
                    ICNTL(10) (max num of refinements):  0 
                    ICNTL(11) (error analysis):          0 
                    ICNTL(12) (efficiency control):                         1 
                    ICNTL(13) (efficiency control):                         0 
                    ICNTL(14) (percentage of estimated workspace increase): 20 
                    ICNTL(18) (input mat struct):                           3 
                    ICNTL(19) (Shur complement info):                       0 
                    ICNTL(20) (rhs sparse pattern):                         0 
                    ICNTL(21) (solution struct):                            1 
                    ICNTL(22) (in-core/out-of-core facility):               0 
                    ICNTL(23) (max size of memory can be allocated locally):0 
                    ICNTL(24) (detection of null pivot rows):               0 
                    ICNTL(25) (computation of a null space basis):          0 
                    ICNTL(26) (Schur options for rhs or solution):          0 
                    ICNTL(27) (experimental parameter):                     -32 
                    ICNTL(28) (use parallel or sequential ordering):        1 
                    ICNTL(29) (parallel ordering):                          0 
                    ICNTL(30) (user-specified set of entries in inv(A)):    0 
                    ICNTL(31) (factors is discarded in the solve phase):    0 
                    ICNTL(33) (compute determinant):                        0 
                    CNTL(1) (relative pivoting threshold):      0.01 
                    CNTL(2) (stopping criterion of refinement): 1.49012e-08 
                    CNTL(3) (absolute pivoting threshold):      0. 
                    CNTL(4) (value of static pivoting):         -1. 
                    CNTL(5) (fixation for null pivots):         0. 
                    RINFO(1) (local estimated flops for the elimination after analysis): 
                      [0] 0. 
                      [1] 123808. 
                    RINFO(2) (local estimated flops for the assembly after factorization): 
                      [0]  0. 
                      [1]  1024. 
                    RINFO(3) (local estimated flops for the elimination after factorization): 
                      [0]  0. 
                      [1]  123808. 
                    INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): 
                    [0] 1 
                    [1] 1 
                    INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): 
                      [0] 1 
                      [1] 1 
                    INFO(23) (num of pivots eliminated on this processor after factorization): 
                      [0] 0 
                      [1] 64 
                    RINFOG(1) (global estimated flops for the elimination after analysis): 123808. 
                    RINFOG(2) (global estimated flops for the assembly after factorization): 1024. 
                    RINFOG(3) (global estimated flops for the elimination after factorization): 123808. 
                    (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
                    INFOG(3) (estimated real workspace for factors on all processors after analysis): 3584 
                    INFOG(4) (estimated integer workspace for factors on all processors after analysis): 222 
                    INFOG(5) (estimated maximum front size in the complete tree): 48 
                    INFOG(6) (number of nodes in the complete tree): 2 
                    INFOG(7) (ordering option effectively use after analysis): 2 
                    INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 
                    INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 3584 
                    INFOG(10) (total integer space store the matrix factors after factorization): 222 
                    INFOG(11) (order of largest frontal matrix after factorization): 48 
                    INFOG(12) (number of off-diagonal pivots): 0 
                    INFOG(13) (number of delayed pivots after factorization): 0 
                    INFOG(14) (number of memory compress after factorization): 0 
                    INFOG(15) (number of steps of iterative refinement after solution): 0 
                    INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 1 
                    INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 2 
                    INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 1 
                    INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 2 
                    INFOG(20) (estimated number of entries in the factors): 3584 
                    INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 1 
                    INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 2 
                    INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 
                    INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 
                    INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 
                    INFOG(28) (after factorization: number of null pivots encountered): 0
                    INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 3584
                    INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 0, 0
                    INFOG(32) (after analysis: type of analysis done): 1
                    INFOG(33) (value used for ICNTL(8)): 7
                    INFOG(34) (exponent of the determinant if determinant is requested): 0
        linear system matrix followed by preconditioner matrix:
        Mat Object:        (fieldsplit_1_)         2 MPI processes
          type: schurcomplement
          rows=64, cols=64
            Schur complement A11 - A10 inv(A00) A01
            A11
              Mat Object:              (fieldsplit_1_)               2 MPI processes
                type: mpiaij
                rows=64, cols=64
                total: nonzeros=1000, allocated nonzeros=1000
                total number of mallocs used during MatSetValues calls =0
                  not using I-node (on process 0) routines
            A10
              Mat Object:               2 MPI processes
                type: mpiaij
                rows=64, cols=624
                total: nonzeros=8400, allocated nonzeros=8400
                total number of mallocs used during MatSetValues calls =0
                  not using I-node (on process 0) routines
            KSP of A00
              KSP Object:              (fieldsplit_0_)               2 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=1e-05, absolute=1e-50, divergence=10000.
                right preconditioning
                using UNPRECONDITIONED norm type for convergence test
              PC Object:              (fieldsplit_0_)               2 MPI processes
                type: lu
                  LU: out-of-place factorization
                  tolerance for zero pivot 2.22045e-14
                  matrix ordering: natural
                  factor fill ratio given 0., needed 0.
                    Factored matrix follows:
                      Mat Object:                       2 MPI processes
                        type: mpiaij
                        rows=624, cols=624
                        package used to perform factorization: mumps
                        total: nonzeros=140616, allocated nonzeros=140616
                        total number of mallocs used during MatSetValues calls =0
                          MUMPS run parameters:
                            SYM (matrix type):                   0 
                            PAR (host participation):            1 
                            ICNTL(1) (output for error):         6 
                            ICNTL(2) (output of diagnostic msg): 0 
                            ICNTL(3) (output for global info):   0 
                            ICNTL(4) (level of printing):        0 
                            ICNTL(5) (input mat struct):         0 
                            ICNTL(6) (matrix prescaling):        7 
                            ICNTL(7) (sequentia matrix ordering):7 
                            ICNTL(8) (scalling strategy):        77 
                            ICNTL(10) (max num of refinements):  0 
                            ICNTL(11) (error analysis):          0 
                            ICNTL(12) (efficiency control):                         1 
                            ICNTL(13) (efficiency control):                         0 
                            ICNTL(14) (percentage of estimated workspace increase): 20 
                            ICNTL(18) (input mat struct):                           3 
                            ICNTL(19) (Shur complement info):                       0 
                            ICNTL(20) (rhs sparse pattern):                         0 
                            ICNTL(21) (solution struct):                            1 
                            ICNTL(22) (in-core/out-of-core facility):               0 
                            ICNTL(23) (max size of memory can be allocated locally):0 
                            ICNTL(24) (detection of null pivot rows):               0 
                            ICNTL(25) (computation of a null space basis):          0 
                            ICNTL(26) (Schur options for rhs or solution):          0 
                            ICNTL(27) (experimental parameter):                     -32 
                            ICNTL(28) (use parallel or sequential ordering):        1 
                            ICNTL(29) (parallel ordering):                          0 
                            ICNTL(30) (user-specified set of entries in inv(A)):    0 
                            ICNTL(31) (factors is discarded in the solve phase):    0 
                            ICNTL(33) (compute determinant):                        0 
                            CNTL(1) (relative pivoting threshold):      0.01 
                            CNTL(2) (stopping criterion of refinement): 1.49012e-08 
                            CNTL(3) (absolute pivoting threshold):      0. 
                            CNTL(4) (value of static pivoting):         -1. 
                            CNTL(5) (fixation for null pivots):         0. 
                            RINFO(1) (local estimated flops for the elimination after analysis): 
                              [0] 1.07031e+07 
                              [1] 9.29512e+06 
                            RINFO(2) (local estimated flops for the assembly after factorization): 
                              [0]  61713. 
                              [1]  91836. 
                            RINFO(3) (local estimated flops for the elimination after factorization): 
                              [0]  1.07031e+07 
                              [1]  9.29512e+06 
                            INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): 
                            [0] 7 
                            [1] 7 
                            INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): 
                              [0] 7 
                              [1] 7 
                            INFO(23) (num of pivots eliminated on this processor after factorization): 
                              [0] 249 
                              [1] 375 
                            RINFOG(1) (global estimated flops for the elimination after analysis): 1.99982e+07 
                            RINFOG(2) (global estimated flops for the assembly after factorization): 153549. 
                            RINFOG(3) (global estimated flops for the elimination after factorization): 1.99982e+07 
                            (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
                            INFOG(3) (estimated real workspace for factors on all processors after analysis): 140616 
                            INFOG(4) (estimated integer workspace for factors on all processors after analysis): 4995 
                            INFOG(5) (estimated maximum front size in the complete tree): 252 
                            INFOG(6) (number of nodes in the complete tree): 23 
                            INFOG(7) (ordering option effectively use after analysis): 2 
                            INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 
                            INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 140616 
                            INFOG(10) (total integer space store the matrix factors after factorization): 4995 
                            INFOG(11) (order of largest frontal matrix after factorization): 252 
                            INFOG(12) (number of off-diagonal pivots): 0 
                            INFOG(13) (number of delayed pivots after factorization): 0 
                            INFOG(14) (number of memory compress after factorization): 0 
                            INFOG(15) (number of steps of iterative refinement after solution): 0 
                            INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 7 
                            INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 14 
                            INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 7 
                            INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 14 
                            INFOG(20) (estimated number of entries in the factors): 140616 
                            INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 7 
                            INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 14 
                            INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 
                            INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 
                            INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 
                            INFOG(28) (after factorization: number of null pivots encountered): 0
                            INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 140616
                            INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 1, 2
                            INFOG(32) (after analysis: type of analysis done): 1
                            INFOG(33) (value used for ICNTL(8)): 7
                            INFOG(34) (exponent of the determinant if determinant is requested): 0
                linear system matrix = precond matrix:
                Mat Object:                (fieldsplit_0_)                 2 MPI processes
                  type: mpiaij
                  rows=624, cols=624
                  total: nonzeros=68940, allocated nonzeros=68940
                  total number of mallocs used during MatSetValues calls =0
                    using I-node (on process 0) routines: found 94 nodes, limit used is 5
            A01
              Mat Object:               2 MPI processes
                type: mpiaij
                rows=624, cols=64
                total: nonzeros=8400, allocated nonzeros=8400
                total number of mallocs used during MatSetValues calls =0
                  using I-node (on process 0) routines: found 94 nodes, limit used is 5
        Mat Object:         2 MPI processes
          type: mpiaij
          rows=64, cols=64
          total: nonzeros=2744, allocated nonzeros=2744
          total number of mallocs used during MatSetValues calls =0
            using I-node (on process 0) routines: found 28 nodes, limit used is 5
  linear system matrix = precond matrix:
  Mat Object:   2 MPI processes
    type: mpiaij
    rows=688, cols=688
    total: nonzeros=86740, allocated nonzeros=86740
    total number of mallocs used during MatSetValues calls =0
      using I-node (on process 0) routines: found 94 nodes, limit used is 5
-------------- next part --------------
  0 KSP unpreconditioned resid norm 2.375592557658e+10 true resid norm 2.375592557658e+10 ||r(i)||/||b|| 1.000000000000e+00
    Residual norms for fieldsplit_1_ solve.
    0 KSP Residual norm 0.000000000000e+00 
  Linear fieldsplit_1_ solve converged due to CONVERGED_ATOL iterations 0
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 1.000000000000e+00 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 1.000000000000e+00 
    1 KSP Residual norm 4.416192634469e-15 
    1 KSP Residual norm 4.416192634469e-15 
  1 KSP unpreconditioned resid norm 6.190344827565e+04 true resid norm 6.190344827565e+04 ||r(i)||/||b|| 2.605810835536e-06
    Residual norms for fieldsplit_1_ solve.
    0 KSP Residual norm 1.000000000000e+00 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.407021980813e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.407021980813e+05 
    1 KSP Residual norm 1.700738199034e-09 
    1 KSP Residual norm 1.700738199034e-09 
    1 KSP Residual norm 1.810321861046e-01 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.443756559170e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.443756559170e+05 
    1 KSP Residual norm 7.962068082549e-10 
    1 KSP Residual norm 7.962068082549e-10 
    2 KSP Residual norm 4.110160641015e-02 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.459077029344e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.459077029344e+05 
    1 KSP Residual norm 3.289249772080e-10 
    1 KSP Residual norm 3.289249772080e-10 
    3 KSP Residual norm 9.399363055282e-03 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.045754196688e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.045754196688e+05 
    1 KSP Residual norm 4.755072958655e-10 
    1 KSP Residual norm 4.755072958655e-10 
    4 KSP Residual norm 1.571092856159e-03 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.162336928973e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.162336928973e+05 
    1 KSP Residual norm 3.150998708365e-10 
    1 KSP Residual norm 3.150998708365e-10 
    5 KSP Residual norm 1.963417150656e-04 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.145763546914e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.145763546914e+05 
    1 KSP Residual norm 1.938942931417e-10 
    1 KSP Residual norm 1.938942931417e-10 
    6 KSP Residual norm 2.086077021964e-05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.507749963998e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.507749963998e+05 
    1 KSP Residual norm 1.928793262485e-10 
    1 KSP Residual norm 1.928793262485e-10 
    7 KSP Residual norm 2.638900162677e-06 
  Linear fieldsplit_1_ solve converged due to CONVERGED_RTOL iterations 7
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.087534725346e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.087534725346e+05 
    1 KSP Residual norm 8.110797351987e-10 
    1 KSP Residual norm 8.110797351987e-10 
  2 KSP unpreconditioned resid norm 1.633570270762e-01 true resid norm 1.633570670086e-01 ||r(i)||/||b|| 6.876476628201e-12
KSP Object: 3 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=1000, initial guess is zero
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000.
  right preconditioning
  using UNPRECONDITIONED norm type for convergence test
PC Object: 3 MPI processes
  type: fieldsplit
    FieldSplit with Schur preconditioner, factorization UPPER
    Preconditioner for the Schur complement formed from Sp, an assembled approximation to S, which uses (lumped, if requested) A00's diagonal's inverse
    Split info:
    Split number 0 Defined by IS
    Split number 1 Defined by IS
    KSP solver for A00 block
      KSP Object:      (fieldsplit_0_)       3 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=1e-05, absolute=1e-50, divergence=10000.
        right preconditioning
        using UNPRECONDITIONED norm type for convergence test
      PC Object:      (fieldsplit_0_)       3 MPI processes
        type: lu
          LU: out-of-place factorization
          tolerance for zero pivot 2.22045e-14
          matrix ordering: natural
          factor fill ratio given 0., needed 0.
            Factored matrix follows:
              Mat Object:               3 MPI processes
                type: mpiaij
                rows=624, cols=624
                package used to perform factorization: mumps
                total: nonzeros=140616, allocated nonzeros=140616
                total number of mallocs used during MatSetValues calls =0
                  MUMPS run parameters:
                    SYM (matrix type):                   0 
                    PAR (host participation):            1 
                    ICNTL(1) (output for error):         6 
                    ICNTL(2) (output of diagnostic msg): 0 
                    ICNTL(3) (output for global info):   0 
                    ICNTL(4) (level of printing):        0 
                    ICNTL(5) (input mat struct):         0 
                    ICNTL(6) (matrix prescaling):        7 
                    ICNTL(7) (sequentia matrix ordering):7 
                    ICNTL(8) (scalling strategy):        77 
                    ICNTL(10) (max num of refinements):  0 
                    ICNTL(11) (error analysis):          0 
                    ICNTL(12) (efficiency control):                         1 
                    ICNTL(13) (efficiency control):                         0 
                    ICNTL(14) (percentage of estimated workspace increase): 20 
                    ICNTL(18) (input mat struct):                           3 
                    ICNTL(19) (Shur complement info):                       0 
                    ICNTL(20) (rhs sparse pattern):                         0 
                    ICNTL(21) (solution struct):                            1 
                    ICNTL(22) (in-core/out-of-core facility):               0 
                    ICNTL(23) (max size of memory can be allocated locally):0 
                    ICNTL(24) (detection of null pivot rows):               0 
                    ICNTL(25) (computation of a null space basis):          0 
                    ICNTL(26) (Schur options for rhs or solution):          0 
                    ICNTL(27) (experimental parameter):                     -32 
                    ICNTL(28) (use parallel or sequential ordering):        1 
                    ICNTL(29) (parallel ordering):                          0 
                    ICNTL(30) (user-specified set of entries in inv(A)):    0 
                    ICNTL(31) (factors is discarded in the solve phase):    0 
                    ICNTL(33) (compute determinant):                        0 
                    CNTL(1) (relative pivoting threshold):      0.01 
                    CNTL(2) (stopping criterion of refinement): 1.49012e-08 
                    CNTL(3) (absolute pivoting threshold):      0. 
                    CNTL(4) (value of static pivoting):         -1. 
                    CNTL(5) (fixation for null pivots):         0. 
                    RINFO(1) (local estimated flops for the elimination after analysis): 
                      [0] 7.17743e+06 
                      [1] 9.83155e+06 
                      [2] 2.98924e+06 
                    RINFO(2) (local estimated flops for the assembly after factorization): 
                      [0]  65835. 
                      [1]  54225. 
                      [2]  33489. 
                    RINFO(3) (local estimated flops for the elimination after factorization): 
                      [0]  7.17743e+06 
                      [1]  9.83155e+06 
                      [2]  2.98924e+06 
                    INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): 
                    [0] 9 
                    [1] 9 
                    [2] 9 
                    INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): 
                      [0] 9 
                      [1] 9 
                      [2] 9 
                    INFO(23) (num of pivots eliminated on this processor after factorization): 
                      [0] 291 
                      [1] 201 
                      [2] 132 
                    RINFOG(1) (global estimated flops for the elimination after analysis): 1.99982e+07 
                    RINFOG(2) (global estimated flops for the assembly after factorization): 153549. 
                    RINFOG(3) (global estimated flops for the elimination after factorization): 1.99982e+07 
                    (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
                    INFOG(3) (estimated real workspace for factors on all processors after analysis): 140616 
                    INFOG(4) (estimated integer workspace for factors on all processors after analysis): 4995 
                    INFOG(5) (estimated maximum front size in the complete tree): 252 
                    INFOG(6) (number of nodes in the complete tree): 23 
                    INFOG(7) (ordering option effectively use after analysis): 2 
                    INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 
                    INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 140616 
                    INFOG(10) (total integer space store the matrix factors after factorization): 4995 
                    INFOG(11) (order of largest frontal matrix after factorization): 252 
                    INFOG(12) (number of off-diagonal pivots): 0 
                    INFOG(13) (number of delayed pivots after factorization): 0 
                    INFOG(14) (number of memory compress after factorization): 0 
                    INFOG(15) (number of steps of iterative refinement after solution): 0 
                    INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 9 
                    INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 27 
                    INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 9 
                    INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 27 
                    INFOG(20) (estimated number of entries in the factors): 140616 
                    INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 9 
                    INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 27 
                    INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 
                    INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 
                    INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 
                    INFOG(28) (after factorization: number of null pivots encountered): 0
                    INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 140616
                    INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 1, 2
                    INFOG(32) (after analysis: type of analysis done): 1
                    INFOG(33) (value used for ICNTL(8)): 7
                    INFOG(34) (exponent of the determinant if determinant is requested): 0
        linear system matrix = precond matrix:
        Mat Object:        (fieldsplit_0_)         3 MPI processes
          type: mpiaij
          rows=624, cols=624
          total: nonzeros=68940, allocated nonzeros=68940
          total number of mallocs used during MatSetValues calls =0
            using I-node (on process 0) routines: found 58 nodes, limit used is 5
    KSP solver for S = A11 - A10 inv(A00) A01 
      KSP Object:      (fieldsplit_1_)       3 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=1e-05, absolute=1e-50, divergence=10000.
        right preconditioning
        using UNPRECONDITIONED norm type for convergence test
      PC Object:      (fieldsplit_1_)       3 MPI processes
        type: lu
          LU: out-of-place factorization
          tolerance for zero pivot 2.22045e-14
          matrix ordering: natural
          factor fill ratio given 0., needed 0.
            Factored matrix follows:
              Mat Object:               3 MPI processes
                type: mpiaij
                rows=64, cols=64
                package used to perform factorization: mumps
                total: nonzeros=3584, allocated nonzeros=3584
                total number of mallocs used during MatSetValues calls =0
                  MUMPS run parameters:
                    SYM (matrix type):                   0 
                    PAR (host participation):            1 
                    ICNTL(1) (output for error):         6 
                    ICNTL(2) (output of diagnostic msg): 0 
                    ICNTL(3) (output for global info):   0 
                    ICNTL(4) (level of printing):        0 
                    ICNTL(5) (input mat struct):         0 
                    ICNTL(6) (matrix prescaling):        7 
                    ICNTL(7) (sequentia matrix ordering):7 
                    ICNTL(8) (scalling strategy):        77 
                    ICNTL(10) (max num of refinements):  0 
                    ICNTL(11) (error analysis):          0 
                    ICNTL(12) (efficiency control):                         1 
                    ICNTL(13) (efficiency control):                         0 
                    ICNTL(14) (percentage of estimated workspace increase): 20 
                    ICNTL(18) (input mat struct):                           3 
                    ICNTL(19) (Shur complement info):                       0 
                    ICNTL(20) (rhs sparse pattern):                         0 
                    ICNTL(21) (solution struct):                            1 
                    ICNTL(22) (in-core/out-of-core facility):               0 
                    ICNTL(23) (max size of memory can be allocated locally):0 
                    ICNTL(24) (detection of null pivot rows):               0 
                    ICNTL(25) (computation of a null space basis):          0 
                    ICNTL(26) (Schur options for rhs or solution):          0 
                    ICNTL(27) (experimental parameter):                     -32 
                    ICNTL(28) (use parallel or sequential ordering):        1 
                    ICNTL(29) (parallel ordering):                          0 
                    ICNTL(30) (user-specified set of entries in inv(A)):    0 
                    ICNTL(31) (factors is discarded in the solve phase):    0 
                    ICNTL(33) (compute determinant):                        0 
                    CNTL(1) (relative pivoting threshold):      0.01 
                    CNTL(2) (stopping criterion of refinement): 1.49012e-08 
                    CNTL(3) (absolute pivoting threshold):      0. 
                    CNTL(4) (value of static pivoting):         -1. 
                    CNTL(5) (fixation for null pivots):         0. 
                    RINFO(1) (local estimated flops for the elimination after analysis): 
                      [0] 0. 
                      [1] 0. 
                      [2] 123808. 
                    RINFO(2) (local estimated flops for the assembly after factorization): 
                      [0]  0. 
                      [1]  0. 
                      [2]  1024. 
                    RINFO(3) (local estimated flops for the elimination after factorization): 
                      [0]  0. 
                      [1]  0. 
                      [2]  123808. 
                    INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): 
                    [0] 1 
                    [1] 1 
                    [2] 1 
                    INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): 
                      [0] 1 
                      [1] 1 
                      [2] 1 
                    INFO(23) (num of pivots eliminated on this processor after factorization): 
                      [0] 0 
                      [1] 0 
                      [2] 64 
                    RINFOG(1) (global estimated flops for the elimination after analysis): 123808. 
                    RINFOG(2) (global estimated flops for the assembly after factorization): 1024. 
                    RINFOG(3) (global estimated flops for the elimination after factorization): 123808. 
                    (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
                    INFOG(3) (estimated real workspace for factors on all processors after analysis): 3584 
                    INFOG(4) (estimated integer workspace for factors on all processors after analysis): 222 
                    INFOG(5) (estimated maximum front size in the complete tree): 48 
                    INFOG(6) (number of nodes in the complete tree): 2 
                    INFOG(7) (ordering option effectively use after analysis): 2 
                    INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 
                    INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 3584 
                    INFOG(10) (total integer space store the matrix factors after factorization): 222 
                    INFOG(11) (order of largest frontal matrix after factorization): 48 
                    INFOG(12) (number of off-diagonal pivots): 0 
                    INFOG(13) (number of delayed pivots after factorization): 0 
                    INFOG(14) (number of memory compress after factorization): 0 
                    INFOG(15) (number of steps of iterative refinement after solution): 0 
                    INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 1 
                    INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 3 
                    INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 1 
                    INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 3 
                    INFOG(20) (estimated number of entries in the factors): 3584 
                    INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 1 
                    INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 3 
                    INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 
                    INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 
                    INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 
                    INFOG(28) (after factorization: number of null pivots encountered): 0
                    INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 3584
                    INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 0, 0
                    INFOG(32) (after analysis: type of analysis done): 1
                    INFOG(33) (value used for ICNTL(8)): 7
                    INFOG(34) (exponent of the determinant if determinant is requested): 0
        linear system matrix followed by preconditioner matrix:
        Mat Object:        (fieldsplit_1_)         3 MPI processes
          type: schurcomplement
          rows=64, cols=64
            Schur complement A11 - A10 inv(A00) A01
            A11
              Mat Object:              (fieldsplit_1_)               3 MPI processes
                type: mpiaij
                rows=64, cols=64
                total: nonzeros=1000, allocated nonzeros=1000
                total number of mallocs used during MatSetValues calls =0
                  not using I-node (on process 0) routines
            A10
              Mat Object:               3 MPI processes
                type: mpiaij
                rows=64, cols=624
                total: nonzeros=8400, allocated nonzeros=8400
                total number of mallocs used during MatSetValues calls =0
                  not using I-node (on process 0) routines
            KSP of A00
              KSP Object:              (fieldsplit_0_)               3 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=1e-05, absolute=1e-50, divergence=10000.
                right preconditioning
                using UNPRECONDITIONED norm type for convergence test
              PC Object:              (fieldsplit_0_)               3 MPI processes
                type: lu
                  LU: out-of-place factorization
                  tolerance for zero pivot 2.22045e-14
                  matrix ordering: natural
                  factor fill ratio given 0., needed 0.
                    Factored matrix follows:
                      Mat Object:                       3 MPI processes
                        type: mpiaij
                        rows=624, cols=624
                        package used to perform factorization: mumps
                        total: nonzeros=140616, allocated nonzeros=140616
                        total number of mallocs used during MatSetValues calls =0
                          MUMPS run parameters:
                            SYM (matrix type):                   0 
                            PAR (host participation):            1 
                            ICNTL(1) (output for error):         6 
                            ICNTL(2) (output of diagnostic msg): 0 
                            ICNTL(3) (output for global info):   0 
                            ICNTL(4) (level of printing):        0 
                            ICNTL(5) (input mat struct):         0 
                            ICNTL(6) (matrix prescaling):        7 
                            ICNTL(7) (sequentia matrix ordering):7 
                            ICNTL(8) (scalling strategy):        77 
                            ICNTL(10) (max num of refinements):  0 
                            ICNTL(11) (error analysis):          0 
                            ICNTL(12) (efficiency control):                         1 
                            ICNTL(13) (efficiency control):                         0 
                            ICNTL(14) (percentage of estimated workspace increase): 20 
                            ICNTL(18) (input mat struct):                           3 
                            ICNTL(19) (Shur complement info):                       0 
                            ICNTL(20) (rhs sparse pattern):                         0 
                            ICNTL(21) (solution struct):                            1 
                            ICNTL(22) (in-core/out-of-core facility):               0 
                            ICNTL(23) (max size of memory can be allocated locally):0 
                            ICNTL(24) (detection of null pivot rows):               0 
                            ICNTL(25) (computation of a null space basis):          0 
                            ICNTL(26) (Schur options for rhs or solution):          0 
                            ICNTL(27) (experimental parameter):                     -32 
                            ICNTL(28) (use parallel or sequential ordering):        1 
                            ICNTL(29) (parallel ordering):                          0 
                            ICNTL(30) (user-specified set of entries in inv(A)):    0 
                            ICNTL(31) (factors is discarded in the solve phase):    0 
                            ICNTL(33) (compute determinant):                        0 
                            CNTL(1) (relative pivoting threshold):      0.01 
                            CNTL(2) (stopping criterion of refinement): 1.49012e-08 
                            CNTL(3) (absolute pivoting threshold):      0. 
                            CNTL(4) (value of static pivoting):         -1. 
                            CNTL(5) (fixation for null pivots):         0. 
                            RINFO(1) (local estimated flops for the elimination after analysis): 
                              [0] 7.17743e+06 
                              [1] 9.83155e+06 
                              [2] 2.98924e+06 
                            RINFO(2) (local estimated flops for the assembly after factorization): 
                              [0]  65835. 
                              [1]  54225. 
                              [2]  33489. 
                            RINFO(3) (local estimated flops for the elimination after factorization): 
                              [0]  7.17743e+06 
                              [1]  9.83155e+06 
                              [2]  2.98924e+06 
                            INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): 
                            [0] 9 
                            [1] 9 
                            [2] 9 
                            INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): 
                              [0] 9 
                              [1] 9 
                              [2] 9 
                            INFO(23) (num of pivots eliminated on this processor after factorization): 
                              [0] 291 
                              [1] 201 
                              [2] 132 
                            RINFOG(1) (global estimated flops for the elimination after analysis): 1.99982e+07 
                            RINFOG(2) (global estimated flops for the assembly after factorization): 153549. 
                            RINFOG(3) (global estimated flops for the elimination after factorization): 1.99982e+07 
                            (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
                            INFOG(3) (estimated real workspace for factors on all processors after analysis): 140616 
                            INFOG(4) (estimated integer workspace for factors on all processors after analysis): 4995 
                            INFOG(5) (estimated maximum front size in the complete tree): 252 
                            INFOG(6) (number of nodes in the complete tree): 23 
                            INFOG(7) (ordering option effectively use after analysis): 2 
                            INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 
                            INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 140616 
                            INFOG(10) (total integer space store the matrix factors after factorization): 4995 
                            INFOG(11) (order of largest frontal matrix after factorization): 252 
                            INFOG(12) (number of off-diagonal pivots): 0 
                            INFOG(13) (number of delayed pivots after factorization): 0 
                            INFOG(14) (number of memory compress after factorization): 0 
                            INFOG(15) (number of steps of iterative refinement after solution): 0 
                            INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 9 
                            INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 27 
                            INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 9 
                            INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 27 
                            INFOG(20) (estimated number of entries in the factors): 140616 
                            INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 9 
                            INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 27 
                            INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 
                            INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 
                            INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 
                            INFOG(28) (after factorization: number of null pivots encountered): 0
                            INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 140616
                            INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 1, 2
                            INFOG(32) (after analysis: type of analysis done): 1
                            INFOG(33) (value used for ICNTL(8)): 7
                            INFOG(34) (exponent of the determinant if determinant is requested): 0
                linear system matrix = precond matrix:
                Mat Object:                (fieldsplit_0_)                 3 MPI processes
                  type: mpiaij
                  rows=624, cols=624
                  total: nonzeros=68940, allocated nonzeros=68940
                  total number of mallocs used during MatSetValues calls =0
                    using I-node (on process 0) routines: found 58 nodes, limit used is 5
            A01
              Mat Object:               3 MPI processes
                type: mpiaij
                rows=624, cols=64
                total: nonzeros=8400, allocated nonzeros=8400
                total number of mallocs used during MatSetValues calls =0
                  using I-node (on process 0) routines: found 58 nodes, limit used is 5
        Mat Object:         3 MPI processes
          type: mpiaij
          rows=64, cols=64
          total: nonzeros=2744, allocated nonzeros=2744
          total number of mallocs used during MatSetValues calls =0
            using I-node (on process 0) routines: found 27 nodes, limit used is 5
  linear system matrix = precond matrix:
  Mat Object:   3 MPI processes
    type: mpiaij
    rows=688, cols=688
    total: nonzeros=86740, allocated nonzeros=86740
    total number of mallocs used during MatSetValues calls =0
      using I-node (on process 0) routines: found 58 nodes, limit used is 5
-------------- next part --------------
  0 KSP unpreconditioned resid norm 2.375592557658e+10 true resid norm 2.375592557658e+10 ||r(i)||/||b|| 1.000000000000e+00
    Residual norms for fieldsplit_1_ solve.
    0 KSP Residual norm 0.000000000000e+00 
  Linear fieldsplit_1_ solve converged due to CONVERGED_ATOL iterations 0
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 1.000000000000e+00 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 1.000000000000e+00 
    1 KSP Residual norm 4.482205480004e-15 
    1 KSP Residual norm 4.482205480004e-15 
  1 KSP unpreconditioned resid norm 6.190344827565e+04 true resid norm 6.190344827565e+04 ||r(i)||/||b|| 2.605810835536e-06
    Residual norms for fieldsplit_1_ solve.
    0 KSP Residual norm 1.000000000000e+00 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.407021980813e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.407021980813e+05 
    1 KSP Residual norm 1.535392735729e-09 
    1 KSP Residual norm 1.535392735729e-09 
    1 KSP Residual norm 1.810321861046e-01 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.443756559170e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.443756559170e+05 
    1 KSP Residual norm 8.820499188125e-10 
    1 KSP Residual norm 8.820499188125e-10 
    2 KSP Residual norm 4.110160641015e-02 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.459077029344e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.459077029344e+05 
    1 KSP Residual norm 3.847344827509e-10 
    1 KSP Residual norm 3.847344827509e-10 
    3 KSP Residual norm 9.399363055282e-03 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.045754196688e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 4.045754196688e+05 
    1 KSP Residual norm 4.971843515516e-10 
    1 KSP Residual norm 4.971843515516e-10 
    4 KSP Residual norm 1.571092856159e-03 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.162336928973e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.162336928973e+05 
    1 KSP Residual norm 3.320224974767e-10 
    1 KSP Residual norm 3.320224974767e-10 
    5 KSP Residual norm 1.963417150656e-04 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.145763546914e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 3.145763546914e+05 
    1 KSP Residual norm 2.070077616994e-10 
    1 KSP Residual norm 2.070077616994e-10 
    6 KSP Residual norm 2.086077021964e-05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.507749963991e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.507749963991e+05 
    1 KSP Residual norm 2.082157055179e-10 
    1 KSP Residual norm 2.082157055179e-10 
    7 KSP Residual norm 2.638900162679e-06 
  Linear fieldsplit_1_ solve converged due to CONVERGED_RTOL iterations 7
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.087534725346e+05 
    Residual norms for fieldsplit_0_ solve.
    0 KSP Residual norm 2.087534725346e+05 
    1 KSP Residual norm 9.092777244907e-10 
    1 KSP Residual norm 9.092777244907e-10 
  2 KSP unpreconditioned resid norm 1.633570323877e-01 true resid norm 1.633570547236e-01 ||r(i)||/||b|| 6.876476111066e-12
KSP Object: 4 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=1000, initial guess is zero
  tolerances:  relative=1e-06, absolute=1e-50, divergence=10000.
  right preconditioning
  using UNPRECONDITIONED norm type for convergence test
PC Object: 4 MPI processes
  type: fieldsplit
    FieldSplit with Schur preconditioner, factorization UPPER
    Preconditioner for the Schur complement formed from Sp, an assembled approximation to S, which uses (lumped, if requested) A00's diagonal's inverse
    Split info:
    Split number 0 Defined by IS
    Split number 1 Defined by IS
    KSP solver for A00 block
      KSP Object:      (fieldsplit_0_)       4 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=1e-05, absolute=1e-50, divergence=10000.
        right preconditioning
        using UNPRECONDITIONED norm type for convergence test
      PC Object:      (fieldsplit_0_)       4 MPI processes
        type: lu
          LU: out-of-place factorization
          tolerance for zero pivot 2.22045e-14
          matrix ordering: natural
          factor fill ratio given 0., needed 0.
            Factored matrix follows:
              Mat Object:               4 MPI processes
                type: mpiaij
                rows=624, cols=624
                package used to perform factorization: mumps
                total: nonzeros=140616, allocated nonzeros=140616
                total number of mallocs used during MatSetValues calls =0
                  MUMPS run parameters:
                    SYM (matrix type):                   0 
                    PAR (host participation):            1 
                    ICNTL(1) (output for error):         6 
                    ICNTL(2) (output of diagnostic msg): 0 
                    ICNTL(3) (output for global info):   0 
                    ICNTL(4) (level of printing):        0 
                    ICNTL(5) (input mat struct):         0 
                    ICNTL(6) (matrix prescaling):        7 
                    ICNTL(7) (sequentia matrix ordering):7 
                    ICNTL(8) (scalling strategy):        77 
                    ICNTL(10) (max num of refinements):  0 
                    ICNTL(11) (error analysis):          0 
                    ICNTL(12) (efficiency control):                         1 
                    ICNTL(13) (efficiency control):                         0 
                    ICNTL(14) (percentage of estimated workspace increase): 20 
                    ICNTL(18) (input mat struct):                           3 
                    ICNTL(19) (Shur complement info):                       0 
                    ICNTL(20) (rhs sparse pattern):                         0 
                    ICNTL(21) (solution struct):                            1 
                    ICNTL(22) (in-core/out-of-core facility):               0 
                    ICNTL(23) (max size of memory can be allocated locally):0 
                    ICNTL(24) (detection of null pivot rows):               0 
                    ICNTL(25) (computation of a null space basis):          0 
                    ICNTL(26) (Schur options for rhs or solution):          0 
                    ICNTL(27) (experimental parameter):                     -32 
                    ICNTL(28) (use parallel or sequential ordering):        1 
                    ICNTL(29) (parallel ordering):                          0 
                    ICNTL(30) (user-specified set of entries in inv(A)):    0 
                    ICNTL(31) (factors is discarded in the solve phase):    0 
                    ICNTL(33) (compute determinant):                        0 
                    CNTL(1) (relative pivoting threshold):      0.01 
                    CNTL(2) (stopping criterion of refinement): 1.49012e-08 
                    CNTL(3) (absolute pivoting threshold):      0. 
                    CNTL(4) (value of static pivoting):         -1. 
                    CNTL(5) (fixation for null pivots):         0. 
                    RINFO(1) (local estimated flops for the elimination after analysis): 
                      [0] 5.99914e+06 
                      [1] 2.55926e+06 
                      [2] 2.03824e+06 
                      [3] 9.40158e+06 
                    RINFO(2) (local estimated flops for the assembly after factorization): 
                      [0]  44154. 
                      [1]  28881. 
                      [2]  30897. 
                      [3]  49617. 
                    RINFO(3) (local estimated flops for the elimination after factorization): 
                      [0]  5.99914e+06 
                      [1]  2.55926e+06 
                      [2]  2.03824e+06 
                      [3]  9.40158e+06 
                    INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): 
                    [0] 11 
                    [1] 11 
                    [2] 11 
                    [3] 12 
                    INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): 
                      [0] 11 
                      [1] 11 
                      [2] 11 
                      [3] 12 
                    INFO(23) (num of pivots eliminated on this processor after factorization): 
                      [0] 315 
                      [1] 84 
                      [2] 72 
                      [3] 153 
                    RINFOG(1) (global estimated flops for the elimination after analysis): 1.99982e+07 
                    RINFOG(2) (global estimated flops for the assembly after factorization): 153549. 
                    RINFOG(3) (global estimated flops for the elimination after factorization): 1.99982e+07 
                    (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
                    INFOG(3) (estimated real workspace for factors on all processors after analysis): 140616 
                    INFOG(4) (estimated integer workspace for factors on all processors after analysis): 4995 
                    INFOG(5) (estimated maximum front size in the complete tree): 252 
                    INFOG(6) (number of nodes in the complete tree): 23 
                    INFOG(7) (ordering option effectively use after analysis): 2 
                    INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 
                    INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 140616 
                    INFOG(10) (total integer space store the matrix factors after factorization): 4995 
                    INFOG(11) (order of largest frontal matrix after factorization): 252 
                    INFOG(12) (number of off-diagonal pivots): 0 
                    INFOG(13) (number of delayed pivots after factorization): 0 
                    INFOG(14) (number of memory compress after factorization): 0 
                    INFOG(15) (number of steps of iterative refinement after solution): 0 
                    INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 12 
                    INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 45 
                    INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 12 
                    INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 45 
                    INFOG(20) (estimated number of entries in the factors): 140616 
                    INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 11 
                    INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 44 
                    INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 
                    INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 
                    INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 
                    INFOG(28) (after factorization: number of null pivots encountered): 0
                    INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 140616
                    INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 1, 2
                    INFOG(32) (after analysis: type of analysis done): 1
                    INFOG(33) (value used for ICNTL(8)): 7
                    INFOG(34) (exponent of the determinant if determinant is requested): 0
        linear system matrix = precond matrix:
        Mat Object:        (fieldsplit_0_)         4 MPI processes
          type: mpiaij
          rows=624, cols=624
          total: nonzeros=68940, allocated nonzeros=68940
          total number of mallocs used during MatSetValues calls =0
            using I-node (on process 0) routines: found 43 nodes, limit used is 5
    KSP solver for S = A11 - A10 inv(A00) A01 
      KSP Object:      (fieldsplit_1_)       4 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=1e-05, absolute=1e-50, divergence=10000.
        right preconditioning
        using UNPRECONDITIONED norm type for convergence test
      PC Object:      (fieldsplit_1_)       4 MPI processes
        type: lu
          LU: out-of-place factorization
          tolerance for zero pivot 2.22045e-14
          matrix ordering: natural
          factor fill ratio given 0., needed 0.
            Factored matrix follows:
              Mat Object:               4 MPI processes
                type: mpiaij
                rows=64, cols=64
                package used to perform factorization: mumps
                total: nonzeros=3584, allocated nonzeros=3584
                total number of mallocs used during MatSetValues calls =0
                  MUMPS run parameters:
                    SYM (matrix type):                   0 
                    PAR (host participation):            1 
                    ICNTL(1) (output for error):         6 
                    ICNTL(2) (output of diagnostic msg): 0 
                    ICNTL(3) (output for global info):   0 
                    ICNTL(4) (level of printing):        0 
                    ICNTL(5) (input mat struct):         0 
                    ICNTL(6) (matrix prescaling):        7 
                    ICNTL(7) (sequentia matrix ordering):7 
                    ICNTL(8) (scalling strategy):        77 
                    ICNTL(10) (max num of refinements):  0 
                    ICNTL(11) (error analysis):          0 
                    ICNTL(12) (efficiency control):                         1 
                    ICNTL(13) (efficiency control):                         0 
                    ICNTL(14) (percentage of estimated workspace increase): 20 
                    ICNTL(18) (input mat struct):                           3 
                    ICNTL(19) (Shur complement info):                       0 
                    ICNTL(20) (rhs sparse pattern):                         0 
                    ICNTL(21) (solution struct):                            1 
                    ICNTL(22) (in-core/out-of-core facility):               0 
                    ICNTL(23) (max size of memory can be allocated locally):0 
                    ICNTL(24) (detection of null pivot rows):               0 
                    ICNTL(25) (computation of a null space basis):          0 
                    ICNTL(26) (Schur options for rhs or solution):          0 
                    ICNTL(27) (experimental parameter):                     -32 
                    ICNTL(28) (use parallel or sequential ordering):        1 
                    ICNTL(29) (parallel ordering):                          0 
                    ICNTL(30) (user-specified set of entries in inv(A)):    0 
                    ICNTL(31) (factors is discarded in the solve phase):    0 
                    ICNTL(33) (compute determinant):                        0 
                    CNTL(1) (relative pivoting threshold):      0.01 
                    CNTL(2) (stopping criterion of refinement): 1.49012e-08 
                    CNTL(3) (absolute pivoting threshold):      0. 
                    CNTL(4) (value of static pivoting):         -1. 
                    CNTL(5) (fixation for null pivots):         0. 
                    RINFO(1) (local estimated flops for the elimination after analysis): 
                      [0] 0. 
                      [1] 0. 
                      [2] 0. 
                      [3] 123808. 
                    RINFO(2) (local estimated flops for the assembly after factorization): 
                      [0]  0. 
                      [1]  0. 
                      [2]  0. 
                      [3]  1024. 
                    RINFO(3) (local estimated flops for the elimination after factorization): 
                      [0]  0. 
                      [1]  0. 
                      [2]  0. 
                      [3]  123808. 
                    INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): 
                    [0] 1 
                    [1] 1 
                    [2] 1 
                    [3] 1 
                    INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): 
                      [0] 1 
                      [1] 1 
                      [2] 1 
                      [3] 1 
                    INFO(23) (num of pivots eliminated on this processor after factorization): 
                      [0] 0 
                      [1] 0 
                      [2] 0 
                      [3] 64 
                    RINFOG(1) (global estimated flops for the elimination after analysis): 123808. 
                    RINFOG(2) (global estimated flops for the assembly after factorization): 1024. 
                    RINFOG(3) (global estimated flops for the elimination after factorization): 123808. 
                    (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
                    INFOG(3) (estimated real workspace for factors on all processors after analysis): 3584 
                    INFOG(4) (estimated integer workspace for factors on all processors after analysis): 222 
                    INFOG(5) (estimated maximum front size in the complete tree): 48 
                    INFOG(6) (number of nodes in the complete tree): 2 
                    INFOG(7) (ordering option effectively use after analysis): 2 
                    INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 
                    INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 3584 
                    INFOG(10) (total integer space store the matrix factors after factorization): 222 
                    INFOG(11) (order of largest frontal matrix after factorization): 48 
                    INFOG(12) (number of off-diagonal pivots): 0 
                    INFOG(13) (number of delayed pivots after factorization): 0 
                    INFOG(14) (number of memory compress after factorization): 0 
                    INFOG(15) (number of steps of iterative refinement after solution): 0 
                    INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 1 
                    INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 4 
                    INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 1 
                    INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 4 
                    INFOG(20) (estimated number of entries in the factors): 3584 
                    INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 1 
                    INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 4 
                    INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 
                    INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 
                    INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 
                    INFOG(28) (after factorization: number of null pivots encountered): 0
                    INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 3584
                    INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 0, 0
                    INFOG(32) (after analysis: type of analysis done): 1
                    INFOG(33) (value used for ICNTL(8)): 7
                    INFOG(34) (exponent of the determinant if determinant is requested): 0
        linear system matrix followed by preconditioner matrix:
        Mat Object:        (fieldsplit_1_)         4 MPI processes
          type: schurcomplement
          rows=64, cols=64
            Schur complement A11 - A10 inv(A00) A01
            A11
              Mat Object:              (fieldsplit_1_)               4 MPI processes
                type: mpiaij
                rows=64, cols=64
                total: nonzeros=1000, allocated nonzeros=1000
                total number of mallocs used during MatSetValues calls =0
                  not using I-node (on process 0) routines
            A10
              Mat Object:               4 MPI processes
                type: mpiaij
                rows=64, cols=624
                total: nonzeros=8400, allocated nonzeros=8400
                total number of mallocs used during MatSetValues calls =0
                  not using I-node (on process 0) routines
            KSP of A00
              KSP Object:              (fieldsplit_0_)               4 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=1e-05, absolute=1e-50, divergence=10000.
                right preconditioning
                using UNPRECONDITIONED norm type for convergence test
              PC Object:              (fieldsplit_0_)               4 MPI processes
                type: lu
                  LU: out-of-place factorization
                  tolerance for zero pivot 2.22045e-14
                  matrix ordering: natural
                  factor fill ratio given 0., needed 0.
                    Factored matrix follows:
                      Mat Object:                       4 MPI processes
                        type: mpiaij
                        rows=624, cols=624
                        package used to perform factorization: mumps
                        total: nonzeros=140616, allocated nonzeros=140616
                        total number of mallocs used during MatSetValues calls =0
                          MUMPS run parameters:
                            SYM (matrix type):                   0 
                            PAR (host participation):            1 
                            ICNTL(1) (output for error):         6 
                            ICNTL(2) (output of diagnostic msg): 0 
                            ICNTL(3) (output for global info):   0 
                            ICNTL(4) (level of printing):        0 
                            ICNTL(5) (input mat struct):         0 
                            ICNTL(6) (matrix prescaling):        7 
                            ICNTL(7) (sequentia matrix ordering):7 
                            ICNTL(8) (scalling strategy):        77 
                            ICNTL(10) (max num of refinements):  0 
                            ICNTL(11) (error analysis):          0 
                            ICNTL(12) (efficiency control):                         1 
                            ICNTL(13) (efficiency control):                         0 
                            ICNTL(14) (percentage of estimated workspace increase): 20 
                            ICNTL(18) (input mat struct):                           3 
                            ICNTL(19) (Shur complement info):                       0 
                            ICNTL(20) (rhs sparse pattern):                         0 
                            ICNTL(21) (solution struct):                            1 
                            ICNTL(22) (in-core/out-of-core facility):               0 
                            ICNTL(23) (max size of memory can be allocated locally):0 
                            ICNTL(24) (detection of null pivot rows):               0 
                            ICNTL(25) (computation of a null space basis):          0 
                            ICNTL(26) (Schur options for rhs or solution):          0 
                            ICNTL(27) (experimental parameter):                     -32 
                            ICNTL(28) (use parallel or sequential ordering):        1 
                            ICNTL(29) (parallel ordering):                          0 
                            ICNTL(30) (user-specified set of entries in inv(A)):    0 
                            ICNTL(31) (factors is discarded in the solve phase):    0 
                            ICNTL(33) (compute determinant):                        0 
                            CNTL(1) (relative pivoting threshold):      0.01 
                            CNTL(2) (stopping criterion of refinement): 1.49012e-08 
                            CNTL(3) (absolute pivoting threshold):      0. 
                            CNTL(4) (value of static pivoting):         -1. 
                            CNTL(5) (fixation for null pivots):         0. 
                            RINFO(1) (local estimated flops for the elimination after analysis): 
                              [0] 5.99914e+06 
                              [1] 2.55926e+06 
                              [2] 2.03824e+06 
                              [3] 9.40158e+06 
                            RINFO(2) (local estimated flops for the assembly after factorization): 
                              [0]  44154. 
                              [1]  28881. 
                              [2]  30897. 
                              [3]  49617. 
                            RINFO(3) (local estimated flops for the elimination after factorization): 
                              [0]  5.99914e+06 
                              [1]  2.55926e+06 
                              [2]  2.03824e+06 
                              [3]  9.40158e+06 
                            INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): 
                            [0] 11 
                            [1] 11 
                            [2] 11 
                            [3] 12 
                            INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): 
                              [0] 11 
                              [1] 11 
                              [2] 11 
                              [3] 12 
                            INFO(23) (num of pivots eliminated on this processor after factorization): 
                              [0] 315 
                              [1] 84 
                              [2] 72 
                              [3] 153 
                            RINFOG(1) (global estimated flops for the elimination after analysis): 1.99982e+07 
                            RINFOG(2) (global estimated flops for the assembly after factorization): 153549. 
                            RINFOG(3) (global estimated flops for the elimination after factorization): 1.99982e+07 
                            (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
                            INFOG(3) (estimated real workspace for factors on all processors after analysis): 140616 
                            INFOG(4) (estimated integer workspace for factors on all processors after analysis): 4995 
                            INFOG(5) (estimated maximum front size in the complete tree): 252 
                            INFOG(6) (number of nodes in the complete tree): 23 
                            INFOG(7) (ordering option effectively use after analysis): 2 
                            INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 
                            INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 140616 
                            INFOG(10) (total integer space store the matrix factors after factorization): 4995 
                            INFOG(11) (order of largest frontal matrix after factorization): 252 
                            INFOG(12) (number of off-diagonal pivots): 0 
                            INFOG(13) (number of delayed pivots after factorization): 0 
                            INFOG(14) (number of memory compress after factorization): 0 
                            INFOG(15) (number of steps of iterative refinement after solution): 0 
                            INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 12 
                            INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 45 
                            INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 12 
                            INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 45 
                            INFOG(20) (estimated number of entries in the factors): 140616 
                            INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 11 
                            INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 44 
                            INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 
                            INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 
                            INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 
                            INFOG(28) (after factorization: number of null pivots encountered): 0
                            INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 140616
                            INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 1, 2
                            INFOG(32) (after analysis: type of analysis done): 1
                            INFOG(33) (value used for ICNTL(8)): 7
                            INFOG(34) (exponent of the determinant if determinant is requested): 0
                linear system matrix = precond matrix:
                Mat Object:                (fieldsplit_0_)                 4 MPI processes
                  type: mpiaij
                  rows=624, cols=624
                  total: nonzeros=68940, allocated nonzeros=68940
                  total number of mallocs used during MatSetValues calls =0
                    using I-node (on process 0) routines: found 43 nodes, limit used is 5
            A01
              Mat Object:               4 MPI processes
                type: mpiaij
                rows=624, cols=64
                total: nonzeros=8400, allocated nonzeros=8400
                total number of mallocs used during MatSetValues calls =0
                  using I-node (on process 0) routines: found 43 nodes, limit used is 5
        Mat Object:         4 MPI processes
          type: mpiaij
          rows=64, cols=64
          total: nonzeros=2744, allocated nonzeros=2744
          total number of mallocs used during MatSetValues calls =0
            using I-node (on process 0) routines: found 23 nodes, limit used is 5
  linear system matrix = precond matrix:
  Mat Object:   4 MPI processes
    type: mpiaij
    rows=688, cols=688
    total: nonzeros=86740, allocated nonzeros=86740
    total number of mallocs used during MatSetValues calls =0
      using I-node (on process 0) routines: found 43 nodes, limit used is 5


More information about the petsc-users mailing list