[petsc-dev] petsc-master bug? "Too many pushes"
Eric Chamberland
Eric.Chamberland at giref.ulaval.ca
Wed Jan 27 08:23:21 CST 2016
Hi,
since dec 15, we compile and test our code with the nightly
"petsc-master" tarball
(http://ftp.mcs.anl.gov/pub/petsc/petsc-master.tar.gz)
and everything was fine until this morning.
I noticed 4 tests in error:
0]PETSC ERROR: --------------------- Error Message
--------------------------------------------------------------
[0]PETSC ERROR: Argument out of range
[0]PETSC ERROR: Too many pushes
[0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html
for trouble shooting.
[0]PETSC ERROR: Petsc Development GIT revision: v3.6.3-2098-g5826409
GIT Date: 2016-01-26 20:32:46 -0600
...
(see full traceback.txt file and kspview.txt file)
If you look at kspview.txt, you will see that the KspView is abruptly
ended at the end of file, at "Factored matrix follows:"
This resolution implies multiple nested matrices, and was running fine
until this morning.
Any ideas? Can you guide me to what to check?
Thanks,
Eric
-------------- next part --------------
[0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[0]PETSC ERROR: Argument out of range
[0]PETSC ERROR: Too many pushes
[0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[0]PETSC ERROR: Petsc Development GIT revision: v3.6.3-2098-g5826409 GIT Date: 2016-01-26 20:32:46 -0600
[0]PETSC ERROR: /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/GIREF/bin/Test.ProblemeGD.dev on a arch-linux2-c-debug named compile by Unknown Wed Jan 27 03:09:57 2016
[0]PETSC ERROR: Configure options --prefix=/opt/petsc-master_debug --with-mpi-compilers=1 --with-make-np=12 --with-shared-libraries=1 --with-mpi-dir=/opt/openmpi-1.6.5_rh6 --with-debugging=yes --with-mkl_pardiso=1 --with-mkl_pardiso-dir=/opt/intel/composerxe/mkl --download-ml=yes --download-mumps=yes --download-superlu=yes --download-superlu_dist=yes --download-parmetis=yes --download-ptscotch=yes --download-metis=yes --download-suitesparse=yes --download-hypre=yes --with-scalapack=1 --with-scalapack-include=/opt/intel/composerxe/mkl/include --with-scalapack-lib="-L/opt/intel/composerxe/mkl/lib/intel64 -lmkl_scalapack_lp64 -lmkl_blacs_openmpi_lp64" --with-blas-lapack-dir=/opt/intel/composerxe/mkl/lib/intel64
[0]PETSC ERROR: #1 PetscViewerPushFormat() line 149 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/sys/classes/viewer/interface/viewa.c
[0]PETSC ERROR: #2 PCView_Factor() line 324 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: #3 PCView_Cholesky() line 73 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/pc/impls/factor/cholesky/cholesky.c
[0]PETSC ERROR: #4 PCView() line 1717 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/pc/interface/precon.c
[0]PETSC ERROR: #5 KSPView() line 213 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/ksp/interface/itcreate.c
[0]PETSC ERROR: #6 MatView_SchurComplement() line 59 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/ksp/utils/schurm.c
[0]PETSC ERROR: #7 MatView() line 886 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/mat/interface/matrix.c
[0]PETSC ERROR: #8 PCView() line 1734 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/pc/interface/precon.c
[0]PETSC ERROR: #9 KSPView() line 213 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/ksp/interface/itcreate.c
[0]PETSC ERROR: #10 PCView_FieldSplit_Schur() line 221 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/pc/impls/fieldsplit/fieldsplit.c
[0]PETSC ERROR: #11 PCView() line 1717 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/pc/interface/precon.c
[0]PETSC ERROR: #12 KSPView() line 213 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/ksp/interface/itcreate.c
[0]PETSC ERROR: #13 MatView_SchurComplement() line 59 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/ksp/utils/schurm.c
[0]PETSC ERROR: #14 MatView() line 886 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/mat/interface/matrix.c
[0]PETSC ERROR: #15 PCView() line 1734 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/pc/interface/precon.c
[0]PETSC ERROR: #16 KSPView() line 213 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/ksp/interface/itcreate.c
[0]PETSC ERROR: #17 PCView_FieldSplit_Schur() line 221 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/pc/impls/fieldsplit/fieldsplit.c
[0]PETSC ERROR: #18 PCView() line 1717 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/pc/interface/precon.c
[0]PETSC ERROR: #19 KSPView() line 213 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/ksp/interface/itcreate.c
[0]PETSC ERROR: #20 PetscObjectView() line 106 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/sys/objects/destroy.c
[0]PETSC ERROR: #21 PetscObjectViewFromOptions() line 2739 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/sys/objects/options.c
[0]PETSC ERROR: #22 KSPSolve() line 822 in /pmi/cmpbib/compilation_BIB_gcc_redhat_petsc-master_debug/COMPILE_AUTO/petsc-master-debug/src/ksp/ksp/interface/itfunc.c
-------------- next part --------------
KSP Object:(systeme_) 1 MPI processes
type: gmres
GMRES: restart=50, using Modified Gram-Schmidt Orthogonalization
GMRES: happy breakdown tolerance 1e-30
maximum iterations=150, initial guess is zero
tolerances: relative=0.001, absolute=1e-18, divergence=1e+08
right preconditioning
using UNPRECONDITIONED norm type for convergence test
PC Object:(systeme_) 1 MPI processes
type: fieldsplit
FieldSplit with Schur preconditioner, factorization FULL
Preconditioner for the Schur complement formed from user provided matrix
Split info:
Split number 0 Defined by IS
Split number 1 Defined by IS
KSP solver for A00 block
KSP Object: (precondHP__HP) 1 MPI processes
type: preonly
maximum iterations=10000, initial guess is zero
tolerances: relative=1e-05, absolute=1e-50, divergence=10000.
left preconditioning
using NONE norm type for convergence test
PC Object: (precondHP__HP) 1 MPI processes
type: fieldsplit
FieldSplit with Schur preconditioner, factorization LOWER
Preconditioner for the Schur complement formed from A11
Split info:
Split number 0 Defined by IS
Split number 1 Defined by IS
KSP solver for A00 block
KSP Object: (cholesky_) 1 MPI processes
type: preonly
maximum iterations=10000, initial guess is zero
tolerances: relative=1e-05, absolute=1e-50, divergence=10000.
left preconditioning
using NONE norm type for convergence test
PC Object: (cholesky_) 1 MPI processes
type: cholesky
Cholesky: 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: 1 MPI processes
type: seqsbaij
rows=16, cols=16
package used to perform factorization: mumps
total: nonzeros=0, allocated nonzeros=16
total number of mallocs used during MatSetValues calls =0
MUMPS run parameters:
SYM (matrix type): 2
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):5
ICNTL(8) (scalling strategy): 77
ICNTL(10) (max num of refinements): 0
ICNTL(11) (error analysis): 0
ICNTL(12) (efficiency control): 0
ICNTL(13) (efficiency control): 0
ICNTL(14) (percentage of estimated workspace increase): 33
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): -24
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] 288.
RINFO(2) (local estimated flops for the assembly after factorization):
[0] 20.
RINFO(3) (local estimated flops for the elimination after factorization):
[0] 288.
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] 16
RINFOG(1) (global estimated flops for the elimination after analysis): 288.
RINFOG(2) (global estimated flops for the assembly after factorization): 20.
RINFOG(3) (global estimated flops for the elimination after factorization): 288.
(RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
INFOG(3) (estimated real workspace for factors on all processors after analysis): 96
INFOG(4) (estimated integer workspace for factors on all processors after analysis): 108
INFOG(5) (estimated maximum front size in the complete tree): 6
INFOG(6) (number of nodes in the complete tree): 4
INFOG(7) (ordering option effectively use after analysis): 5
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): 96
INFOG(10) (total integer space store the matrix factors after factorization): 108
INFOG(11) (order of largest frontal matrix after factorization): 6
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): 64
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): 5
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)): 64
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)): -2
INFOG(34) (exponent of the determinant if determinant is requested): 0
linear system matrix = precond matrix:
Mat Object: (cholesky_) 1 MPI processes
type: seqsbaij
rows=16, cols=16
total: nonzeros=64, allocated nonzeros=64
total number of mallocs used during MatSetValues calls =0
block size is 1
KSP solver for S = A11 - A10 inv(A00) A01
KSP Object: (ssor_) 1 MPI processes
type: preonly
maximum iterations=10000, initial guess is zero
tolerances: relative=1e-05, absolute=1e-50, divergence=10000.
left preconditioning
using NONE norm type for convergence test
PC Object: (ssor_) 1 MPI processes
type: sor
SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1.
linear system matrix followed by preconditioner matrix:
Mat Object: (precondHP__HPfieldsplit_schur_) 1 MPI processes
type: schurcomplement
rows=68, cols=68
Schur complement A11 - A10 inv(A00) A01
A11
Mat Object: (solveurHP__HPfieldsplit_a_11_) 1 MPI processes
type: seqaij
rows=68, cols=68
total: nonzeros=1280, allocated nonzeros=1280
total number of mallocs used during MatSetValues calls =0
using I-node routines: found 28 nodes, limit used is 5
A10
Mat Object: (solveurHP__HPBlocsHDiag_) 1 MPI processes
type: seqaij
rows=68, cols=16
total: nonzeros=389, allocated nonzeros=389
total number of mallocs used during MatSetValues calls =0
using I-node routines: found 26 nodes, limit used is 5
KSP of A00
KSP Object: (cholesky_) 1 MPI processes
type: preonly
maximum iterations=10000, initial guess is zero
tolerances: relative=1e-05, absolute=1e-50, divergence=10000.
left preconditioning
using NONE norm type for convergence test
PC Object: (cholesky_) 1 MPI processes
type: cholesky
Cholesky: 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: 1 MPI processes
type: seqsbaij
rows=16, cols=16
package used to perform factorization: mumps
total: nonzeros=0, allocated nonzeros=16
total number of mallocs used during MatSetValues calls =0
MUMPS run parameters:
SYM (matrix type): 2
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):5
ICNTL(8) (scalling strategy): 77
ICNTL(10) (max num of refinements): 0
ICNTL(11) (error analysis): 0
ICNTL(12) (efficiency control): 0
ICNTL(13) (efficiency control): 0
ICNTL(14) (percentage of estimated workspace increase): 33
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): -24
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] 288.
RINFO(2) (local estimated flops for the assembly after factorization):
[0] 20.
RINFO(3) (local estimated flops for the elimination after factorization):
[0] 288.
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] 16
RINFOG(1) (global estimated flops for the elimination after analysis): 288.
RINFOG(2) (global estimated flops for the assembly after factorization): 20.
RINFOG(3) (global estimated flops for the elimination after factorization): 288.
(RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
INFOG(3) (estimated real workspace for factors on all processors after analysis): 96
INFOG(4) (estimated integer workspace for factors on all processors after analysis): 108
INFOG(5) (estimated maximum front size in the complete tree): 6
INFOG(6) (number of nodes in the complete tree): 4
INFOG(7) (ordering option effectively use after analysis): 5
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): 96
INFOG(10) (total integer space store the matrix factors after factorization): 108
INFOG(11) (order of largest frontal matrix after factorization): 6
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): 64
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): 5
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)): 64
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)): -2
INFOG(34) (exponent of the determinant if determinant is requested): 0
linear system matrix = precond matrix:
Mat Object: (cholesky_) 1 MPI processes
type: seqsbaij
rows=16, cols=16
total: nonzeros=64, allocated nonzeros=64
total number of mallocs used during MatSetValues calls =0
block size is 1
A01
Mat Object: (solveurHP__HPBlocsHDiag_) 1 MPI processes
type: seqaij
rows=16, cols=68
total: nonzeros=389, allocated nonzeros=389
total number of mallocs used during MatSetValues calls =0
using I-node routines: found 8 nodes, limit used is 5
Mat Object: (solveurHP__HPfieldsplit_a_11_) 1 MPI processes
type: seqaij
rows=68, cols=68
total: nonzeros=1280, allocated nonzeros=1280
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: (solveurHP__HP) 1 MPI processes
type: nest
rows=84, cols=84
Matrix object:
type=nest, rows=2, cols=2
MatNest structure:
(0,0) : prefix="cholesky_", type=seqsbaij, rows=16, cols=16
(0,1) : prefix="solveurHP__HPBlocsHDiag_", type=seqaij, rows=16, cols=68
(1,0) : prefix="solveurHP__HPBlocsHDiag_", type=seqaij, rows=68, cols=16
(1,1) : prefix="solveurHP__HPfieldsplit_a_11_", type=seqaij, rows=68, cols=68
KSP solver for S = A11 - A10 inv(A00) A01
KSP Object: (systeme_fieldsplit_lambda_) 1 MPI processes
type: preonly
maximum iterations=10000, initial guess is zero
tolerances: relative=1e-05, absolute=1e-50, divergence=10000.
left preconditioning
using NONE norm type for convergence test
PC Object: (systeme_fieldsplit_lambda_) 1 MPI processes
type: mat
linear system matrix followed by preconditioner matrix:
Mat Object: (systeme_fieldsplit_lambda_) 1 MPI processes
type: schurcomplement
rows=8, cols=8
Schur complement A11 - A10 inv(A00) A01
A11
Mat Object: (systeme_fieldsplit_lambda_) 1 MPI processes
type: seqaij
rows=8, cols=8
total: nonzeros=18, allocated nonzeros=18
total number of mallocs used during MatSetValues calls =0
using I-node routines: found 4 nodes, limit used is 5
A10
Mat Object: () 1 MPI processes
type: seqaij
rows=8, cols=84
total: nonzeros=280, allocated nonzeros=280
total number of mallocs used during MatSetValues calls =0
using I-node routines: found 4 nodes, limit used is 5
KSP of A00
KSP Object: (precondHP__HP) 1 MPI processes
type: preonly
maximum iterations=10000, initial guess is zero
tolerances: relative=1e-05, absolute=1e-50, divergence=10000.
left preconditioning
using NONE norm type for convergence test
PC Object: (precondHP__HP) 1 MPI processes
type: fieldsplit
FieldSplit with Schur preconditioner, factorization LOWER
Preconditioner for the Schur complement formed from A11
Split info:
Split number 0 Defined by IS
Split number 1 Defined by IS
KSP solver for A00 block
KSP Object: (cholesky_) 1 MPI processes
type: preonly
maximum iterations=10000, initial guess is zero
tolerances: relative=1e-05, absolute=1e-50, divergence=10000.
left preconditioning
using NONE norm type for convergence test
PC Object: (cholesky_) 1 MPI processes
type: cholesky
Cholesky: 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: 1 MPI processes
type: seqsbaij
rows=16, cols=16
package used to perform factorization: mumps
total: nonzeros=0, allocated nonzeros=16
total number of mallocs used during MatSetValues calls =0
MUMPS run parameters:
SYM (matrix type): 2
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):5
ICNTL(8) (scalling strategy): 77
ICNTL(10) (max num of refinements): 0
ICNTL(11) (error analysis): 0
ICNTL(12) (efficiency control): 0
ICNTL(13) (efficiency control): 0
ICNTL(14) (percentage of estimated workspace increase): 33
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): -24
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] 288.
RINFO(2) (local estimated flops for the assembly after factorization):
[0] 20.
RINFO(3) (local estimated flops for the elimination after factorization):
[0] 288.
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] 16
RINFOG(1) (global estimated flops for the elimination after analysis): 288.
RINFOG(2) (global estimated flops for the assembly after factorization): 20.
RINFOG(3) (global estimated flops for the elimination after factorization): 288.
(RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0)
INFOG(3) (estimated real workspace for factors on all processors after analysis): 96
INFOG(4) (estimated integer workspace for factors on all processors after analysis): 108
INFOG(5) (estimated maximum front size in the complete tree): 6
INFOG(6) (number of nodes in the complete tree): 4
INFOG(7) (ordering option effectively use after analysis): 5
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): 96
INFOG(10) (total integer space store the matrix factors after factorization): 108
INFOG(11) (order of largest frontal matrix after factorization): 6
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): 64
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): 5
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)): 64
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)): -2
INFOG(34) (exponent of the determinant if determinant is requested): 0
linear system matrix = precond matrix:
Mat Object: (cholesky_) 1 MPI processes
type: seqsbaij
rows=16, cols=16
total: nonzeros=64, allocated nonzeros=64
total number of mallocs used during MatSetValues calls =0
block size is 1
KSP solver for S = A11 - A10 inv(A00) A01
KSP Object: (ssor_) 1 MPI processes
type: preonly
maximum iterations=10000, initial guess is zero
tolerances: relative=1e-05, absolute=1e-50, divergence=10000.
left preconditioning
using NONE norm type for convergence test
PC Object: (ssor_) 1 MPI processes
type: sor
SOR: type = local_symmetric, iterations = 1, local iterations = 1, omega = 1.
linear system matrix followed by preconditioner matrix:
Mat Object: (precondHP__HPfieldsplit_schur_) 1 MPI processes
type: schurcomplement
rows=68, cols=68
Schur complement A11 - A10 inv(A00) A01
A11
Mat Object: (solveurHP__HPfieldsplit_a_11_) 1 MPI processes
type: seqaij
rows=68, cols=68
total: nonzeros=1280, allocated nonzeros=1280
total number of mallocs used during MatSetValues calls =0
using I-node routines: found 28 nodes, limit used is 5
A10
Mat Object: (solveurHP__HPBlocsHDiag_) 1 MPI processes
type: seqaij
rows=68, cols=16
total: nonzeros=389, allocated nonzeros=389
total number of mallocs used during MatSetValues calls =0
using I-node routines: found 26 nodes, limit used is 5
KSP of A00
KSP Object: (cholesky_) 1 MPI processes
type: preonly
maximum iterations=10000, initial guess is zero
tolerances: relative=1e-05, absolute=1e-50, divergence=10000.
left preconditioning
using NONE norm type for convergence test
PC Object: (cholesky_) 1 MPI processes
type: cholesky
Cholesky: out-of-place factorization
tolerance for zero pivot 2.22045e-14
matrix ordering: natural
factor fill ratio given 0., needed 0.
Factored matrix follows:
WARNING! There are options you set that were not used!
WARNING! could be spelling mistake, etc!
More information about the petsc-dev
mailing list