[petsc-users] [0]PETSC ERROR: Zero pivot in LU factorization:

Barry Smith bsmith at mcs.anl.gov
Sun May 3 13:36:19 CDT 2015


   There is some mixup between your complex and real build and the test examples. When ex19 fails it prints 

> [0]PETSC ERROR: Configure options PETSC_DIR=/home/tsariysk/MFEMv3/tars/petsc-3.5.3 PETSC_ARCH=petsc-complex-dbg --prefix=/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-complex-dbg --with-cc=mpicc --with-cxx=mpicxx --with-fc=mpif90 --CFLAGS=-O --with-x --with-precision=double --with-scalar-type=complex --with-clanguage=c++ --with-debugger=gdb --with-debugging --with-fortran-datatypes=1 --with-blas-lapack-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-hdf5-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-metis-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-parmetis-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-cgns-dir=/home/tsariysk/MFEMv3/pkgs/cgns --with-valgrind=1

  note all the petsc-complex-dbg. Yet it was built allegedly with the real version so should not list these things.  I cannot explain how it got into this state.

   I would start all over again with a minimal set of configure options: no CFLAGS, no --with-clanguage no hypre, metis, parmetis, 

  Barry


> On May 3, 2015, at 1:15 PM, Ted Sariyski <tsariysk at craft-tech.com> wrote:
> 
> Hi,
> I successfully build a version of PETSc with scalar-type=complex. A version with the only change of scalar-type=real, builds, but the test fails. What do I miss here?
> Thanks,
> --
> Ted
> 
> 
> BUILD:
> --------
> ./configure                                            \
> PETSC_DIR=${PETSC_DIST_DIR}  PETSC_ARCH=${PETSC_ARCH}  \
> --prefix=${PETSC_INSTALL_DIR}/${PETSC_ARCH}            \
> --with-cc=mpicc --with-cxx=mpicxx --with-fc=mpif90     \
> --CFLAGS=-O                                                        \
> --with-x      \
> --with-precision=double                                       \
> --with-scalar-type=${SCALAR_TYPE}                   \
> --with-clanguage=c++                                         \
> --with-debugger=gdb                                            \
> --with-debugging                                                   \
> --with-fortran-datatypes=1                                   \
> --with-cgns-dir=${PKGSDIR}/cgns                        \
> --with-blas-lapack-dir=${PETSC_DIST_DIR}/${PETSC_ARCH} \
> --with-hdf5-dir=${PETSC_DIST_DIR}/${PETSC_ARCH}             \
> --download-metis=yes                           \
> --download-parmetis=yes                      \
> --download-hypre=yes                           \        <------ this is not included in the complex build
> --with-valgrind=1
> 
> 
> 
> TEST
> ---------------------------------
> -bash-3.2$ make PETSC_DIR=/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg PETSC_ARCH="" test
> Running test examples to verify correct installation
> Using PETSC_DIR=/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg and PETSC_ARCH=
> *******************Error detected during compile or link!*******************
> See http://www.mcs.anl.gov/petsc/documentation/faq.html
> /home/tsariysk/MFEMv3/tars/petsc-3.5.3/src/snes/examples/tutorials ex19
> ********************************************************************************* 
> *********************W-a-r-n-i-n-g*************************
> Your PETSC_DIR may not match the directory you are in
> PETSC_DIR  /home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg Current directory /home/tsariysk/MFEMv3/tars/petsc-3.5.3/src/snes/examples/tutorials
> Ignore this if you are running make test
> ******************************************************
> mpicxx -o ex19.o -c -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -g -O0   -fPIC -I/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/include -I/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/include -I/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/include -I/home/tsariysk/MFEMv3/pkgs/cgns/include -I/opt/mpich-3.1.4/include `pwd`/ex19.c
> mpicxx -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -g -O0   -o ex19  ex19.o -Wl,-rpath,/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/lib -L/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/lib  -lpetsc -Wl,-rpath,/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/lib -L/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/lib -lHYPRE -Wl,-rpath,/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg -L/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg -llapack -lblas -lparmetis -lmetis -lX11 -lpthread -lssl -lcrypto -Wl,-rpath,/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/lib -lhdf5hl_fortran -lhdf5_fortran -lhdf5_hl -lhdf5 -Wl,-rpath,/home/tsariysk/MFEMv3/pkgs/cgns/lib -L/home/tsariysk/MFEMv3/pkgs/cgns/lib -lcgns -Wl,-rpath,/opt/mpich-3.1.4/lib -L/opt/mpich-3.1.4/lib -Wl,-rpath,/opt/gcc/4.7.1/lib/gcc/x86_64-unknown-linux-gnu/4.7.1 -L/opt/gcc/4.7.1/lib/gcc/x86_64-unknown-linux-gnu/4.7.1 -Wl,-rpath,/opt/gcc/4.7.1/lib64 -L/opt/gcc/4.7.1/lib64 -Wl,-rpath,/opt/gcc/4.7.1/lib -L/opt/gcc/4.7.1/lib -lmpifort -lgfortran -lm -lgfortran -lm -lmpicxx -lstdc++ -Wl,-rpath,/opt/mpich-3.1.4/lib -L/opt/mpich-3.1.4/lib -Wl,-rpath,/opt/gcc/4.7.1/lib/gcc/x86_64-unknown-linux-gnu/4.7.1 -L/opt/gcc/4.7.1/lib/gcc/x86_64-unknown-linux-gnu/4.7.1 -Wl,-rpath,/opt/gcc/4.7.1/lib64 -L/opt/gcc/4.7.1/lib64 -Wl,-rpath,/opt/gcc/4.7.1/lib -L/opt/gcc/4.7.1/lib -ldl -Wl,-rpath,/opt/mpich-3.1.4/lib -lmpi -lgcc_s -ldl
> /usr/bin/ld: warning: libgfortran.so.1, needed by /usr/lib/../lib64/liblapack.so, may conflict with libgfortran.so.3
> /usr/bin/ld: warning: libgfortran.so.1, needed by /usr/lib/../lib64/liblapack.so, may conflict with libgfortran.so.3
> /bin/rm -f ex19.o
> Possible error running C/C++ src/snes/examples/tutorials/ex19 with 1 MPI process
> See http://www.mcs.anl.gov/petsc/documentation/faq.html
> lid velocity = 0.0016, prandtl # = 1, grashof # = 1
> [0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
> [0]PETSC ERROR: Zero pivot in LU factorization: http://www.mcs.anl.gov/petsc/documentation/faq.html#ZeroPivot
> [0]PETSC ERROR: Zero pivot, row 2
> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
> [0]PETSC ERROR: Petsc Release Version 3.5.3, Jan, 31, 2015
> [0]PETSC ERROR: ./ex19 on a petsc-complex-dbg named odin.craft-tech.com by tsariysk Sun May  3 14:02:08 2015
> [0]PETSC ERROR: Configure options PETSC_DIR=/home/tsariysk/MFEMv3/tars/petsc-3.5.3 PETSC_ARCH=petsc-complex-dbg --prefix=/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-complex-dbg --with-cc=mpicc --with-cxx=mpicxx --with-fc=mpif90 --CFLAGS=-O --with-x --with-precision=double --with-scalar-type=complex --with-clanguage=c++ --with-debugger=gdb --with-debugging --with-fortran-datatypes=1 --with-blas-lapack-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-hdf5-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-metis-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-parmetis-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-cgns-dir=/home/tsariysk/MFEMv3/pkgs/cgns --with-valgrind=1
> [0]PETSC ERROR: #1 PetscKernel_A_gets_inverse_A_4() line 48 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/mat/impls/baij/seq/dgefa4.c
> [0]PETSC ERROR: #2 MatSOR_SeqAIJ_Inode() line 2812 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/mat/impls/aij/seq/inode.c
> [0]PETSC ERROR: #3 MatSOR() line 3643 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/mat/interface/matrix.c
> [0]PETSC ERROR: #4 PCApply_SOR() line 35 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/impls/sor/sor.c
> [0]PETSC ERROR: #5 PCApply() line 440 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/interface/precon.c
> [0]PETSC ERROR: #6 KSP_PCApply() line 230 in /home/tsariysk/MFEMv3/tars/petsc-3.5.3/include/petsc-private/kspimpl.h
> [0]PETSC ERROR: #7 KSPInitialResidual() line 56 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/interface/itres.c
> [0]PETSC ERROR: #8 KSPSolve_GMRES() line 234 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/impls/gmres/gmres.c
> [0]PETSC ERROR: #9 KSPSolve() line 460 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/interface/itfunc.c
> [0]PETSC ERROR: #10 KSPSolve_Chebyshev() line 368 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/impls/cheby/cheby.c
> [0]PETSC ERROR: #11 KSPSolve() line 460 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/interface/itfunc.c
> [0]PETSC ERROR: #12 PCMGMCycle_Private() line 19 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/impls/mg/mg.c
> [0]PETSC ERROR: #13 PCApply_MG() line 337 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/impls/mg/mg.c
> [0]PETSC ERROR: #14 PCApply() line 440 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/interface/precon.c
> [0]PETSC ERROR: #15 KSP_PCApply() line 230 in /home/tsariysk/MFEMv3/tars/petsc-3.5.3/include/petsc-private/kspimpl.h
> [0]PETSC ERROR: #16 KSPFGMRESCycle() line 168 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/impls/gmres/fgmres/fgmres.c 
> [0]PETSC ERROR: #17 KSPSolve_FGMRES() line 295 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/impls/gmres/fgmres/fgmres.c 
> [0]PETSC ERROR: #18 KSPSolve() line 460 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/interface/itfunc.c
> [0]PETSC ERROR: #19 SNESSolve_NEWTONLS() line 232 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/snes/impls/ls/ls.c
> [0]PETSC ERROR: #20 SNESSolve() line 3743 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/snes/interface/snes.c
> [0]PETSC ERROR: #21 main() line 158 in /home/tsariysk/MFEMv3/tars/petsc-3.5.3/src/snes/examples/tutorials/ex19.c
> [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
> application called MPI_Abort(MPI_COMM_WORLD, 71) - process 0
> 
> ===================================================================================
> =   BAD TERMINATION OF ONE OF YOUR APPLICATION PROCESSES
> =   PID 24633 RUNNING AT odin.craft-tech.com
> =   EXIT CODE: 71
> =   CLEANING UP REMAINING PROCESSES
> =   YOU CAN IGNORE THE BELOW CLEANUP MESSAGES
> ===================================================================================
> Possible error running C/C++ src/snes/examples/tutorials/ex19 with 2 MPI processes
> See http://www.mcs.anl.gov/petsc/documentation/faq.html
> lid velocity = 0.0016, prandtl # = 1, grashof # = 1
> [0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
> [0]PETSC ERROR: Zero pivot in LU factorization: http://www.mcs.anl.gov/petsc/documentation/faq.html#ZeroPivot
> [0]PETSC ERROR: Zero pivot, row 2
> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
> [0]PETSC ERROR: [1]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
> [1]PETSC ERROR: Zero pivot in LU factorization: http://www.mcs.anl.gov/petsc/documentation/faq.html#ZeroPivot
> [1]PETSC ERROR: Zero pivot, row 2
> [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
> [1]PETSC ERROR: Petsc Release Version 3.5.3, Jan, 31, 2015
> [1]PETSC ERROR: ./ex19 on a petsc-complex-dbg named odin.craft-tech.com by tsariysk Sun May  3 14:02:08 2015
> [1]PETSC ERROR: Configure options PETSC_DIR=/home/tsariysk/MFEMv3/tars/petsc-3.5.3 PETSC_ARCH=petsc-complex-dbg --prefix=/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-complex-dbg --with-cc=mpicc --with-cxx=mpicxx --with-fc=mpif90 --CFLAGS=-O --with-x --with-precision=double --with-scalar-type=complex --with-clanguage=c++ --with-debugger=gdb --with-debugging --with-fortran-datatypes=1 --with-blas-lapack-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-hdf5-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-metis-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-parmetis-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-cgns-dir=/home/tsariysk/MFEMv3/pkgs/cgns --with-valgrind=1
> [1]PETSC ERROR: #1 PetscKernel_A_gets_inverse_A_4() line 48 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/mat/impls/baij/seq/dgefa4.c
> [1]PETSC ERROR: #2 MatSOR_SeqAIJ_Inode() line 2812 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/mat/impls/aij/seq/inode.c
> [1]PETSC ERROR: #3 MatSOR_MPIAIJ() line 1483 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/mat/impls/aij/mpi/mpiaij.c
> Petsc Release Version 3.5.3, Jan, 31, 2015
> [0]PETSC ERROR: ./ex19 on a petsc-complex-dbg named odin.craft-tech.com by tsariysk Sun May  3 14:02:08 2015
> [0]PETSC ERROR: Configure options PETSC_DIR=/home/tsariysk/MFEMv3/tars/petsc-3.5.3 PETSC_ARCH=petsc-complex-dbg --prefix=/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-complex-dbg --with-cc=mpicc --with-cxx=mpicxx --with-fc=mpif90 --CFLAGS=-O --with-x --with-precision=double --with-scalar-type=complex --with-clanguage=c++ --with-debugger=gdb --with-debugging --with-fortran-datatypes=1 --with-blas-lapack-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-hdf5-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-metis-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-parmetis-dir=/home/tsariysk/MFEMv3/tars/petsc-3.5.3/petsc-complex-dbg --with-cgns-dir=/home/tsariysk/MFEMv3/pkgs/cgns --with-valgrind=1
> [0]PETSC ERROR: #1 PetscKernel_A_gets_inverse_A_4() line 48 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/mat/impls/baij/seq/dgefa4.c
> [0]PETSC ERROR: #2 MatSOR_SeqAIJ_Inode() line 2812 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/mat/impls/aij/seq/inode.c
> [0]PETSC ERROR: #3 MatSOR_MPIAIJ() line 1483 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/mat/impls/aij/mpi/mpiaij.c
> [1]PETSC ERROR: #4 MatSOR() line 3643 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/mat/interface/matrix.c
> [1]PETSC ERROR: [0]PETSC ERROR: #4 MatSOR() line 3643 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/mat/interface/matrix.c
> #5 PCApply_SOR() line 35 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/impls/sor/sor.c
> [1]PETSC ERROR: [0]PETSC ERROR: #5 PCApply_SOR() line 35 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/impls/sor/sor.c
> [0]PETSC ERROR: #6 PCApply() line 440 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/interface/precon.c
> #6 PCApply() line 440 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/interface/precon.c
> [1]PETSC ERROR: [0]PETSC ERROR: #7 KSP_PCApply() line 230 in /home/tsariysk/MFEMv3/tars/petsc-3.5.3/include/petsc-private/kspimpl.h
> #7 KSP_PCApply() line 230 in /home/tsariysk/MFEMv3/tars/petsc-3.5.3/include/petsc-private/kspimpl.h
> [0]PETSC ERROR: #8 KSPInitialResidual() line 56 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/interface/itres.c
> [1]PETSC ERROR: #8 KSPInitialResidual() line 56 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/interface/itres.c
> [0]PETSC ERROR: #9 KSPSolve_GMRES() line 234 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/impls/gmres/gmres.c
> [0]PETSC ERROR: [1]PETSC ERROR: #9 KSPSolve_GMRES() line 234 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/impls/gmres/gmres.c
> #10 KSPSolve() line 460 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/interface/itfunc.c
> [0]PETSC ERROR: #11 KSPSolve_Chebyshev() line 368 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/impls/cheby/cheby.c
> [0]PETSC ERROR: [1]PETSC ERROR: #10 KSPSolve() line 460 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/interface/itfunc.c
> #12 KSPSolve() line 460 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/interface/itfunc.c
> [0]PETSC ERROR: [1]PETSC ERROR: #11 KSPSolve_Chebyshev() line 368 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/impls/cheby/cheby.c
> #13 PCMGMCycle_Private() line 19 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/impls/mg/mg.c
> [0]PETSC ERROR: #14 PCApply_MG() line 337 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/impls/mg/mg.c
> [0]PETSC ERROR: [1]PETSC ERROR: #12 KSPSolve() line 460 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/interface/itfunc.c
> #15 PCApply() line 440 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/interface/precon.c
> [0]PETSC ERROR: #16 KSP_PCApply() line 230 in /home/tsariysk/MFEMv3/tars/petsc-3.5.3/include/petsc-private/kspimpl.h
> [1]PETSC ERROR: #13 PCMGMCycle_Private() line 19 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/impls/mg/mg.c
> [0]PETSC ERROR: #17 KSPFGMRESCycle() line 168 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/impls/gmres/fgmres/fgmres.c
> [0]PETSC ERROR: #18 KSPSolve_FGMRES() line 295 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/impls/gmres/fgmres/fgmres.c
> [1]PETSC ERROR: #14 PCApply_MG() line 337 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/impls/mg/mg.c
> [0]PETSC ERROR: #19 KSPSolve() line 460 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/interface/itfunc.c
> [0]PETSC ERROR: #20 SNESSolve_NEWTONLS() line 232 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/snes/impls/ls/ls.c
> [1]PETSC ERROR: #15 PCApply() line 440 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/pc/interface/precon.c
> [0]PETSC ERROR: #21 SNESSolve() line 3743 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/snes/interface/snes.c
> [1]PETSC ERROR: #16 KSP_PCApply() line 230 in /home/tsariysk/MFEMv3/tars/petsc-3.5.3/include/petsc-private/kspimpl.h
> [0]PETSC ERROR: #22 main() line 158 in /home/tsariysk/MFEMv3/tars/petsc-3.5.3/src/snes/examples/tutorials/ex19.c
> [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
> [1]PETSC ERROR: #17 KSPFGMRESCycle() line 168 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/impls/gmres/fgmres/fgmres.c
> [1]PETSC ERROR: #18 KSPSolve_FGMRES() line 295 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/impls/gmres/fgmres/fgmres.c
> [1]PETSC ERROR: #19 KSPSolve() line 460 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/ksp/ksp/interface/itfunc.c
> application called MPI_Abort(MPI_COMM_WORLD, 71) - process 0
> [1]PETSC ERROR: #20 SNESSolve_NEWTONLS() line 232 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/snes/impls/ls/ls.c
> [1]PETSC ERROR: #21 SNESSolve() line 3743 in /work/tsariysk/MFEMv3/tars/petsc-3.5.3/src/snes/interface/snes.c
> [1]PETSC ERROR: #22 main() line 158 in /home/tsariysk/MFEMv3/tars/petsc-3.5.3/src/snes/examples/tutorials/ex19.c
> [1]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
> application called MPI_Abort(MPI_COMM_WORLD, 71) - process 1
> 
> ===================================================================================
> =   BAD TERMINATION OF ONE OF YOUR APPLICATION PROCESSES
> =   PID 24638 RUNNING AT odin.craft-tech.com
> =   EXIT CODE: 71
> =   CLEANING UP REMAINING PROCESSES
> =   YOU CAN IGNORE THE BELOW CLEANUP MESSAGES
> ===================================================================================
> *******************Error detected during compile or link!*******************
> See http://www.mcs.anl.gov/petsc/documentation/faq.html
> /home/tsariysk/MFEMv3/tars/petsc-3.5.3/src/snes/examples/tutorials ex5f90t
> *********************************************************
> mpif90 -c  -fPIC -Wall -Wno-unused-variable -ffree-line-length-0 -Wno-unused-dummy-argument -g -O0 -I/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/include -I/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/include -I/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/include -I/home/tsariysk/MFEMv3/pkgs/cgns/include -I/opt/mpich-3.1.4/include    -o ex5f90t.o ex5f90t.F
> mpif90 -fPIC -Wall -Wno-unused-variable -ffree-line-length-0 -Wno-unused-dummy-argument -g -O0   -o ex5f90t ex5f90t.o -Wl,-rpath,/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/lib -L/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/lib  -lpetsc -Wl,-rpath,/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/lib -L/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/lib -lHYPRE -Wl,-rpath,/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg -L/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg -llapack -lblas -lparmetis -lmetis -lX11 -lpthread -lssl -lcrypto -Wl,-rpath,/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg/lib -lhdf5hl_fortran -lhdf5_fortran -lhdf5_hl -lhdf5 -Wl,-rpath,/home/tsariysk/MFEMv3/pkgs/cgns/lib -L/home/tsariysk/MFEMv3/pkgs/cgns/lib -lcgns -Wl,-rpath,/opt/mpich-3.1.4/lib -L/opt/mpich-3.1.4/lib -Wl,-rpath,/opt/gcc/4.7.1/lib/gcc/x86_64-unknown-linux-gnu/4.7.1 -L/opt/gcc/4.7.1/lib/gcc/x86_64-unknown-linux-gnu/4.7.1 -Wl,-rpath,/opt/gcc/4.7.1/lib64 -L/opt/gcc/4.7.1/lib64 -Wl,-rpath,/opt/gcc/4.7.1/lib -L/opt/gcc/4.7.1/lib -lmpifort -lgfortran -lm -lgfortran -lm -lmpicxx -lstdc++ -Wl,-rpath,/opt/mpich-3.1.4/lib -L/opt/mpich-3.1.4/lib -Wl,-rpath,/opt/gcc/4.7.1/lib/gcc/x86_64-unknown-linux-gnu/4.7.1 -L/opt/gcc/4.7.1/lib/gcc/x86_64-unknown-linux-gnu/4.7.1 -Wl,-rpath,/opt/gcc/4.7.1/lib64 -L/opt/gcc/4.7.1/lib64 -Wl,-rpath,/opt/gcc/4.7.1/lib -L/opt/gcc/4.7.1/lib -ldl -Wl,-rpath,/opt/mpich-3.1.4/lib -lmpi -lgcc_s -ldl
> /usr/bin/ld: warning: libgfortran.so.1, needed by /usr/lib/../lib64/liblapack.so, may conflict with libgfortran.so.3
> /usr/bin/ld: warning: libgfortran.so.1, needed by /usr/lib/../lib64/liblapack.so, may conflict with libgfortran.so.3
> /usr/bin/ld: warning: libgfortran.so.1, needed by /usr/lib/../lib64/liblapack.so, may conflict with libgfortran.so.3
> /bin/rm -f ex5f90t.o
> Possible error running Fortran example src/snes/examples/tutorials/ex5f90t with 1 MPI process
> See http://www.mcs.anl.gov/petsc/documentation/faq.html
> Number of SNES iterations =     0
> Completed test examples
> =========================================
> Now to evaluate the computer systems you plan use - do:
> make PETSC_DIR=/home/tsariysk/MFEMv3/pkgs/petsc-3.5.3/petsc-real-dbg PETSC_ARCH= streams NPMAX=<number of MPI processes you intend to use>
> 



More information about the petsc-users mailing list