<div dir="ltr"><div dir="ltr">On Thu, Jul 11, 2019 at 12:37 PM Povolotskyi, Mykhailo via petsc-users <<a href="mailto:petsc-users@mcs.anl.gov">petsc-users@mcs.anl.gov</a>> wrote:<br></div><div class="gmail_quote"><blockquote class="gmail_quote" style="margin:0px 0px 0px 0.8ex;border-left:1px solid rgb(204,204,204);padding-left:1ex">Hello,<br>
<br>
I want to use CISS for my eigenvalue problem. To test it I tried a <br>
simple (2x2) matrix case, but the code failed with the following message:<br>
<br>
[0]PETSC ERROR: --------------------- Error Message <br>
--------------------------------------------------------------<br>
[0]PETSC ERROR: Error in external library<br>
[0]PETSC ERROR: Error in LAPACK subroutine gesvd: info=127<br></blockquote><div><br></div><div>This does not make sense. The error is supposed to be the number of non-converged diagonals, but</div><div>you only have a 2x2 problem, so something else is wrong.</div><div><br></div><div>   Matt</div><div> </div><blockquote class="gmail_quote" style="margin:0px 0px 0px 0.8ex;border-left:1px solid rgb(204,204,204);padding-left:1ex">
[0]PETSC ERROR: See <a href="http://www.mcs.anl.gov/petsc/documentation/faq.html" rel="noreferrer" target="_blank">http://www.mcs.anl.gov/petsc/documentation/faq.html</a> <br>
for trouble shooting.<br>
[0]PETSC ERROR: Petsc Release Version 3.8.4, Mar, 24, 2018<br>
[0]PETSC ERROR: var1 on a linux-complex named <a href="http://brown-a027.rcac.purdue.edu" rel="noreferrer" target="_blank">brown-a027.rcac.purdue.edu</a> <br>
by mpovolot Thu Jul 11 13:28:21 2019<br>
[0]PETSC ERROR: Configure options --with-scalar-type=complex --with-x=0 <br>
--with-hdf5 --download-hdf5=1 --with-single-library=1 --with-pic=1 <br>
--with-shared-libraries=0 --with-log=0 --with-clanguage=C++ <br>
--CXXFLAGS="-fopenmp -fPIC" --CFLAGS="-fopenmp -fPIC" --with-fortran=0 <br>
--FFLAGS="-fopenmp -fPIC" --with-debugging=0 --with-cc=mpicc <br>
--with-fc=mpif90 --with-cxx=mpicxx COPTFLAGS= CXXOPTFLAGS= FOPTFLAGS= <br>
--download-metis=1 --download-parmetis=1 <br>
--with-valgrind-dir=/apps/brown/valgrind/3.13.0_gcc-4.8.5 <br>
--download-mumps=1 --with-fortran-kernels=0 --download-superlu_dist=1 <br>
--with-blaslapack-lib="-L/apps/cent7/intel/compilers_and_libraries_2017.1.132/linux/mkl/lib/intel64 <br>
-lmkl_intel_lp64 -lmkl_gnu_thread -lmkl_core " <br>
--with-blacs-lib=/apps/cent7/intel/compilers_and_libraries_2017.1.132/linux/mkl/lib/intel64/libmkl_blacs_intelmpi_lp64.so <br>
--with-blacs-include=/apps/cent7/intel/compilers_and_libraries_2017.1.132/linux/mkl/include <br>
--with-scalapack-lib="-Wl,-rpath,/apps/cent7/intel/compilers_and_libraries_2017.1.132/linux/mkl/lib/intel64 <br>
-L/apps/cent7/intel/compilers_and_libraries_2017.1.132/linux/mkl/lib/intel64 <br>
-lmkl_gf_lp64 -lmkl_gnu_thread -lmkl_core  -lpthread <br>
-L/apps/cent7/intel/compilers_and_libraries_2017.1.132/linux/mkl/lib/intel64 <br>
-lmkl_scalapack_lp64 -lmkl_blacs_intelmpi_lp64" <br>
--with-scalapack-include=/apps/cent7/intel/compilers_and_libraries_2017.1.132/linux/mkl/include<br>
[0]PETSC ERROR: #1 SVD_S() line 611 in <br>
/depot/kildisha/apps/brown/nemo5/libs/slepc/build-cplx/src/eps/impls/ciss/ciss.c<br>
[0]PETSC ERROR: #2 EPSSolve_CISS() line 1028 in <br>
/depot/kildisha/apps/brown/nemo5/libs/slepc/build-cplx/src/eps/impls/ciss/ciss.c<br>
[0]PETSC ERROR: #3 EPSSolve() line 147 in <br>
/depot/kildisha/apps/brown/nemo5/libs/slepc/build-cplx/src/eps/interface/epssolve.c<br>
<br>
<br>
Here is the code:<br>
<br>
void test1()<br>
{<br>
   Mat matrix_petsc;<br>
MatCreateDense(MPI_COMM_SELF,2,2,PETSC_DECIDE,PETSC_DECIDE,NULL,&matrix_petsc);<br>
MatSetValue(matrix_petsc,0,0,complex<double>(1,0),INSERT_VALUES);<br>
MatSetValue(matrix_petsc,1,1,complex<double>(2,0),INSERT_VALUES);<br>
MatSetValue(matrix_petsc,0,1,complex<double>(0,0),INSERT_VALUES);<br>
MatSetValue(matrix_petsc,1,0,complex<double>(0,0),INSERT_VALUES);<br>
   MatAssemblyBegin(matrix_petsc, MAT_FINAL_ASSEMBLY);<br>
   MatAssemblyEnd(matrix_petsc, MAT_FINAL_ASSEMBLY);<br>
<br>
  {<br>
       EPS            eps;<br>
       EPSType        type;<br>
       RG             rg;<br>
<br>
       EPSCreate(MPI_COMM_SELF,&eps);<br>
       EPSSetOperators( eps,matrix_petsc,NULL);<br>
       EPSSetType(eps,EPSCISS);<br>
       EPSSetProblemType(eps, EPS_NHEP);<br>
<br>
       double real_min = -10;<br>
       double real_max =  10;<br>
<br>
       double imag_min = -10;<br>
       double imag_max = 10;<br>
<br>
       EPSGetRG(eps,&rg);<br>
       RGSetType(rg,RGINTERVAL);<br>
RGIntervalSetEndpoints(rg,real_min,real_max,imag_min,imag_max);<br>
<br>
       EPSSolve(eps);<br>
<br>
       EPSDestroy(&eps);<br>
   }<br>
<br>
<br>
   MatDestroy(&matrix_petsc);<br>
<br>
}<br>
<br>
<br>
Do you see anything wrong in the way I'm calling SLEPC functions?<br>
<br>
Thank you,<br>
<br>
Michael.<br>
<br>
</blockquote></div><br clear="all"><div><br></div>-- <br><div dir="ltr" class="gmail_signature"><div dir="ltr"><div><div dir="ltr"><div><div dir="ltr"><div>What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead.<br>-- Norbert Wiener</div><div><br></div><div><a href="http://www.cse.buffalo.edu/~knepley/" target="_blank">https://www.cse.buffalo.edu/~knepley/</a><br></div></div></div></div></div></div></div></div>