[petsc-users] Question on incomplete factorization level and fill
Danyang Su
danyang.su at gmail.com
Wed May 24 15:06:47 CDT 2017
Dear Hong,
I just tested with different number of processors for the same matrix.
It sometimes got "ERROR: Arguments are incompatible" for different
number of processors. It works fine using 4, 8, or 24 processors, but
failed with "ERROR: Arguments are incompatible" using 16 or 48
processors. The error information is attached. I tested this on my local
computer with 6 cores 12 threads. Any suggestion on this?
Thanks,
Danyang
On 17-05-24 12:28 PM, Danyang Su wrote:
>
> Hi Hong,
>
> Awesome. Thanks for testing the case. I will try your options for the
> code and get back to you later.
>
> Regards,
>
> Danyang
>
>
> On 17-05-24 12:21 PM, Hong wrote:
>> Danyang :
>> I tested your data.
>> Your matrices encountered zero pivots, e.g.
>> petsc/src/ksp/ksp/examples/tutorials (master)
>> $ mpiexec -n 24 ./ex10 -f0 a_react_in_2.bin -rhs b_react_in_2.bin
>> -ksp_monitor -ksp_error_if_not_converged
>>
>> [15]PETSC ERROR: Zero pivot in LU factorization:
>> http://www.mcs.anl.gov/petsc/documentation/faq.html#zeropivot
>> [15]PETSC ERROR: Zero pivot row 1249 value 2.05808e-14 tolerance
>> 2.22045e-14
>> ...
>>
>> Adding option '-sub_pc_factor_shift_type nonzero', I got
>> mpiexec -n 24 ./ex10 -f0 a_react_in_2.bin -rhs b_react_in_2.bin
>> -ksp_monitor -ksp_error_if_not_converged -sub_pc_factor_shift_type
>> nonzero -mat_view ascii::ascii_info
>>
>> Mat Object: 24 MPI processes
>> type: mpiaij
>> rows=450000, cols=450000
>> total: nonzeros=6991400, allocated nonzeros=6991400
>> total number of mallocs used during MatSetValues calls =0
>> not using I-node (on process 0) routines
>> 0 KSP Residual norm 5.849777711755e+01
>> 1 KSP Residual norm 6.824179430230e-01
>> 2 KSP Residual norm 3.994483555787e-02
>> 3 KSP Residual norm 6.085841461433e-03
>> 4 KSP Residual norm 8.876162583511e-04
>> 5 KSP Residual norm 9.407780665278e-05
>> Number of iterations = 5
>> Residual norm 0.00542891
>>
>> Hong
>>
>> Hi Matt,
>>
>> Yes. The matrix is 450000x450000 sparse. The hypre takes hundreds
>> of iterates, not for all but in most of the timesteps. The matrix
>> is not well conditioned, with nonzero entries range from 1.0e-29
>> to 1.0e2. I also made double check if there is anything wrong in
>> the parallel version, however, the matrix is the same with
>> sequential version except some round error which is relatively
>> very small. Usually for those not well conditioned matrix, direct
>> solver should be faster than iterative solver, right? But when I
>> use the sequential iterative solver with ILU prec developed
>> almost 20 years go by others, the solver converge fast with
>> appropriate factorization level. In other words, when I use 24
>> processor using hypre, the speed is almost the same as as the old
>> sequential iterative solver using 1 processor.
>>
>> I use most of the default configuration for the general case with
>> pretty good speedup. And I am not sure if I miss something for
>> this problem.
>>
>> Thanks,
>>
>> Danyang
>>
>>
>> On 17-05-24 11:12 AM, Matthew Knepley wrote:
>>> On Wed, May 24, 2017 at 12:50 PM, Danyang Su
>>> <danyang.su at gmail.com <mailto:danyang.su at gmail.com>> wrote:
>>>
>>> Hi Matthew and Barry,
>>>
>>> Thanks for the quick response.
>>>
>>> I also tried superlu and mumps, both work but it is about
>>> four times slower than ILU(dt) prec through hypre, with 24
>>> processors I have tested.
>>>
>>> You mean the total time is 4x? And you are taking hundreds of
>>> iterates? That seems hard to believe, unless you are dropping
>>> a huge number of elements.
>>>
>>> When I look into the convergence information, the method
>>> using ILU(dt) still takes 200 to 3000 linear iterations for
>>> each newton iteration. One reason is this equation is hard
>>> to solve. As for the general cases, the same method works
>>> awesome and get very good speedup.
>>>
>>> I do not understand what you mean here.
>>>
>>> I also doubt if I use hypre correctly for this case. Is
>>> there anyway to check this problem, or is it possible to
>>> increase the factorization level through hypre?
>>>
>>> I don't know.
>>>
>>> Matt
>>>
>>> Thanks,
>>>
>>> Danyang
>>>
>>>
>>> On 17-05-24 04:59 AM, Matthew Knepley wrote:
>>>> On Wed, May 24, 2017 at 2:21 AM, Danyang Su
>>>> <danyang.su at gmail.com <mailto:danyang.su at gmail.com>> wrote:
>>>>
>>>> Dear All,
>>>>
>>>> I use PCFactorSetLevels for ILU and PCFactorSetFill for
>>>> other preconditioning in my code to help solve the
>>>> problems that the default option is hard to solve.
>>>> However, I found the latter one, PCFactorSetFill does
>>>> not take effect for my problem. The matrices and rhs as
>>>> well as the solutions are attached from the link below.
>>>> I obtain the solution using hypre preconditioner and it
>>>> takes 7 and 38 iterations for matrix 1 and matrix 2.
>>>> However, if I use other preconditioner, the solver just
>>>> failed at the first matrix. I have tested this matrix
>>>> using the native sequential solver (not PETSc) with ILU
>>>> preconditioning. If I set the incomplete factorization
>>>> level to 0, this sequential solver will take more than
>>>> 100 iterations. If I increase the factorization level
>>>> to 1 or more, it just takes several iterations. This
>>>> remind me that the PC factor for this matrices should
>>>> be increased. However, when I tried it in PETSc, it
>>>> just does not work.
>>>>
>>>> Matrix and rhs can be obtained from the link below.
>>>>
>>>> https://eilinator.eos.ubc.ca:8443/index.php/s/CalUcq9CMeblk4R
>>>> <https://eilinator.eos.ubc.ca:8443/index.php/s/CalUcq9CMeblk4R>
>>>>
>>>> Would anyone help to check if you can make this work by
>>>> increasing the PC factor level or fill?
>>>>
>>>>
>>>> We have ILU(k) supported in serial. However ILU(dt) which
>>>> takes a tolerance only works through Hypre
>>>>
>>>> http://www.mcs.anl.gov/petsc/documentation/linearsolvertable.html
>>>> <http://www.mcs.anl.gov/petsc/documentation/linearsolvertable.html>
>>>>
>>>> I recommend you try SuperLU or MUMPS, which can both be
>>>> downloaded automatically by configure, and
>>>> do a full sparse LU.
>>>>
>>>> Thanks,
>>>>
>>>> Matt
>>>>
>>>> Thanks and regards,
>>>>
>>>> Danyang
>>>>
>>>>
>>>>
>>>>
>>>>
>>>> --
>>>> What most experimenters take for granted before they begin
>>>> their experiments is infinitely more interesting than any
>>>> results to which their experiments lead.
>>>> -- Norbert Wiener
>>>>
>>>> http://www.caam.rice.edu/~mk51/
>>>> <http://www.caam.rice.edu/%7Emk51/>
>>>
>>>
>>>
>>>
>>> --
>>> What most experimenters take for granted before they begin their
>>> experiments is infinitely more interesting than any results to
>>> which their experiments lead.
>>> -- Norbert Wiener
>>>
>>> http://www.caam.rice.edu/~mk51/ <http://www.caam.rice.edu/%7Emk51/>
>>
>>
>
-------------- next part --------------
An HTML attachment was scrubbed...
URL: <http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20170524/b6347109/attachment-0001.html>
-------------- next part --------------
Mat Object: 16 MPI processes
type: mpiaij
rows=450000, cols=450000
total: nonzeros=6991400, allocated nonzeros=6991400
total number of mallocs used during MatSetValues calls =0
not using I-node (on process 0) routines
[0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[0]PETSC ERROR: Arguments are incompatible
[0]PETSC ERROR: Incompatible vector local lengths 28130 != 28125
[0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[0]PETSC ERROR: [1]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[1]PETSC ERROR: Arguments are incompatible
[1]PETSC ERROR: Incompatible vector local lengths 28130 != 28125
[1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[1]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[1]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:54:10 2017
[1]PETSC ERROR: [2]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[2]PETSC ERROR: Arguments are incompatible
[2]PETSC ERROR: Incompatible vector local lengths 28130 != 28125
[2]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[2]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[2]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:54:10 2017
[2]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[2]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[4]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[4]PETSC ERROR: Arguments are incompatible
[4]PETSC ERROR: Incompatible vector local lengths 28130 != 28125
[4]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[4]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[4]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:54:10 2017
[4]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[4]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[6]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[6]PETSC ERROR: Arguments are incompatible
[6]PETSC ERROR: Incompatible vector local lengths 28130 != 28125
[6]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[6]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[6]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:54:10 2017
[6]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[6]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[8]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[8]PETSC ERROR: Arguments are incompatible
[8]PETSC ERROR: Incompatible vector local lengths 28120 != 28125
[8]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[8]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[8]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:54:10 2017
[8]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[8]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[8]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:54:10 2017
[0]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[0]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[0]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[0]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[0]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[1]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[1]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[1]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[1]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[2]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[2]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[2]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[2]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[3]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[3]PETSC ERROR: Arguments are incompatible
[3]PETSC ERROR: Incompatible vector local lengths 28130 != 28125
[3]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[3]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[3]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:54:10 2017
[3]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[3]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[3]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[3]PETSC ERROR: [4]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[4]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[4]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[4]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[4]PETSC ERROR: PETSc Option Table entries:
[4]PETSC ERROR: [5]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[5]PETSC ERROR: Arguments are incompatible
[5]PETSC ERROR: Incompatible vector local lengths 28130 != 28125
[5]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[5]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[5]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:54:10 2017
[5]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[5]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[5]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[5]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[5]PETSC ERROR: [6]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[6]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[6]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[6]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[6]PETSC ERROR: PETSc Option Table entries:
[7]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[7]PETSC ERROR: Arguments are incompatible
[7]PETSC ERROR: Incompatible vector local lengths 28130 != 28125
[7]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[7]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[7]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:54:10 2017
[7]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[7]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[7]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[7]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
#2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[8]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[8]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[8]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[8]PETSC ERROR: PETSc Option Table entries:
[8]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[8]PETSC ERROR: -ksp_error_if_not_converged
[8]PETSC ERROR: [11]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[11]PETSC ERROR: Arguments are incompatible
[11]PETSC ERROR: Incompatible vector local lengths 28120 != 28125
[11]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[11]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[11]PETSC ERROR: [12]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[12]PETSC ERROR: Arguments are incompatible
[12]PETSC ERROR: Incompatible vector local lengths 28120 != 28125
[12]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[12]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[12]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:54:10 2017
[12]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[12]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[12]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[12]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[12]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[0]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[0]PETSC ERROR: PETSc Option Table entries:
[0]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[0]PETSC ERROR: -ksp_error_if_not_converged
[0]PETSC ERROR: -mat_view ascii::ascii_info
[0]PETSC ERROR: -matload_block_size 1
[0]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[0]PETSC ERROR: -skp_monitor
[0]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[0]PETSC ERROR: -vecload_block_size 10
[1]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[1]PETSC ERROR: PETSc Option Table entries:
[1]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[1]PETSC ERROR: -ksp_error_if_not_converged
[1]PETSC ERROR: -mat_view ascii::ascii_info
[1]PETSC ERROR: -matload_block_size 1
[1]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[1]PETSC ERROR: -skp_monitor
[1]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[1]PETSC ERROR: -vecload_block_size 10
[2]PETSC ERROR: PETSc Option Table entries:
[2]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[2]PETSC ERROR: -ksp_error_if_not_converged
[2]PETSC ERROR: -mat_view ascii::ascii_info
[2]PETSC ERROR: -matload_block_size 1
[2]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[2]PETSC ERROR: -skp_monitor
[2]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[2]PETSC ERROR: -vecload_block_size 10
[2]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
#3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[3]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[3]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[3]PETSC ERROR: PETSc Option Table entries:
[3]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[3]PETSC ERROR: -ksp_error_if_not_converged
[3]PETSC ERROR: -mat_view ascii::ascii_info
[3]PETSC ERROR: -matload_block_size 1
[3]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[3]PETSC ERROR: -skp_monitor
-f0 ./mat_rhs/a_react_in_2.bin
[4]PETSC ERROR: -ksp_error_if_not_converged
[4]PETSC ERROR: -mat_view ascii::ascii_info
[4]PETSC ERROR: -matload_block_size 1
[4]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[4]PETSC ERROR: -skp_monitor
[4]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[4]PETSC ERROR: -vecload_block_size 10
[4]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
#4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[5]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[5]PETSC ERROR: PETSc Option Table entries:
[5]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[5]PETSC ERROR: -ksp_error_if_not_converged
[5]PETSC ERROR: -mat_view ascii::ascii_info
[5]PETSC ERROR: -matload_block_size 1
[5]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[5]PETSC ERROR: -skp_monitor
[5]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[6]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[6]PETSC ERROR: -ksp_error_if_not_converged
[6]PETSC ERROR: -mat_view ascii::ascii_info
[6]PETSC ERROR: -matload_block_size 1
[6]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[6]PETSC ERROR: -skp_monitor
[6]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[6]PETSC ERROR: -vecload_block_size 10
[6]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
[7]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[7]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[7]PETSC ERROR: PETSc Option Table entries:
[7]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[7]PETSC ERROR: -ksp_error_if_not_converged
[7]PETSC ERROR: -mat_view ascii::ascii_info
[7]PETSC ERROR: -matload_block_size 1
[7]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[7]PETSC ERROR: -skp_monitor
-mat_view ascii::ascii_info
[8]PETSC ERROR: -matload_block_size 1
[8]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[8]PETSC ERROR: -skp_monitor
[8]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[8]PETSC ERROR: -vecload_block_size 10
[8]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:54:10 2017
[11]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[11]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[11]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[11]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[11]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[11]PETSC ERROR: [12]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[12]PETSC ERROR: PETSc Option Table entries:
[12]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[12]PETSC ERROR: -ksp_error_if_not_converged
[12]PETSC ERROR: -mat_view ascii::ascii_info
[12]PETSC ERROR: -matload_block_size 1
[12]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[12]PETSC ERROR: -skp_monitor
[12]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
[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, 75) - process 2
[cli_2]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 2
[3]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[3]PETSC ERROR: -vecload_block_size 10
[3]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
[5]PETSC ERROR: -vecload_block_size 10
[5]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
[7]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[7]PETSC ERROR: -vecload_block_size 10
[7]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
#5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[11]PETSC ERROR: PETSc Option Table entries:
[11]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[11]PETSC ERROR: -ksp_error_if_not_converged
[11]PETSC ERROR: -mat_view ascii::ascii_info
[11]PETSC ERROR: -matload_block_size 1
[11]PETSC ERROR: [12]PETSC ERROR: -vecload_block_size 10
[12]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 1
[cli_1]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 1
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 3
[cli_3]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 3
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 5
[cli_5]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 5
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 6
[cli_6]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 6
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 7
[cli_7]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 7
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 8
[cli_8]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 8
-rhs ./mat_rhs/b_react_in_2.bin
[11]PETSC ERROR: -skp_monitor
[11]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[11]PETSC ERROR: -vecload_block_size 10
[11]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 12
[cli_12]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 12
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 0
[cli_0]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 0
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 11
[cli_11]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 11
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 4
[cli_4]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 4
[9]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[9]PETSC ERROR: Arguments are incompatible
[9]PETSC ERROR: Incompatible vector local lengths 28120 != 28125
[9]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[9]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[9]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:54:10 2017
[9]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[9]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[9]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[9]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[9]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[9]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[9]PETSC ERROR: PETSc Option Table entries:
[9]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[9]PETSC ERROR: -ksp_error_if_not_converged
[9]PETSC ERROR: -mat_view ascii::ascii_info
[9]PETSC ERROR: -matload_block_size 1
[9]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[9]PETSC ERROR: -skp_monitor
[9]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[9]PETSC ERROR: -vecload_block_size 10
[9]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 9
[cli_9]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 9
===================================================================================
= BAD TERMINATION OF ONE OF YOUR APPLICATION PROCESSES
= EXIT CODE: 75
= CLEANING UP REMAINING PROCESSES
= YOU CAN IGNORE THE BELOW CLEANUP MESSAGES
===================================================================================
-------------- next part --------------
Mat Object: 48 MPI processes
type: mpiaij
rows=450000, cols=450000
total: nonzeros=6991400, allocated nonzeros=6991400
total number of mallocs used during MatSetValues calls =0
not using I-node (on process 0) routines
[0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[0]PETSC ERROR: Arguments are incompatible
[0]PETSC ERROR: Incompatible vector local lengths 9380 != 9375
[0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[0]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[0]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[0]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[0]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[0]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[0]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[0]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[0]PETSC ERROR: PETSc Option Table entries:
[0]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[0]PETSC ERROR: -ksp_error_if_not_converged
[0]PETSC ERROR: -mat_view ascii::ascii_info
[0]PETSC ERROR: -matload_block_size 1
[0]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[0]PETSC ERROR: -skp_monitor
[0]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[0]PETSC ERROR: -vecload_block_size 10
[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, 75) - process 0
[cli_0]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 0
[1]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[1]PETSC ERROR: Arguments are incompatible
[1]PETSC ERROR: Incompatible vector local lengths 9380 != 9375
[1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[1]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[1]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[1]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[1]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[1]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[1]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[1]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[1]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[1]PETSC ERROR: PETSc Option Table entries:
[1]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[1]PETSC ERROR: -ksp_error_if_not_converged
[1]PETSC ERROR: -mat_view ascii::ascii_info
[1]PETSC ERROR: -matload_block_size 1
[1]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[1]PETSC ERROR: -skp_monitor
[1]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[1]PETSC ERROR: -vecload_block_size 10
[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, 75) - process 1
[cli_1]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 1
[2]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[2]PETSC ERROR: Arguments are incompatible
[2]PETSC ERROR: Incompatible vector local lengths 9380 != 9375
[2]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[2]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[2]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[2]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[2]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[2]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[2]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[2]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[2]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[2]PETSC ERROR: PETSc Option Table entries:
[2]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[2]PETSC ERROR: -ksp_error_if_not_converged
[2]PETSC ERROR: -mat_view ascii::ascii_info
[2]PETSC ERROR: -matload_block_size 1
[2]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[2]PETSC ERROR: -skp_monitor
[2]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[2]PETSC ERROR: -vecload_block_size 10
[2]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 2
[cli_2]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 2
[4]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[4]PETSC ERROR: Arguments are incompatible
[4]PETSC ERROR: Incompatible vector local lengths 9380 != 9375
[4]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[4]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[4]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[4]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[4]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[4]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[4]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[4]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[4]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[4]PETSC ERROR: PETSc Option Table entries:
[4]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[4]PETSC ERROR: -ksp_error_if_not_converged
[4]PETSC ERROR: -mat_view ascii::ascii_info
[4]PETSC ERROR: -matload_block_size 1
[4]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[4]PETSC ERROR: -skp_monitor
[4]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[4]PETSC ERROR: -vecload_block_size 10
[4]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 4
[cli_4]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 4
[5]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[5]PETSC ERROR: Arguments are incompatible
[5]PETSC ERROR: Incompatible vector local lengths 9380 != 9375
[5]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[5]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[5]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[5]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[5]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[5]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[5]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[5]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[5]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[5]PETSC ERROR: PETSc Option Table entries:
[5]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[5]PETSC ERROR: -ksp_error_if_not_converged
[5]PETSC ERROR: -mat_view ascii::ascii_info
[5]PETSC ERROR: -matload_block_size 1
[5]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[5]PETSC ERROR: -skp_monitor
[5]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[5]PETSC ERROR: -vecload_block_size 10
[5]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 5
[cli_5]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 5
[6]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[6]PETSC ERROR: Arguments are incompatible
[6]PETSC ERROR: Incompatible vector local lengths 9380 != 9375
[6]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[6]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[6]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[6]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[6]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[6]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[6]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[6]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[6]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[6]PETSC ERROR: PETSc Option Table entries:
[6]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[6]PETSC ERROR: -ksp_error_if_not_converged
[6]PETSC ERROR: -mat_view ascii::ascii_info
[6]PETSC ERROR: -matload_block_size 1
[6]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[6]PETSC ERROR: -skp_monitor
[6]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[6]PETSC ERROR: -vecload_block_size 10
[6]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 6
[cli_6]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 6
[8]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[8]PETSC ERROR: Arguments are incompatible
[8]PETSC ERROR: Incompatible vector local lengths 9380 != 9375
[8]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[8]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[8]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[8]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[8]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[8]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[8]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[8]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[8]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[8]PETSC ERROR: PETSc Option Table entries:
[8]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[8]PETSC ERROR: -ksp_error_if_not_converged
[8]PETSC ERROR: -mat_view ascii::ascii_info
[8]PETSC ERROR: -matload_block_size 1
[8]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[8]PETSC ERROR: -skp_monitor
[8]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[8]PETSC ERROR: -vecload_block_size 10
[8]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 8
[cli_8]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 8
[10]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[10]PETSC ERROR: Arguments are incompatible
[10]PETSC ERROR: Incompatible vector local lengths 9380 != 9375
[10]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[10]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[10]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[10]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[10]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[10]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[10]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[10]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[10]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[10]PETSC ERROR: PETSc Option Table entries:
[10]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[10]PETSC ERROR: -ksp_error_if_not_converged
[10]PETSC ERROR: -mat_view ascii::ascii_info
[10]PETSC ERROR: -matload_block_size 1
[10]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[10]PETSC ERROR: -skp_monitor
[10]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[10]PETSC ERROR: -vecload_block_size 10
[10]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 10
[cli_10]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 10
[16]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[16]PETSC ERROR: Arguments are incompatible
[16]PETSC ERROR: Incompatible vector local lengths 9380 != 9375
[16]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[16]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[16]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[16]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[16]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[16]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[16]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[16]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[16]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[16]PETSC ERROR: PETSc Option Table entries:
[16]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[16]PETSC ERROR: -ksp_error_if_not_converged
[16]PETSC ERROR: -mat_view ascii::ascii_info
[16]PETSC ERROR: -matload_block_size 1
[16]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[16]PETSC ERROR: -skp_monitor
[16]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[16]PETSC ERROR: -vecload_block_size 10
[16]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 16
[cli_16]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 16
[24]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[24]PETSC ERROR: Arguments are incompatible
[24]PETSC ERROR: Incompatible vector local lengths 9370 != 9375
[24]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[24]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[24]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[24]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[24]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[24]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[24]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[24]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[24]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[24]PETSC ERROR: PETSc Option Table entries:
[24]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[24]PETSC ERROR: -ksp_error_if_not_converged
[24]PETSC ERROR: -mat_view ascii::ascii_info
[24]PETSC ERROR: -matload_block_size 1
[24]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[24]PETSC ERROR: -skp_monitor
[24]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[24]PETSC ERROR: -vecload_block_size 10
[24]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 24
[cli_24]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 24
[28]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[28]PETSC ERROR: Arguments are incompatible
[28]PETSC ERROR: Incompatible vector local lengths 9370 != 9375
[28]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[28]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[28]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[28]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[28]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[28]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[28]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[28]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[28]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[28]PETSC ERROR: PETSc Option Table entries:
[28]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[28]PETSC ERROR: -ksp_error_if_not_converged
[28]PETSC ERROR: -mat_view ascii::ascii_info
[28]PETSC ERROR: -matload_block_size 1
[28]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[28]PETSC ERROR: -skp_monitor
[28]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[28]PETSC ERROR: -vecload_block_size 10
[28]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 28
[cli_28]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 28
[32]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[32]PETSC ERROR: Arguments are incompatible
[32]PETSC ERROR: Incompatible vector local lengths 9370 != 9375
[32]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[32]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[32]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[32]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[32]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[32]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[32]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[32]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[32]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[32]PETSC ERROR: PETSc Option Table entries:
[32]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[32]PETSC ERROR: -ksp_error_if_not_converged
[32]PETSC ERROR: -mat_view ascii::ascii_info
[32]PETSC ERROR: -matload_block_size 1
[32]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[32]PETSC ERROR: -skp_monitor
[32]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[32]PETSC ERROR: -vecload_block_size 10
[32]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 32
[cli_32]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 32
[33]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[33]PETSC ERROR: Arguments are incompatible
[33]PETSC ERROR: Incompatible vector local lengths 9370 != 9375
[33]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[33]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[33]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[33]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[33]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[33]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[33]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[33]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[33]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[33]PETSC ERROR: PETSc Option Table entries:
[33]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[33]PETSC ERROR: -ksp_error_if_not_converged
[33]PETSC ERROR: -mat_view ascii::ascii_info
[33]PETSC ERROR: -matload_block_size 1
[33]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[33]PETSC ERROR: -skp_monitor
[33]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[33]PETSC ERROR: -vecload_block_size 10
[33]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 33
[cli_33]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 33
[34]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[34]PETSC ERROR: Arguments are incompatible
[34]PETSC ERROR: Incompatible vector local lengths 9370 != 9375
[34]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[34]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[34]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[34]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[34]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[34]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[34]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[34]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[34]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[34]PETSC ERROR: PETSc Option Table entries:
[34]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[34]PETSC ERROR: -ksp_error_if_not_converged
[34]PETSC ERROR: -mat_view ascii::ascii_info
[34]PETSC ERROR: -matload_block_size 1
[34]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[34]PETSC ERROR: -skp_monitor
[34]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[34]PETSC ERROR: -vecload_block_size 10
[34]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 34
[cli_34]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 34
[40]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[40]PETSC ERROR: Arguments are incompatible
[40]PETSC ERROR: Incompatible vector local lengths 9370 != 9375
[40]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[40]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[40]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[40]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[40]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[40]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[40]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[40]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[40]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[40]PETSC ERROR: PETSc Option Table entries:
[40]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[40]PETSC ERROR: -ksp_error_if_not_converged
[40]PETSC ERROR: -mat_view ascii::ascii_info
[40]PETSC ERROR: -matload_block_size 1
[40]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[40]PETSC ERROR: -skp_monitor
[40]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[40]PETSC ERROR: -vecload_block_size 10
[40]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 40
[cli_40]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 40
[42]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[42]PETSC ERROR: Arguments are incompatible
[42]PETSC ERROR: Incompatible vector local lengths 9370 != 9375
[42]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[42]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[42]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[42]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[42]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[42]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[42]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[42]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[42]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[42]PETSC ERROR: PETSc Option Table entries:
[42]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[42]PETSC ERROR: -ksp_error_if_not_converged
[42]PETSC ERROR: -mat_view ascii::ascii_info
[42]PETSC ERROR: -matload_block_size 1
[42]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[42]PETSC ERROR: -skp_monitor
[42]PETSC ERROR: -sub_pc_factor_shift_type nonzero
[42]PETSC ERROR: -vecload_block_size 10
[42]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov----------
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 42
[cli_42]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 75) - process 42
[44]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------
[44]PETSC ERROR: Arguments are incompatible
[44]PETSC ERROR: Incompatible vector local lengths 9370 != 9375
[44]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting.
[44]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017
[44]PETSC ERROR: ./ex10 on a linux-gnu-dbg named nwmop by dsu Wed May 24 12:57:30 2017
[44]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes
[44]PETSC ERROR: #1 VecCopy() line 1639 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/vec/vec/interface/vector.c
[44]PETSC ERROR: #2 KSPInitialResidual() line 65 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itres.c
[44]PETSC ERROR: #3 KSPSolve_GMRES() line 239 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/impls/gmres/gmres.c
[44]PETSC ERROR: #4 KSPSolve() line 656 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/interface/itfunc.c
[44]PETSC ERROR: #5 main() line 330 in /home/dsu/Soft/PETSc/petsc-3.7.5/src/ksp/ksp/examples/tutorials/ex10.c
[44]PETSC ERROR: PETSc Option Table entries:
[44]PETSC ERROR: -f0 ./mat_rhs/a_react_in_2.bin
[44]PETSC ERROR: -ksp_error_if_not_converged
[44]PETSC ERROR: -mat_view ascii::ascii_info
[44]PETSC ERROR: -matload_block_size 1
[44]PETSC ERROR: -rhs ./mat_rhs/b_react_in_2.bin
[44]PETSC ERROR: -skp_monitor
[44]PETSC ERROR: -sub_pc_factor_shift_type nonzero
===================================================================================
= BAD TERMINATION OF ONE OF YOUR APPLICATION PROCESSES
= EXIT CODE: 75
= CLEANING UP REMAINING PROCESSES
= YOU CAN IGNORE THE BELOW CLEANUP MESSAGES
===================================================================================
-------------- next part --------------
Mat Object: 8 MPI processes
type: mpiaij
rows=450000, cols=450000
total: nonzeros=6991400, allocated nonzeros=6991400
total number of mallocs used during MatSetValues calls =0
not using I-node (on process 0) routines
Number of iterations = 5
Residual norm 0.00542965
WARNING! There are options you set that were not used!
WARNING! could be spelling mistake, etc!
Option left: name:-skp_monitor (no value)
More information about the petsc-users
mailing list