<div dir="ltr">Hello everyone,<div><br></div><div>Are there more ideas why when using <span style="font-size:13px;font-family:arial,sans-serif">MatSetOption(mat, MAT_NEW_NONZERO_ALLOCATION_</span><span style="font-size:13px;font-family:arial,sans-serif">ERR,PETSC_FALSE), the processor seems trying to access elements that are out of local range?</span></div>
<div><span style="font-size:13px;font-family:arial,sans-serif"><br></span></div><div><span style="font-size:13px;font-family:arial,sans-serif">Anybody can help? Thank you so much.</span></div><div><br></div><div>Best regards,</div>
<div>Jifeng Zhao</div></div><div class="gmail_extra"><br><br><div class="gmail_quote">On Sun, Jul 27, 2014 at 3:37 PM, jifeng zhao <span dir="ltr"><<a href="mailto:jifengzhao2015@u.northwestern.edu" target="_blank">jifengzhao2015@u.northwestern.edu</a>></span> wrote:<br>
<blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex"><div dir="ltr">Thank you all for the insights. <div><br></div><div>I tried to add <span style="font-size:13px;font-family:arial,sans-serif">MatSetOption(mat, MAT_NEW_NONZERO_ALLOCATION_</span><span style="font-size:13px;font-family:arial,sans-serif">ERR,PETSC_FALSE). It does solve the malloc error. However there appears to be another error:</span></div>

<div><span style="font-size:13px;font-family:arial,sans-serif"><br></span></div><div><span style="font-size:13px;font-family:arial,sans-serif">In addition, 66324 appears to be the number of index that is assigned to each processor. </span></div>

<div><span style="font-size:13px;font-family:arial,sans-serif"><br></span></div><div><font face="arial, sans-serif">Any more insights? Thanks a lot! </font></div><div class=""><div><span style="font-size:13px;font-family:arial,sans-serif"><br>

</span></div>PETSC ERROR: Argument out of range!<br></div>PETSC ERROR: <b>Column too large: col 935748 max 66324!</b><br>PETSC ERROR: ------------------------------------------------------------------------<br>PETSC ERROR: Petsc Release Version 3.4.4, Mar, 13, 2014<br>

PETSC ERROR: See docs/changes/index.html for recent updates.<br>PETSC ERROR: See docs/faq.html for hints about trouble shooting.<br>PETSC ERROR: See docs/index.html for manual pages.<br>PETSC ERROR: ------------------------------------------------------------------------<br>

PETSC ERROR: eigen_solver20 on a arch-linux2-c-debug named qnode4091 by jzh953 Sun Jul 27 15:17:28 2014<br>PETSC ERROR: Libraries linked from /software/petsc/3.4.4/lib<br>PETSC ERROR: Configure run at Tue Jul  8 14:20:27 2014<br>

]PETSC ERROR: Configure options --prefix=/software/petsc/3.4.4 --with-blas-lib=/software/lapack/3.5.0/lib/libblas.so --with-lapack-lib=/software/lapack/3.5.0/liblapack.so --with-hdf5-dir=/software/hdf5/1.8.12 with-boost=1 --with-boost-dir=/software/hdf5/1.8.12 --with-fftw=1 --with-fftw-dir=/software/FFTW/3.3.3-gcc-threads --with-valgrind-dir=/software/valgrind/3.8.1 --with-netcdf=1 --with-netcdf-dir=/software/netCDF/4.2 --with-hdf5=1 --with-debugging=1 --with-mpi-dir=/software/mpi/openmpi-1.6.3-gcc-4.6.3-trq4 --download-scalapack --download-mumps --download-hypre --download-parmetis --download-metis<br>

<br>PETSC ERROR: ------------------------------------------------------------------------<div>PETSC ERROR: MatSetValues_SeqSBAIJ() line 986 in /hpc/software/sources/builds/petsc-3.4.4/src/mat/impls/sbaij/seq/sbaij.c<br>PETSC ERROR: MatDisAssemble_MPISBAIJ() line 356 in /hpc/software/sources/builds/petsc-3.4.4/src/mat/impls/sbaij/mpi/mmsbaij.c<br>

PETSC ERROR: MatSetValues_MPISBAIJ() line 213 in /hpc/software/sources/builds/petsc-3.4.4/src/mat/impls/sbaij/mpi/mpisbaij.c<br>PETSC ERROR: MatSetValues() line 1106 in /hpc/software/sources/builds/petsc-3.4.4/src/mat/interface/matrix.c<br>

PETSC ERROR: MatAXPY_Basic() line 78 in /hpc/software/sources/builds/petsc-3.4.4/src/mat/utils/axpy.c<br>PETSC ERROR: MatAXPY_MPISBAIJ() line 1398 in /hpc/software/sources/builds/petsc-3.4.4/src/mat/impls/sbaij/mpi/mpisbaij.c<br>

PETSC ERROR: MatAXPY() line 39 in /hpc/software/sources/builds/petsc-3.4.4/src/mat/utils/axpy.c<br>PETSC ERROR: STMatGAXPY_Private() line 375 in src/st/interface/stsolve.c<br>PETSC ERROR: STSetUp_Sinvert() line 138 in src/st/impls/sinvert/sinvert.c<br>

PETSC ERROR: STSetUp() line 294 in src/st/interface/stsolve.c<br>PETSC ERROR: EPSSetUp() line 215 in src/eps/interface/setup.c<br>PETSC ERROR: EPSSolve() line 90 in src/eps/interface/solve.c<br>PETSC ERROR: --------------------------------------------------------------------------</div>

</div><div class="gmail_extra"><div><div class="h5"><br><br><div class="gmail_quote">On Sat, Jul 26, 2014 at 12:35 PM, Jose E. Roman <span dir="ltr"><<a href="mailto:jroman@dsic.upv.es" target="_blank">jroman@dsic.upv.es</a>></span> wrote:<br>

<blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex">The problem is that your stiffness and mass matrices have different nonzero pattern.<br>
<br>
The -eps_target configuration computes a MatAXPY on the first matrix (stiffness), so MatSetOption(mat, MAT_NEW_NONZERO_ALLOCATION_ERR,PETSC_FALSE) could be called on this matrix, as Barry suggests.<br>
<br>
Another workaround would be to force both of them having the same nonzero pattern, maybe using MatSetOption(mat,MAT_IGNORE_ZERO_ENTRIES,PETSC_FALSE).<br>
<br>
Also, this problem would not appear with target=0.0.<br>
<br>
See details on section 3.4.2 of SLEPc's users guide.<br>
<br>
Jose<br>
<br>
<br>
<br>
El 26/07/2014, a las 19:04, Barry Smith escribió:<br>
<div><div><br>
><br>
>  We need the entire error message. A matrix is being formed that wasn’t fully preallocated for so you need to determine which matrix and make sure either 1) it gets fully preallocated or 2) MatSetOption(mat, MAT_NEW_NONZERO_ALLOCATION_ERR,PETSC_FALSE) is called on the matrix<br>


><br>
>  Barry<br>
><br>
> On Jul 26, 2014, at 10:34 AM, jifeng zhao <<a href="mailto:jifengzhao2015@u.northwestern.edu" target="_blank">jifengzhao2015@u.northwestern.edu</a>> wrote:<br>
><br>
>> Hello all,<br>
>><br>
>> I am trying to use ex7 to solve series of generalized problem. The running commands are:<br>
>><br>
>> ./ex7 -f1 petsc_stiff19.dat -f2 petsc_mass19.dat -mat_type sbaij -eps_gen_hermitian -eps_type krylovschur -eps_smallest_magnitude. -eps_monitor_conv -st_k    sp_type bcgs -st_pc_type bjacobi -st_sub_pc_type icc -st_ksp_rtol 1.e-4 -eps_tol 1.e-4 -eps_nev 40 -st_type sinvert<br>


>><br>
>> It works fine, but when my problem contains zero eigenvalue, it fails to converge.<br>
>><br>
>> Supposedly, I should use eps_target -0.1 instead of eps_smallest_magnitude. However if eps_target is used, I run into a memory issue:<br>
>><br>
>> PETSC ERROR: --------------------- Error Message ------------------------------------<br>
>> PETSC ERROR: Argument out of range!<br>
>> PETSC ERROR: New nonzero at (0,6) caused a malloc!<br>
>> PETSC ERROR: ------------------------------------------------------------------------<br>
>><br>
>> Does anybody know how to solve this? Thanks!<br>
>><br>
>> Jifeng Zhao<br>
>> PhD candidate at Northwestern University, US<br>
>> Theoretical and Applied Mechanics Program<br>
><br>
<br>
</div></div></blockquote></div><br><br clear="all"><div><br></div></div></div>-- <br><div class=""><div dir="ltr">Jifeng Zhao<div>PhD candidate at Northwestern University, US</div><div>Theoretical and Applied Mechanics Program</div>
</div>
</div></div>
</blockquote></div><br><br clear="all"><div><br></div>-- <br><div dir="ltr">Jifeng Zhao<div>PhD candidate at Northwestern University, US</div><div>Theoretical and Applied Mechanics Program</div></div>
</div>