[petsc-users] ask for the ERROR MESSAGE

ziming xiong xiongziming2010 at gmail.com
Wed May 31 09:53:02 CDT 2023


Hello,
I created a code for solving the finite element method using the PCBDDC
method according to ex71, but I got the following error at the end, I can't
find out the cause of the error, can you tell me what the error is based on
the error message?
 (PS. I have tried:
Mat AA.
PetscCall(MatConvert(A, MATAIJ, MAT_INITIAL_MATRIX, &AA)).
to change the matrix type and then solve for AA, it works fine)

[0]PETSC ERROR: --------------------- Error Message
--------------------------------------------------------------
[1]PETSC ERROR: --------------------- Error Message
--------------------------------------------------------------
[0]PETSC ERROR:
[1]PETSC ERROR:
Error in external library
Error in external library
[0]PETSC ERROR:
[1]PETSC ERROR:
Error in query to SYEV Lapack routine 0
Error in query to SYEV Lapack routine 0
[0]PETSC ERROR:
[1]PETSC ERROR:
See https://petsc.org/release/faq/ for trouble shooting.
See https://petsc.org/release/faq/ for trouble shooting.
[0]PETSC ERROR:
[1]PETSC ERROR:
Petsc Development GIT revision: unknown  GIT Date: unknown
Petsc Development GIT revision: unknown  GIT Date: unknown
[0]PETSC ERROR:
[1]PETSC ERROR:
test_petsc_fem.exe on a arch-mswin-c-debug named lmeep-329 by XiongZiming
Wed May 31 16:52:36 2023
test_petsc_fem.exe on a arch-mswin-c-debug named lmeep-329 by XiongZiming
Wed May 31 16:52:36 2023
[0]PETSC ERROR:
[1]PETSC ERROR:
Configure options
--with-cc=/cygdrive/f/post_doc_C++/petsc_new/petsc-main/lib/petsc/bin/win32fe/win_cl
--with-cxx=/cygdrive/f/post_doc_C++/petsc_new/petsc-main/lib/petsc/bin/win32fe/win_cl
--with-fc=0 --download-metis --with-shared-libraries=0
--with-mpi-include="[/cygdrive/c/PROGRA~2/Intel/MPI/Include,/cygdrive/c/PROGRA~2/Intel/MPI/Include/x64]"
--with-mpi-lib="-L/cygdrive/c/PROGRA~2/Intel/MPI/lib/x64 msmpifec.lib
msmpi.lib" --with-mpiexec=/cygdrive/c/PROGRA~1/Microsoft_MPI/Bin/mpiexec
--with-blaslapack-lib="-L/cygdrive/c/PROGRA~2/Intel/oneAPI/mkl/latest/lib/intel64
mkl_intel_lp64_dll.lib mkl_sequential_dll.lib mkl_core_dll.lib"
--with-64-bit-indices
--with-mkl_pardiso-dir=/cygdrive/c/PROGRA~2/Intel/oneAPI/mkl/latest
Configure options
--with-cc=/cygdrive/f/post_doc_C++/petsc_new/petsc-main/lib/petsc/bin/win32fe/win_cl
--with-cxx=/cygdrive/f/post_doc_C++/petsc_new/petsc-main/lib/petsc/bin/win32fe/win_cl
--with-fc=0 --download-metis --with-shared-libraries=0
--with-mpi-include="[/cygdrive/c/PROGRA~2/Intel/MPI/Include,/cygdrive/c/PROGRA~2/Intel/MPI/Include/x64]"
--with-mpi-lib="-L/cygdrive/c/PROGRA~2/Intel/MPI/lib/x64 msmpifec.lib
msmpi.lib" --with-mpiexec=/cygdrive/c/PROGRA~1/Microsoft_MPI/Bin/mpiexec
--with-blaslapack-lib="-L/cygdrive/c/PROGRA~2/Intel/oneAPI/mkl/latest/lib/intel64
mkl_intel_lp64_dll.lib mkl_sequential_dll.lib mkl_core_dll.lib"
--with-64-bit-indices
--with-mkl_pardiso-dir=/cygdrive/c/PROGRA~2/Intel/oneAPI/mkl/latest
[0]PETSC ERROR:
[1]PETSC ERROR:
#1 PCBDDCConstraintsSetUp() at
F:\post_doc_C++\petsc_new\petsc-main\src\ksp\pc\impls\bddc\bddcprivate.c:5975
#1 PCBDDCConstraintsSetUp() at
F:\post_doc_C++\petsc_new\petsc-main\src\ksp\pc\impls\bddc\bddcprivate.c:5975
[0]PETSC ERROR:
[1]PETSC ERROR:
#2 PCSetUp_BDDC() at
F:\post_doc_C++\petsc_new\petsc-main\src\ksp\pc\impls\bddc\bddc.c:1659
#2 PCSetUp_BDDC() at
F:\post_doc_C++\petsc_new\petsc-main\src\ksp\pc\impls\bddc\bddc.c:1659
[0]PETSC ERROR:
[1]PETSC ERROR:
#3 PCSetUp() at
F:\post_doc_C++\petsc_new\petsc-main\src\ksp\pc\interface\precon.c:994
#3 PCSetUp() at
F:\post_doc_C++\petsc_new\petsc-main\src\ksp\pc\interface\precon.c:994
[1]PETSC ERROR:
[0]PETSC ERROR:
#4 KSPSetUp() at
F:\post_doc_C++\petsc_new\petsc-main\src\ksp\ksp\interface\itfunc.c:406
#4 KSPSetUp() at
F:\post_doc_C++\petsc_new\petsc-main\src\ksp\ksp\interface\itfunc.c:406
[1]PETSC ERROR:
[0]PETSC ERROR:
#5 petsc_calcul_part_DMDA() at petsc_DMDA.cpp:285
#5 petsc_calcul_part_DMDA() at petsc_DMDA.cpp:285
[1]PETSC ERROR:
[0]PETSC ERROR:
#6 main() at ..\Main.cpp:281
#6 main() at ..\Main.cpp:281
[1]PETSC ERROR:
[0]PETSC ERROR:
No PETSc Option Table entries
No PETSc Option Table entries
[1]PETSC ERROR:
[0]PETSC ERROR:
----------------End of Error Message -------send entire error message to
petsc-maint at mcs.anl.gov----------
----------------End of Error Message -------send entire error message to
petsc-maint at mcs.anl.gov----------

job aborted:
[ranks] message

[0-1] application aborted
aborting MPI_COMM_SELF (comm=0x44000001), error 76, comm rank 0

---- error analysis -----

[0-1] on lmeep-329
test_petsc_fem.exe aborted the job. abort code 76

---- error analysis -----



Ziming XIONG
-------------- next part --------------
An HTML attachment was scrubbed...
URL: <http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20230531/75065f7d/attachment.html>


More information about the petsc-users mailing list