<div dir="ltr"><div class="gmail_quote"><div dir="ltr">On Wed, Jul 4, 2018 at 8:47 AM Mark Adams <<a href="mailto:mfadams@lbl.gov">mfadams@lbl.gov</a>> wrote:<br></div><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex"><div dir="ltr">Sorry, this error was with MKL matrices. It is still an error inside of Plex. My non-Plex tests (KSP) now work in a branch (pushed).</div></blockquote><div><br></div><div>Ah, I might know what this is. When you ask the DM to create a matrix, it tries to convert it to the internal type</div><div>-dm_mat_type. Is this set to the type you want? Its possible we have some logic problem with when the conversion happens</div><div>that does not get triggered in the regular scenarios.</div><div><br></div><div>  Matt</div><div> </div><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex"><div class="gmail_quote"><div dir="ltr">On Tue, Jul 3, 2018 at 7:24 PM Mark Adams <<a href="mailto:mfadams@lbl.gov" target="_blank">mfadams@lbl.gov</a>> wrote:<br></div><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex"><div dir="ltr"><br><br><div class="gmail_quote"><div dir="ltr">On Tue, Jul 3, 2018 at 6:26 PM Jed Brown <<a href="mailto:jed@jedbrown.org" target="_blank">jed@jedbrown.org</a>> wrote:<br></div><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex">"Smith, Barry F." <<a href="mailto:bsmith@mcs.anl.gov" target="_blank">bsmith@mcs.anl.gov</a>> writes:<br>
<br>
>   Runs fine in the master branch;  do you really need it to work in maint.<br>
<br>
Uh, many users work with releases.  If this is a "regression" it implies<br>
that it worked at some point in the past.  In that case, we should fix<br>
it in 'maint' even if some new feature in 'master' has also fixed it.<br>
Note that Mark's prompt says he's on 'master', not 'maint'.<br></blockquote><div><br></div><div>Yea, let me double check this.</div><div> </div><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex">
<br>
>   Barry<br>
><br>
><br>
>> On Jul 3, 2018, at 6:39 AM, Mark Adams <<a href="mailto:mfadams@lbl.gov" target="_blank">mfadams@lbl.gov</a>> wrote:<br>
>> <br>
>> SNES ex56 seems to have regressed:<br>
>> <br>
>> 04:35 nid02516 master *= ~/petsc_install/petsc/src/snes/examples/tutorials$ make PETSC_DIR=/global/homes/m/madams/petsc_install/petsc-cori-knl-opt-intel-omp PETSC_ARCH="" runex56<br>
>> srun -n 1 ./ex56 -cells 2,2,1 -max_conv_its 3 -petscspace_order 2 -snes_max_it 2 -ksp_max_it 100 -ksp_type cg -ksp_rtol 1.e-11 -ksp_norm_type unpreconditioned -snes_rtol 1.e-10 -pc_type gamg -pc_gamg_type agg -pc_gamg_agg_nsmooths 1 -pc_gamg_coarse_eq_limit 1000 -pc_gamg_reuse_interpolation true -pc_gamg_square_graph 1 -pc_gamg_threshold 0.05 -pc_gamg_threshold_scale .0 -ksp_converged_reason -snes_monitor_short -ksp_monitor_short -snes_converged_reason -use_mat_nearnullspace true -mg_levels_ksp_max_it 1 -mg_levels_ksp_type chebyshev -mg_levels_esteig_ksp_type cg -mg_levels_esteig_ksp_max_it 10 -mg_levels_ksp_chebyshev_esteig 0,0.05,0,1.05 -mg_levels_pc_type jacobi -petscpartitioner_type simple -mat_block_size 3 -matptap_via scalable -ex56_dm_view -run_type 1                        <br>
>> OMP: Warning #239: KMP_AFFINITY: granularity=fine will be used.                                                                                                                                      <br>
>> [0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------                                                                                    <br>
>> [0]PETSC ERROR: Object is in wrong state                                                                                                                                                              <br>
>> [0]PETSC ERROR: Not for unassembled matrix                                                                                                                                                            <br>
>> [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> for trouble shooting.                                                                                                         <br>
>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-825-g3a11c7608d  GIT Date: 2018-07-01 06:15:09 +0200                                                                                          <br>
>> [0]PETSC ERROR: /global/u2/m/madams/petsc_install/petsc/src/snes/examples/tutorials/./ex56 on a  named nid02516 by madams Tue Jul  3 04:35:52 2018                                                    <br>
>> [0]PETSC ERROR: Configure options --known-level1-dcache-size=32768 --known-level1-dcache-linesize=64 --known-level1-dcache-assoc=8 --known-sizeof-char=1 --known-sizeof-void-p=8 --known-sizeof-short=2 --known-sizeof-int=4 --known-sizeof-long=8 --known-sizeof-long-long=8 --known-sizeof-float=4 --known-sizeof-double=8 --known-sizeof-size_t=8 --known-bits-per-byte=8 --known-memcmp-ok=1 --known-sizeof-MPI_Comm=4 --known-sizeof-MPI_Fint=4 --known-mpi-long-double=1 --known-mpi-int64_t=1 --known-mpi-c-double-complex=1 --known-mklspblas-supports-zero-based=0 --known-has-attribute-aligned=1 --with-cc=cc --with-cxx=CC --with-fc=ftn COPTFLAGS="  -g -O0 -mkl -static-intel" CXXOPTFLAGS="-g -O0 -mkl -static-intel" FOPTFLAGS="  -g -O0 -mkl -static-intel" --download-metis=1 --with-hypre-dir=/global/homes/m/madams/tmp/hypre32-2.14.0 --download-parmetis=1 LIBS="-L/opt/intel/compilers_and_libraries_2018.1.163/linux/mkl/lib/intel64 -lmkl_intel_lp64 -lmkl_intel_thread -lmkl_core -liomp5 -lpthread" --with-blaslapack-include=/opt/intel/compilers_and_libraries_2018.1.163/linux/mkl/include --with-debugging=1 --with-mpiexec=srun --with-batch=1 --known-mpi-shared-libraries=1 --known-64-bit-blas-indices=0 --with-64-bit-indices=0 PETSC_ARCH=arch-cori-knl-opt-intel-omp --with-openmp=1 --download-p4est=0 --with-x=0 --prefix=/global/homes/m/madams/petsc_install/petsc-cori-knl-opt-intel-omp PETSC_DIR=/global/homes/m/madams/petsc_install/petsc<br>
>> [0]PETSC ERROR: #1 MatConvert() line 4066 in /global/u2/m/madams/petsc_install/petsc/src/mat/interface/matrix.c<br>
>> [0]PETSC ERROR: #2 MatSetType() line 67 in /global/u2/m/madams/petsc_install/petsc/src/mat/interface/matreg.c<br>
>> [0]PETSC ERROR: #3 MatSetFromOptions() line 229 in /global/u2/m/madams/petsc_install/petsc/src/mat/utils/gcreate.c<br>
>> [0]PETSC ERROR: #4 DMCreateMatrix_Plex() line 1137 in /global/u2/m/madams/petsc_install/petsc/src/dm/impls/plex/plex.c<br>
>> [0]PETSC ERROR: #5 DMCreateMatrix() line 1266 in /global/u2/m/madams/petsc_install/petsc/src/dm/interface/dm.c<br>
>> [0]PETSC ERROR: #6 main() line 428 in /global/homes/m/madams/petsc_install/petsc/src/snes/examples/tutorials/ex56.c<br>
>> [0]PETSC ERROR: PETSc Option Table entries:<br>
>> [0]PETSC ERROR: -cells 2,2,1<br>
>> [0]PETSC ERROR: -ex56_dm_refine 0<br>
>> [0]PETSC ERROR: -ex56_dm_view<br>
>> [0]PETSC ERROR: -ksp_converged_reason<br>
>> [0]PETSC ERROR: -ksp_max_it 100<br>
>> [0]PETSC ERROR: -ksp_monitor_short<br>
>> [0]PETSC ERROR: -ksp_norm_type unpreconditioned<br>
>> [0]PETSC ERROR: -ksp_rtol 1.e-11<br>
>> [0]PETSC ERROR: -ksp_type cg<br>
>> [0]PETSC ERROR: -mat_block_size 3<br>
>> [0]PETSC ERROR: -mat_type aijmkl<br>
>> [0]PETSC ERROR: -matptap_via scalable<br>
>> [0]PETSC ERROR: -max_conv_its 3<br>
>> [0]PETSC ERROR: -mg_levels_esteig_ksp_max_it 10<br>
>> [0]PETSC ERROR: -mg_levels_esteig_ksp_type cg<br>
>> [0]PETSC ERROR: -mg_levels_ksp_chebyshev_esteig 0,0.05,0,1.05<br>
>> [0]PETSC ERROR: -mg_levels_ksp_max_it 1<br>
>> [0]PETSC ERROR: -mg_levels_ksp_type chebyshev<br>
>> [0]PETSC ERROR: -mg_levels_pc_type jacobi<br>
>> [0]PETSC ERROR: -pc_gamg_agg_nsmooths 1<br>
>> [0]PETSC ERROR: -pc_gamg_coarse_eq_limit 1000<br>
>> [0]PETSC ERROR: -pc_gamg_reuse_interpolation true<br>
>> [0]PETSC ERROR: -pc_gamg_square_graph 1<br>
>> <br>
</blockquote></div></div>
</blockquote></div>
</blockquote></div><br clear="all"><div><br></div>-- <br><div dir="ltr" class="gmail_signature" data-smartmail="gmail_signature"><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.caam.rice.edu/~mk51/" target="_blank">https://www.cse.buffalo.edu/~knepley/</a><br></div></div></div></div></div></div>