[petsc-users] snes/ex19 issue with nvprof

Xiangdong epscodes at gmail.com
Sat Jul 6 15:07:32 CDT 2019


Hi Mark,

Yes, I am using your branch (mark/gamg-fix-viennacl-rebased) with Petsc
Development GIT revision: v3.11.3-1064-g8b74309384. I compiled PETSc with
CUDA 10.1.

Which version of CUDA are you using?

Thanks.

Xiangdong

On Sat, Jul 6, 2019 at 1:43 PM Mark Adams <mfadams at lbl.gov> wrote:

> I am not able to reproduce this error. THis is what I get. Are you pulling
> from mark/gamg-fix-viennacl-rebased ?
>
> 13:38  /gpfs/alpine/scratch/adams/geo127$ jsrun -n 1 -c 4 -a 4 -g 1 ./ex19
> -da_refine 5 -snes_view -snes_monitor -ksp_monitor -mat_type aijcusparse
> -vec_type cuda -log_view
> lid velocity = 0.000106281, prandtl # = 1., grashof # = 1.
>   0 SNES Function norm 1.036007954337e-02
>     0 KSP Residual norm 9.144944502871e-02
>     1 KSP Residual norm 2.593759906204e-02
>     2 KSP Residual norm 1.669815200495e-02
>     3 KSP Residual norm 1.510777951698e-02
>     4 KSP Residual norm 1.458401237884e-02
>     5 KSP Residual norm 1.418635322926e-02
>     6 KSP Residual norm 1.377436725003e-02
>     7 KSP Residual norm 1.332236907186e-02
>     8 KSP Residual norm 1.288602527920e-02
>     9 KSP Residual norm 1.240018288138e-02
>    10 KSP Residual norm 1.186798872492e-02
>
>
> On Fri, Jul 5, 2019 at 11:07 PM Xiangdong <epscodes at gmail.com> wrote:
>
>> Hi Mark,
>>
>> After pulling your new commit, I got an error when running ex19 (even
>> without nvprof). Same error with version 3.11.3. But ex19 run fine with old
>> commit 64edb9194a9.
>>
>> Below is a run time log error file. By the way, which version of cuda
>> does PETSc support?
>>
>> Thank you.
>>
>> Xiangdong
>>
>> lid velocity = 0.000106281, prandtl # = 1., grashof # = 1.
>>   0 SNES Function norm 1.036007954337e-02
>>     0 KSP Residual norm 9.158537890035e-02
>> [0]PETSC ERROR: --------------------- Error Message
>> --------------------------------------------------------------
>> [0]PETSC ERROR: Invalid argument
>> [0]PETSC ERROR: Object (seq) is not seqcuda or mpicuda
>> [0]PETSC ERROR: See https://www.mcs.anl.gov/petsc/documentation/faq.html
>> for trouble shooting.
>> [0]PETSC ERROR: Petsc Development GIT revision: v3.11.3-1064-g8b74309384
>>  GIT Date: 2019-07-03 10:24:59 -0400
>> [0]PETSC ERROR: ./extest on a arch-debug2 named new by eps Fri Jul  5
>> 22:57:02 2019
>> [0]PETSC ERROR: Configure options PETSC_ARCH=arch-debug2
>> --with-debugging=1 --with-mpi-dir=/home/eps/MyLocal/mpi/mpich
>> --with-blaslapack-dir=/home/eps/MyLocal/intel/mkl --with-cuda=1
>> [0]PETSC ERROR: #1 VecCUDAGetArrayRead() line 1304 in
>> /home/eps/MyLocal/petsc-mark/src/vec/vec/impls/seq/seqcuda/veccuda2.cu
>> [0]PETSC ERROR: #2 MatMultAdd_SeqAIJCUSPARSE() line 1415 in
>> /home/eps/MyLocal/petsc-mark/src/mat/impls/aij/seq/seqcusparse/
>> aijcusparse.cu
>> [0]PETSC ERROR: #3 MatMult_SeqAIJCUSPARSE() line 1347 in
>> /home/eps/MyLocal/petsc-mark/src/mat/impls/aij/seq/seqcusparse/
>> aijcusparse.cu
>> [0]PETSC ERROR: #4 MatMult() line 2368 in
>> /home/eps/MyLocal/petsc-mark/src/mat/interface/matrix.c
>> [0]PETSC ERROR: #5 PCApplyBAorAB() line 662 in
>> /home/eps/MyLocal/petsc-mark/src/ksp/pc/interface/precon.c
>> [0]PETSC ERROR: #6 KSP_PCApplyBAorAB() line 309 in
>> /home/eps/MyLocal/petsc-mark/include/petsc/private/kspimpl.h
>> [0]PETSC ERROR: #7 KSPGMRESCycle() line 152 in
>> /home/eps/MyLocal/petsc-mark/src/ksp/ksp/impls/gmres/gmres.c
>> [0]PETSC ERROR: #8 KSPSolve_GMRES() line 237 in
>> /home/eps/MyLocal/petsc-mark/src/ksp/ksp/impls/gmres/gmres.c
>> [0]PETSC ERROR: #9 KSPSolve() line 764 in
>> /home/eps/MyLocal/petsc-mark/src/ksp/ksp/interface/itfunc.c
>> [0]PETSC ERROR: #10 SNESSolve_NEWTONLS() line 225 in
>> /home/eps/MyLocal/petsc-mark/src/snes/impls/ls/ls.c
>> [0]PETSC ERROR: #11 SNESSolve() line 4430 in
>> /home/eps/MyLocal/petsc-mark/src/snes/interface/snes.c
>> [0]PETSC ERROR: #12 main() line 161 in
>> /home/eps/MyCodes/petsctest/extest.c
>> [0]PETSC ERROR: PETSc Option Table entries:
>> [0]PETSC ERROR: -da_refine 5
>> [0]PETSC ERROR: -ksp_monitor
>> [0]PETSC ERROR: -mat_type aijcusparse
>> [0]PETSC ERROR: -snes_monitor
>> [0]PETSC ERROR: -snes_view
>> [0]PETSC ERROR: -vec_type cuda
>> [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, 62) - process 0
>>
>> On Wed, Jul 3, 2019 at 10:27 AM Mark Adams <mfadams at lbl.gov> wrote:
>>
>>> My branch mark/gamg-fix-viennacl-rebased fixes this problem for me.
>>> Please give it a try.
>>> Thanks,
>>> Mark
>>>
>>> On Tue, Jul 2, 2019 at 10:41 PM Xiangdong via petsc-users <
>>> petsc-users at mcs.anl.gov> wrote:
>>>
>>>> Hello everyone,
>>>>
>>>> When I run the ex19 with cuda like this:
>>>>  mpiexec -np 4 ./ex19 -da_refine 5 -snes_view -snes_monitor
>>>> -ksp_monitor -mat_type aijcusparse -vec_type cuda  -log_view
>>>>
>>>> it worked fine and produced correct results.
>>>>
>>>> However, when I tried to run this example with nvprof:
>>>> nvprof --profile-child-processes mpiexec -np 4 ./extest -da_refine 5
>>>> -snes_view -snes_monitor -ksp_monitor -mat_type aijcusparse -vec_type cuda
>>>>  -log_view
>>>>
>>>> I got errors like:
>>>> [3]PETSC ERROR: Error in external library
>>>> [3]PETSC ERROR: CUDA error 700
>>>> [3]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html
>>>> for trouble shooting.
>>>> [3]PETSC ERROR: Petsc Release Version 3.11.2, unknown
>>>> [3]PETSC ERROR: ./ex19 on a arch-opt named new by eps Tue Jul  2
>>>> 22:26:01 2019
>>>> [3]PETSC ERROR: Configure options PETSC_ARCH=arch-opt
>>>> --with-debugging=0 --with-mpi-dir=/home/eps/MyLocal/mpi/mpich
>>>> --with-blaslapack-dir=/home/eps/MyLocal/intel/mkl
>>>> --with-cuda-dir=/home/eps/MyLocal/cuda
>>>> --with-hypre-dir=/home/eps/MyLocal/hypre-2.15.1/hypre-install
>>>> --download-hdf5=1
>>>> [3]PETSC ERROR: #1 VecSet_SeqCUDA() line 785 in
>>>> /home/eps/MyLocal/petsc/src/vec/vec/impls/seq/seqcuda/veccuda2.cu
>>>> [3]PETSC ERROR: #2 VecSet() line 547 in
>>>> /home/eps/MyLocal/petsc/src/vec/vec/interface/rvector.c
>>>> [3]PETSC ERROR: #3 VecCreate_MPICUDA() line 178 in
>>>> /home/eps/MyLocal/petsc/src/vec/vec/impls/mpi/mpicuda/mpicuda.cu
>>>> [3]PETSC ERROR: #4 VecSetType() line 51 in
>>>> /home/eps/MyLocal/petsc/src/vec/vec/interface/vecreg.c
>>>> [3]PETSC ERROR: #5 VecCreate_CUDA() line 192 in
>>>> /home/eps/MyLocal/petsc/src/vec/vec/impls/mpi/mpicuda/mpicuda.cu
>>>> [3]PETSC ERROR: #6 VecSetType() line 51 in
>>>> /home/eps/MyLocal/petsc/src/vec/vec/interface/vecreg.c
>>>> [3]PETSC ERROR: #7 MatCreateVecs() line 8996 in
>>>> /home/eps/MyLocal/petsc/src/mat/interface/matrix.c
>>>> [3]PETSC ERROR: #8 MatFDColoringCreate() line 482 in
>>>> /home/eps/MyLocal/petsc/src/mat/matfd/fdmatrix.c
>>>> [3]PETSC ERROR: #9 SNESComputeJacobian_DMDA() line 175 in
>>>> /home/eps/MyLocal/petsc/src/snes/utils/dmdasnes.c
>>>> [3]PETSC ERROR: #10 SNESComputeJacobian() line 2718 in
>>>> /home/eps/MyLocal/petsc/src/snes/interface/snes.c
>>>> [3]PETSC ERROR: #11 SNESSolve_NEWTONLS() line 222 in
>>>> /home/eps/MyLocal/petsc/src/snes/impls/ls/ls.c
>>>> [3]PETSC ERROR: #12 SNESSolve() line 4560 in
>>>> /home/eps/MyLocal/petsc/src/snes/interface/snes.c
>>>> [3]PETSC ERROR: #13 main() line 161 in
>>>> /home/eps/MyCodes/petsctest/extest.c
>>>>
>>>> The full run log is attached.
>>>>
>>>> I am using  NVIDIA-SMI 418.56       Driver Version: 418.56       CUDA
>>>> Version: 10.1.
>>>>
>>>> I do not know why it is okay without nvprof but crashed with nvprof.
>>>> Any suggestion to fix this?
>>>>
>>>> Thank you.
>>>>
>>>> Best,
>>>> Xiangdong
>>>>
>>>>
-------------- next part --------------
An HTML attachment was scrubbed...
URL: <http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20190706/1ab77cfa/attachment-0001.html>


More information about the petsc-users mailing list