<div dir="ltr">Hello,<div>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?</div><div> (PS. I have tried:</div>Mat AA.<br>PetscCall(MatConvert(A, MATAIJ, MAT_INITIAL_MATRIX, &AA)).<br>to change the matrix type and then solve for AA, it works fine)<div><br></div><div>[0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------<br>[1]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------<br>[0]PETSC ERROR:<br>[1]PETSC ERROR:<br>Error in external library<br>Error in external library<br>[0]PETSC ERROR:<br>[1]PETSC ERROR:<br>Error in query to SYEV Lapack routine 0<br>Error in query to SYEV Lapack routine 0<br>[0]PETSC ERROR:<br>[1]PETSC ERROR:<br>See <a href="https://petsc.org/release/faq/">https://petsc.org/release/faq/</a> for trouble shooting.<br>See <a href="https://petsc.org/release/faq/">https://petsc.org/release/faq/</a> for trouble shooting.<br>[0]PETSC ERROR:<br>[1]PETSC ERROR:<br>Petsc Development GIT revision: unknown  GIT Date: unknown<br>Petsc Development GIT revision: unknown  GIT Date: unknown<br>[0]PETSC ERROR:<br>[1]PETSC ERROR:<br>test_petsc_fem.exe on a arch-mswin-c-debug named lmeep-329 by XiongZiming Wed May 31 16:52:36 2023<br>test_petsc_fem.exe on a arch-mswin-c-debug named lmeep-329 by XiongZiming Wed May 31 16:52:36 2023<br>[0]PETSC ERROR:<br>[1]PETSC ERROR:<br>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<br>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<br>[0]PETSC ERROR:<br>[1]PETSC ERROR:<br>#1 PCBDDCConstraintsSetUp() at F:\post_doc_C++\petsc_new\petsc-main\src\ksp\pc\impls\bddc\bddcprivate.c:5975<br>#1 PCBDDCConstraintsSetUp() at F:\post_doc_C++\petsc_new\petsc-main\src\ksp\pc\impls\bddc\bddcprivate.c:5975<br>[0]PETSC ERROR:<br>[1]PETSC ERROR:<br>#2 PCSetUp_BDDC() at F:\post_doc_C++\petsc_new\petsc-main\src\ksp\pc\impls\bddc\bddc.c:1659<br>#2 PCSetUp_BDDC() at F:\post_doc_C++\petsc_new\petsc-main\src\ksp\pc\impls\bddc\bddc.c:1659<br>[0]PETSC ERROR:<br>[1]PETSC ERROR:<br>#3 PCSetUp() at F:\post_doc_C++\petsc_new\petsc-main\src\ksp\pc\interface\precon.c:994<br>#3 PCSetUp() at F:\post_doc_C++\petsc_new\petsc-main\src\ksp\pc\interface\precon.c:994<br>[1]PETSC ERROR:<br>[0]PETSC ERROR:<br>#4 KSPSetUp() at F:\post_doc_C++\petsc_new\petsc-main\src\ksp\ksp\interface\itfunc.c:406<br>#4 KSPSetUp() at F:\post_doc_C++\petsc_new\petsc-main\src\ksp\ksp\interface\itfunc.c:406<br>[1]PETSC ERROR:<br>[0]PETSC ERROR:<br>#5 petsc_calcul_part_DMDA() at petsc_DMDA.cpp:285<br>#5 petsc_calcul_part_DMDA() at petsc_DMDA.cpp:285<br>[1]PETSC ERROR:<br>[0]PETSC ERROR:<br>#6 main() at ..\Main.cpp:281<br>#6 main() at ..\Main.cpp:281<br>[1]PETSC ERROR:<br>[0]PETSC ERROR:<br>No PETSc Option Table entries<br>No PETSc Option Table entries<br>[1]PETSC ERROR:<br>[0]PETSC ERROR:<br>----------------End of Error Message -------send entire error message to petsc-maint@mcs.anl.gov----------<br>----------------End of Error Message -------send entire error message to petsc-maint@mcs.anl.gov----------<br><br>job aborted:<br>[ranks] message<br><br>[0-1] application aborted<br>aborting MPI_COMM_SELF (comm=0x44000001), error 76, comm rank 0<br><br>---- error analysis -----<br><br>[0-1] on lmeep-329<br>test_petsc_fem.exe aborted the job. abort code 76<br><br>---- error analysis -----<br></div><div><br></div><div><br></div><div><br></div><div>Ziming XIONG</div></div>