<div dir="ltr">Hi Jed,<div><br></div><div>Earlier I completely missed your point. I believe the utility of <span style="font-size:12.7272720336914px">SNESSetFunctionDomainError is that an application can determine if the state (xx) being passed to compute residual function is </span>meaningful (eg. a pair of (P,T) could result in negative density). If the state is not meaningful, the application<span style="font-size:12.7272720336914px"> could simply call </span><span style="font-size:12.7272720336914px">SNESSetFunctionDomainError() and not update the residual vector. This would cause SNES to exit with </span><span style="font-size:12.7272720336914px">SNES_DIVERGED_FUNCTION_DOMAIN.</span></div><div><br></div><div>Looking at PFLOTRAN code more carefully, I now realize that Peter is using <span style="font-size:12.7272720336914px">SNESSetFunctionDomainError() in FLASH2/MPHASE/MISCIBLE/IMMISCIBLE modes. I will now implement similar check for TH mode.</span><br><div><span style="font-size:12.7272720336914px"><br></span></div><div><span style="font-size:12.7272720336914px">Thanks,</span></div><div>-Gautam.<br></div></div></div><div class="gmail_extra"><br><div class="gmail_quote">On Wed, Dec 3, 2014 at 12:13 PM, Gautam Bisht <span dir="ltr"><<a href="mailto:gbisht@lbl.gov" target="_blank">gbisht@lbl.gov</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">The user function was putting NaNs in the residual vector. I ended up fixing the user function to avoid putting NaNs in the residual vector.<span class="HOEnZb"><font color="#888888"><div><br></div></font></span><div><span class="HOEnZb"><font color="#888888">-Gautam.</font></span><div><div class="h5"><br><div class="gmail_extra"><br><div class="gmail_quote">On Wed, Dec 3, 2014 at 10:48 AM, Jed Brown <span dir="ltr"><<a href="mailto:jed@jedbrown.org" target="_blank">jed@jedbrown.org</a>></span> wrote:<br><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex"><span>"Hammond, Glenn E" <<a href="mailto:gehammo@sandia.gov" target="_blank">gehammo@sandia.gov</a>> writes:<br>
<br>
> Can you explain why the NaNs or infs are being produced in the first place, or at least pinpoint the location and catch it there?<br>
<br>
</span>If the SNESFunction computes NaN because the state is invalid, please<br>
call SNESSetFunctionDomainError and don't update the residual vector (or<br>
don't put NaN in there).  SNES will clean up and return with<br>
SNESConvergedReason SNES_DIVERGED_FUNCTION_DOMAIN.<br>
<br>
We don't do this by default because detecting NaN collectively requires<br>
an extra reduction.  Perhaps SNES could have a mode that automatically<br>
checks.<br>
<span><br>
><br>
> Glenn<br>
><br>
> From: <a href="mailto:pflotran-dev@googlegroups.com" target="_blank">pflotran-dev@googlegroups.com</a> [mailto:<a href="mailto:pflotran-dev@googlegroups.com" target="_blank">pflotran-dev@googlegroups.com</a>] On Behalf Of Gautam Bisht<br>
> Sent: Wednesday, December 03, 2014 8:36 AM<br>
> To: <a href="mailto:pflotran-dev@googlegroups.com" target="_blank">pflotran-dev@googlegroups.com</a><br>
> Subject: [EXTERNAL] [pflotran-dev: 2695] Unintended consequence of CHKERRQ()<br>
><br>
> The issue is that when SNES diverges with a "not-a-number or infinite", the code crashes without giving timestepper_BE a chance to reduce the time-step. But, if CHKERRQ() is commented out after call to SNESSolve(), the code is able to reduce dt sufficiently to converge due to "itol_res" (PFLOTRAN's custom convergence reason == inorm_residual < solver%newton_inf_res_tol). Attached below is inputdeck (with an outrages initial dt = 1yr to illustrate the issue). Apart from commenting out CHKERRQ(), is there an alternate way to let timestepper_BE reduce dt?<br>
><br>
> Below are relevant information to reproduce the error.<br>
><br>
>>hg tip<br>
> changeset:   8541:fa2d4295aa14<br>
> tag:         tip<br>
</span>> user:        Nathan Collier <<a href="mailto:nathaniel.collier@gmail.com" target="_blank">nathaniel.collier@gmail.com</a><mailto:<a href="mailto:nathaniel.collier@gmail.com" target="_blank">nathaniel.collier@gmail.com</a>>><br>
<span>> date:        Wed Dec 03 08:52:00 2014 -0500<br>
> summary:     made output process-model identifier lines to be of uniform length (80 characters). Yeah it is a little OCD of me.<br>
><br>
</span>>>./pflotran -pflotranin <a href="http://da.in" target="_blank">da.in</a><<a href="http://da.in" target="_blank">http://da.in</a>><br>
<span>><br>
> == TH FLOW =====================================================================<br>
>   1 2f: 2.55E+00 2x: 1.63E+07 2s: 1.72E+07 ir: 1.49E+00 iu: 3.10E+06 rsn:   0<br>
>   2 2f: 1.88E-01 2x: 1.57E+14 2s: 1.57E+14 ir: 5.33E-02 iu: 4.37E+13 rsn:   0<br>
>   3 2f: 1.07E-01 2x: 1.60E+14 2s: 4.28E+12 ir: 2.27E-02 iu: 9.90E+11 rsn:   0<br>
>   4 2f: 1.24E+01 2x: 1.60E+14 2s: 9.53E+11 ir: 1.16E+01 iu: 7.15E+11 rsn:   0<br>
>   5 2f: 1.29E+06 2x: 7.75E+20 2s: 7.75E+20 ir: 1.15E+06 iu: 7.21E+20 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut=  1[  0] t=  0.00000E+00 dt=  5.00000E-01<br>
>   1 2f: 2.22E+00 2x: 1.38E+07 2s: 1.47E+07 ir: 1.47E+00 iu: 3.06E+06 rsn:   0<br>
>   2 2f: 2.94E-01 2x: 1.11E+14 2s: 1.11E+14 ir: 1.44E-01 iu: 4.05E+13 rsn:   0<br>
>   3 2f: 6.05E+20 2x: 2.13E+14 2s: 1.79E+14 ir: 4.44E+20 iu: 8.93E+13 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut=  2[  0] t=  0.00000E+00 dt=  2.50000E-01<br>
>   1 2f: 2.17E+00 2x: 1.12E+07 2s: 1.21E+07 ir: 1.44E+00 iu: 3.01E+06 rsn:   0<br>
>   2 2f: 5.55E-01 2x: 8.08E+13 2s: 8.08E+13 ir: 4.07E-01 iu: 3.66E+13 rsn:   0<br>
> [0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------<br>
> [0]PETSC ERROR: Floating point exception<br>
> [0]PETSC ERROR: Vec entry at local location 50 is not-a-number or infinite at end of function: Parameter number 3<br>
> [0]PETSC ERROR: See <a href="http://www.mcs.anl.gov/petsc/documentation/faq.html" target="_blank">http://www.mcs.anl.gov/petsc/documentation/faq.html</a> for trouble shooting.<br>
> [0]PETSC ERROR: Petsc Release Version 3.5.1, unknown<br>
</span>> [0]PETSC ERROR: ../../../src/pflotran/pflotran on a darwin-gnu-fort-debug named <a href="http://gautams-mac-pro.dhcp.lbl.gov" target="_blank">gautams-mac-pro.dhcp.lbl.gov</a><<a href="http://gautams-mac-pro.dhcp.lbl.gov" target="_blank">http://gautams-mac-pro.dhcp.lbl.gov</a>> by gbisht Wed Dec  3 08:16:17 2014<br>
<span>> [0]PETSC ERROR: Configure options --download-hdf5=1 --with-blas-lapack-lib=/System/Library/Frameworks/Accelerate.framework/Versions/Current/Accelerate --download-parmetis=yes --download-metis=yes --with-cc=/opt/local/bin/mpicc-openmpi-mp --with-cxx=/opt/local/bin/mpicxx-openmpi-mp --with-fc=/opt/local/bin/mpif90-openmpi-mp --with-mpiexec=/opt/local/bin/mpiexec-openmpi-mp PETSC_ARCH=darwin-gnu-fort-debug --download-sowing=1<br>
> [0]PETSC ERROR: #1 VecValidValues() line 34 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/vec/vec/interface/rvector.c<br>
> [0]PETSC ERROR: #2 SNESComputeFunction() line 2043 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/interface/snes.c<br>
> [0]PETSC ERROR: #3 SNESLineSearchApply_Basic() line 40 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/linesearch/impls/basic/linesearchbasic.c<br>
> [0]PETSC ERROR: #4 SNESLineSearchApply() line 563 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/linesearch/interface/linesearch.c<br>
> [0]PETSC ERROR: #5 SNESSolve_NEWTONLS() line 254 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/impls/ls/ls.c<br>
> [0]PETSC ERROR: #6 SNESSolve() line 3743 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/interface/snes.c<br>
> --------------------------------------------------------------------------<br>
> MPI_ABORT was invoked on rank 0 in communicator MPI_COMM_WORLD<br>
> with errorcode 72.<br>
><br>
> NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes.<br>
> You may or may not see output from other processes, depending on<br>
> exactly when Open MPI kills them.<br>
> --------------------------------------------------------------------------<br>
><br>
><br>
>> hg diff<br>
> diff -r fa2d4295aa14 src/pflotran/timestepper_BE.F90<br>
> --- a/src/pflotran/timestepper_BE.F90           Wed Dec 03 08:52:00 2014 -0500<br>
> +++ b/src/pflotran/timestepper_BE.F90       Wed Dec 03 08:22:35 2014 -0800<br>
> @@ -310,7 +310,7 @@<br>
>      call PetscTime(log_start_time, ierr);CHKERRQ(ierr)<br>
><br>
>      call SNESSolve(solver%snes,PETSC_NULL_OBJECT, &<br>
> -                   process_model%solution_vec,ierr);CHKERRQ(ierr)<br>
> +                   process_model%solution_vec,ierr);!CHKERRQ(ierr)<br>
><br>
>      call PetscTime(log_end_time, ierr);CHKERRQ(ierr)<br>
><br>
><br>
</span>>>./pflotran -pflotranin <a href="http://da.in" target="_blank">da.in</a><<a href="http://da.in" target="_blank">http://da.in</a>><br>
<span>><br>
> == TH FLOW =====================================================================<br>
>   1 2f: 2.55E+00 2x: 1.63E+07 2s: 1.72E+07 ir: 1.49E+00 iu: 3.10E+06 rsn:   0<br>
>   2 2f: 1.88E-01 2x: 1.57E+14 2s: 1.57E+14 ir: 5.33E-02 iu: 4.37E+13 rsn:   0<br>
>   3 2f: 1.07E-01 2x: 1.60E+14 2s: 4.28E+12 ir: 2.27E-02 iu: 9.90E+11 rsn:   0<br>
>   4 2f: 1.24E+01 2x: 1.60E+14 2s: 9.53E+11 ir: 1.16E+01 iu: 7.15E+11 rsn:   0<br>
>   5 2f: 1.29E+06 2x: 7.75E+20 2s: 7.75E+20 ir: 1.15E+06 iu: 7.21E+20 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut=  1[  0] t=  0.00000E+00 dt=  5.00000E-01<br>
>   1 2f: 2.22E+00 2x: 1.38E+07 2s: 1.47E+07 ir: 1.47E+00 iu: 3.06E+06 rsn:   0<br>
>   2 2f: 2.94E-01 2x: 1.11E+14 2s: 1.11E+14 ir: 1.44E-01 iu: 4.05E+13 rsn:   0<br>
>   3 2f: 6.05E+20 2x: 2.13E+14 2s: 1.79E+14 ir: 4.44E+20 iu: 8.93E+13 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut=  2[  0] t=  0.00000E+00 dt=  2.50000E-01<br>
>   1 2f: 2.17E+00 2x: 1.12E+07 2s: 1.21E+07 ir: 1.44E+00 iu: 3.01E+06 rsn:   0<br>
>   2 2f: 5.55E-01 2x: 8.08E+13 2s: 8.08E+13 ir: 4.07E-01 iu: 3.66E+13 rsn:   0<br>
> [0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------<br>
> [0]PETSC ERROR: Floating point exception<br>
> [0]PETSC ERROR: Vec entry at local location 50 is not-a-number or infinite at end of function: Parameter number 3<br>
> [0]PETSC ERROR: See <a href="http://www.mcs.anl.gov/petsc/documentation/faq.html" target="_blank">http://www.mcs.anl.gov/petsc/documentation/faq.html</a> for trouble shooting.<br>
> [0]PETSC ERROR: Petsc Release Version 3.5.1, unknown<br>
</span>> [0]PETSC ERROR: ../../../src/pflotran/pflotran on a darwin-gnu-fort-debug named <a href="http://gautams-mac-pro.dhcp.lbl.gov" target="_blank">gautams-mac-pro.dhcp.lbl.gov</a><<a href="http://gautams-mac-pro.dhcp.lbl.gov" target="_blank">http://gautams-mac-pro.dhcp.lbl.gov</a>> by gbisht Wed Dec  3 08:17:35 2014<br>
<span>> [0]PETSC ERROR: Configure options --download-hdf5=1 --with-blas-lapack-lib=/System/Library/Frameworks/Accelerate.framework/Versions/Current/Accelerate --download-parmetis=yes --download-metis=yes --with-cc=/opt/local/bin/mpicc-openmpi-mp --with-cxx=/opt/local/bin/mpicxx-openmpi-mp --with-fc=/opt/local/bin/mpif90-openmpi-mp --with-mpiexec=/opt/local/bin/mpiexec-openmpi-mp PETSC_ARCH=darwin-gnu-fort-debug --download-sowing=1<br>
> [0]PETSC ERROR: #1 VecValidValues() line 34 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/vec/vec/interface/rvector.c<br>
> [0]PETSC ERROR: #2 SNESComputeFunction() line 2043 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/interface/snes.c<br>
> [0]PETSC ERROR: #3 SNESLineSearchApply_Basic() line 40 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/linesearch/impls/basic/linesearchbasic.c<br>
> [0]PETSC ERROR: #4 SNESLineSearchApply() line 563 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/linesearch/interface/linesearch.c<br>
> [0]PETSC ERROR: #5 SNESSolve_NEWTONLS() line 254 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/impls/ls/ls.c<br>
> [0]PETSC ERROR: #6 SNESSolve() line 3743 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/interface/snes.c<br>
>  -> Cut time step: snes=  0 icut=  3[  0] t=  0.00000E+00 dt=  1.25000E-01<br>
>   1 2f: 2.12E+00 2x: 9.08E+06 2s: 9.85E+06 ir: 1.41E+00 iu: 2.94E+06 rsn:   0<br>
>   2 2f: 7.89E-01 2x: 5.95E+13 2s: 5.95E+13 ir: 6.28E-01 iu: 3.20E+13 rsn:   0<br>
> [0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------<br>
> [0]PETSC ERROR: Floating point exception<br>
> [0]PETSC ERROR: Vec entry at local location 34 is not-a-number or infinite at end of function: Parameter number 3<br>
> [0]PETSC ERROR: See <a href="http://www.mcs.anl.gov/petsc/documentation/faq.html" target="_blank">http://www.mcs.anl.gov/petsc/documentation/faq.html</a> for trouble shooting.<br>
> [0]PETSC ERROR: Petsc Release Version 3.5.1, unknown<br>
</span>> [0]PETSC ERROR: ../../../src/pflotran/pflotran on a darwin-gnu-fort-debug named <a href="http://gautams-mac-pro.dhcp.lbl.gov" target="_blank">gautams-mac-pro.dhcp.lbl.gov</a><<a href="http://gautams-mac-pro.dhcp.lbl.gov" target="_blank">http://gautams-mac-pro.dhcp.lbl.gov</a>> by gbisht Wed Dec  3 08:17:35 2014<br>
<span>> [0]PETSC ERROR: Configure options --download-hdf5=1 --with-blas-lapack-lib=/System/Library/Frameworks/Accelerate.framework/Versions/Current/Accelerate --download-parmetis=yes --download-metis=yes --with-cc=/opt/local/bin/mpicc-openmpi-mp --with-cxx=/opt/local/bin/mpicxx-openmpi-mp --with-fc=/opt/local/bin/mpif90-openmpi-mp --with-mpiexec=/opt/local/bin/mpiexec-openmpi-mp PETSC_ARCH=darwin-gnu-fort-debug --download-sowing=1<br>
> [0]PETSC ERROR: #7 VecValidValues() line 34 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/vec/vec/interface/rvector.c<br>
> [0]PETSC ERROR: #8 SNESComputeFunction() line 2043 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/interface/snes.c<br>
> [0]PETSC ERROR: #9 SNESLineSearchApply_Basic() line 40 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/linesearch/impls/basic/linesearchbasic.c<br>
> [0]PETSC ERROR: #10 SNESLineSearchApply() line 563 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/linesearch/interface/linesearch.c<br>
> [0]PETSC ERROR: #11 SNESSolve_NEWTONLS() line 254 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/impls/ls/ls.c<br>
> [0]PETSC ERROR: #12 SNESSolve() line 3743 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/interface/snes.c<br>
>  -> Cut time step: snes=  0 icut=  4[  0] t=  0.00000E+00 dt=  6.25000E-02<br>
>   1 2f: 2.04E+00 2x: 7.38E+06 2s: 8.06E+06 ir: 1.36E+00 iu: 2.86E+06 rsn:   0<br>
>   2 2f: 5.60E+04 2x: 4.28E+13 2s: 4.28E+13 ir: 4.47E+04 iu: 2.66E+13 rsn:   0<br>
>   3 2f: 1.16E+18 2x: 4.91E+13 2s: 2.30E+13 ir: 9.47E+17 iu: 1.69E+13 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut=  5[  0] t=  0.00000E+00 dt=  3.12500E-02<br>
>   1 2f: 1.94E+00 2x: 6.00E+06 2s: 6.57E+06 ir: 1.30E+00 iu: 2.74E+06 rsn:   0<br>
>   2 2f: 6.76E+04 2x: 2.91E+13 2s: 2.91E+13 ir: 5.18E+04 iu: 2.06E+13 rsn:   0<br>
> [0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------<br>
> [0]PETSC ERROR: Floating point exception<br>
> [0]PETSC ERROR: Vec entry at local location 14 is not-a-number or infinite at end of function: Parameter number 3<br>
> [0]PETSC ERROR: See <a href="http://www.mcs.anl.gov/petsc/documentation/faq.html" target="_blank">http://www.mcs.anl.gov/petsc/documentation/faq.html</a> for trouble shooting.<br>
> [0]PETSC ERROR: Petsc Release Version 3.5.1, unknown<br>
</span>> [0]PETSC ERROR: ../../../src/pflotran/pflotran on a darwin-gnu-fort-debug named <a href="http://gautams-mac-pro.dhcp.lbl.gov" target="_blank">gautams-mac-pro.dhcp.lbl.gov</a><<a href="http://gautams-mac-pro.dhcp.lbl.gov" target="_blank">http://gautams-mac-pro.dhcp.lbl.gov</a>> by gbisht Wed Dec  3 08:17:35 2014<br>
<span>> [0]PETSC ERROR: Configure options --download-hdf5=1 --with-blas-lapack-lib=/System/Library/Frameworks/Accelerate.framework/Versions/Current/Accelerate --download-parmetis=yes --download-metis=yes --with-cc=/opt/local/bin/mpicc-openmpi-mp --with-cxx=/opt/local/bin/mpicxx-openmpi-mp --with-fc=/opt/local/bin/mpif90-openmpi-mp --with-mpiexec=/opt/local/bin/mpiexec-openmpi-mp PETSC_ARCH=darwin-gnu-fort-debug --download-sowing=1<br>
> [0]PETSC ERROR: #13 VecValidValues() line 34 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/vec/vec/interface/rvector.c<br>
> [0]PETSC ERROR: #14 SNESComputeFunction() line 2043 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/interface/snes.c<br>
> [0]PETSC ERROR: #15 SNESLineSearchApply_Basic() line 40 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/linesearch/impls/basic/linesearchbasic.c<br>
> [0]PETSC ERROR: #16 SNESLineSearchApply() line 563 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/linesearch/interface/linesearch.c<br>
> [0]PETSC ERROR: #17 SNESSolve_NEWTONLS() line 254 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/impls/ls/ls.c<br>
> [0]PETSC ERROR: #18 SNESSolve() line 3743 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/interface/snes.c<br>
>  -> Cut time step: snes=  0 icut=  6[  0] t=  0.00000E+00 dt=  1.56250E-02<br>
>   1 2f: 1.81E+00 2x: 4.84E+06 2s: 5.31E+06 ir: 1.21E+00 iu: 2.58E+06 rsn:   0<br>
>   2 2f: 1.56E+04 2x: 1.81E+13 2s: 1.81E+13 ir: 1.22E+04 iu: 1.43E+13 rsn:   0<br>
>   3 2f: 9.46E+15 2x: 1.99E+13 2s: 7.41E+12 ir: 7.34E+15 iu: 5.84E+12 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut=  7[  0] t=  0.00000E+00 dt=  7.81250E-03<br>
>   1 2f: 1.64E+00 2x: 3.85E+06 2s: 4.21E+06 ir: 1.11E+00 iu: 2.37E+06 rsn:   0<br>
>   2 2f: 1.37E+04 2x: 9.82E+12 2s: 9.82E+12 ir: 1.02E+04 iu: 8.52E+12 rsn:   0<br>
>   3 2f: 5.35E+14 2x: 1.86E+13 2s: 1.65E+13 ir: 3.78E+14 iu: 1.62E+13 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut=  8[  0] t=  0.00000E+00 dt=  3.90625E-03<br>
>   1 2f: 1.42E+00 2x: 3.01E+06 2s: 3.25E+06 ir: 9.67E-01 iu: 2.09E+06 rsn:   0<br>
>   2 2f: 6.03E+03 2x: 4.39E+12 2s: 4.39E+12 ir: 4.38E+03 iu: 4.08E+12 rsn:   0<br>
> [0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------<br>
> [0]PETSC ERROR: Floating point exception<br>
> [0]PETSC ERROR: Vec entry at local location 30 is not-a-number or infinite at end of function: Parameter number 3<br>
> [0]PETSC ERROR: See <a href="http://www.mcs.anl.gov/petsc/documentation/faq.html" target="_blank">http://www.mcs.anl.gov/petsc/documentation/faq.html</a> for trouble shooting.<br>
> [0]PETSC ERROR: Petsc Release Version 3.5.1, unknown<br>
</span>> [0]PETSC ERROR: ../../../src/pflotran/pflotran on a darwin-gnu-fort-debug named <a href="http://gautams-mac-pro.dhcp.lbl.gov" target="_blank">gautams-mac-pro.dhcp.lbl.gov</a><<a href="http://gautams-mac-pro.dhcp.lbl.gov" target="_blank">http://gautams-mac-pro.dhcp.lbl.gov</a>> by gbisht Wed Dec  3 08:17:35 2014<br>
<span>> [0]PETSC ERROR: Configure options --download-hdf5=1 --with-blas-lapack-lib=/System/Library/Frameworks/Accelerate.framework/Versions/Current/Accelerate --download-parmetis=yes --download-metis=yes --with-cc=/opt/local/bin/mpicc-openmpi-mp --with-cxx=/opt/local/bin/mpicxx-openmpi-mp --with-fc=/opt/local/bin/mpif90-openmpi-mp --with-mpiexec=/opt/local/bin/mpiexec-openmpi-mp PETSC_ARCH=darwin-gnu-fort-debug --download-sowing=1<br>
> [0]PETSC ERROR: #19 VecValidValues() line 34 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/vec/vec/interface/rvector.c<br>
> [0]PETSC ERROR: #20 SNESComputeFunction() line 2043 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/interface/snes.c<br>
> [0]PETSC ERROR: #21 SNESLineSearchApply_Basic() line 40 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/linesearch/impls/basic/linesearchbasic.c<br>
> [0]PETSC ERROR: #22 SNESLineSearchApply() line 563 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/linesearch/interface/linesearch.c<br>
> [0]PETSC ERROR: #23 SNESSolve_NEWTONLS() line 254 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/impls/ls/ls.c<br>
> [0]PETSC ERROR: #24 SNESSolve() line 3743 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/interface/snes.c<br>
>  -> Cut time step: snes=  0 icut=  9[  0] t=  0.00000E+00 dt=  1.95312E-03<br>
>   1 2f: 1.16E+00 2x: 2.30E+06 2s: 2.42E+06 ir: 8.00E-01 iu: 1.76E+06 rsn:   0<br>
>   2 2f: 4.32E+03 2x: 1.47E+12 2s: 1.47E+12 ir: 3.07E+03 iu: 1.42E+12 rsn:   0<br>
> [0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------<br>
> [0]PETSC ERROR: Floating point exception<br>
> [0]PETSC ERROR: Vec entry at local location 4 is not-a-number or infinite at end of function: Parameter number 3<br>
> [0]PETSC ERROR: See <a href="http://www.mcs.anl.gov/petsc/documentation/faq.html" target="_blank">http://www.mcs.anl.gov/petsc/documentation/faq.html</a> for trouble shooting.<br>
> [0]PETSC ERROR: Petsc Release Version 3.5.1, unknown<br>
</span>> [0]PETSC ERROR: ../../../src/pflotran/pflotran on a darwin-gnu-fort-debug named <a href="http://gautams-mac-pro.dhcp.lbl.gov" target="_blank">gautams-mac-pro.dhcp.lbl.gov</a><<a href="http://gautams-mac-pro.dhcp.lbl.gov" target="_blank">http://gautams-mac-pro.dhcp.lbl.gov</a>> by gbisht Wed Dec  3 08:17:35 2014<br>
<div><div>> [0]PETSC ERROR: Configure options --download-hdf5=1 --with-blas-lapack-lib=/System/Library/Frameworks/Accelerate.framework/Versions/Current/Accelerate --download-parmetis=yes --download-metis=yes --with-cc=/opt/local/bin/mpicc-openmpi-mp --with-cxx=/opt/local/bin/mpicxx-openmpi-mp --with-fc=/opt/local/bin/mpif90-openmpi-mp --with-mpiexec=/opt/local/bin/mpiexec-openmpi-mp PETSC_ARCH=darwin-gnu-fort-debug --download-sowing=1<br>
> [0]PETSC ERROR: #25 VecValidValues() line 34 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/vec/vec/interface/rvector.c<br>
> [0]PETSC ERROR: #26 SNESComputeFunction() line 2043 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/interface/snes.c<br>
> [0]PETSC ERROR: #27 SNESLineSearchApply_Basic() line 40 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/linesearch/impls/basic/linesearchbasic.c<br>
> [0]PETSC ERROR: #28 SNESLineSearchApply() line 563 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/linesearch/interface/linesearch.c<br>
> [0]PETSC ERROR: #29 SNESSolve_NEWTONLS() line 254 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/impls/ls/ls.c<br>
> [0]PETSC ERROR: #30 SNESSolve() line 3743 in /Users/gbisht/Research/Models/PETSc/petsc_821a792/src/snes/interface/snes.c<br>
>  -> Cut time step: snes=  0 icut= 10[  0] t=  0.00000E+00 dt=  9.76562E-04<br>
>   1 2f: 8.79E-01 2x: 1.73E+06 2s: 1.70E+06 ir: 6.11E-01 iu: 1.37E+06 rsn:   0<br>
>   2 2f: 1.34E+03 2x: 3.17E+11 2s: 3.17E+11 ir: 9.30E+02 iu: 3.14E+11 rsn:   0<br>
>   3 2f: 3.99E+13 2x: 6.13E+11 2s: 3.04E+11 ir: 3.26E+13 iu: 2.98E+11 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut= 11[  0] t=  0.00000E+00 dt=  4.88281E-04<br>
>   1 2f: 5.96E-01 2x: 1.33E+06 2s: 1.10E+06 ir: 4.19E-01 iu: 9.69E+05 rsn:   0<br>
>   2 2f: 4.60E+04 2x: 3.54E+10 2s: 3.54E+10 ir: 3.25E+04 iu: 3.54E+10 rsn:   0<br>
>   3 2f: 9.64E+15 2x: 3.91E+11 2s: 3.55E+11 ir: 7.87E+15 iu: 3.55E+11 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut= 12[  0] t=  0.00000E+00 dt=  2.44141E-04<br>
>   1 2f: 3.54E-01 2x: 1.11E+06 2s: 6.36E+05 ir: 2.50E-01 iu: 5.95E+05 rsn:   0<br>
>   2 2f: 5.42E+04 2x: 1.33E+09 2s: 1.33E+09 ir: 3.93E+04 iu: 1.33E+09 rsn:   0<br>
>   3 2f: 3.51E+06 2x: 1.75E+10 2s: 1.75E+10 ir: 2.87E+06 iu: 1.75E+10 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut= 13[  0] t=  0.00000E+00 dt=  1.22070E-04<br>
>   1 2f: 5.74E-02 2x: 1.04E+06 2s: 3.17E+05 ir: 4.02E-02 iu: 3.07E+05 rsn:   0<br>
>   2 2f: 3.60E-02 2x: 6.66E+09 2s: 6.66E+09 ir: 2.88E-02 iu: 6.66E+09 rsn:   0<br>
>   3 2f: 5.16E+02 2x: 2.91E+08 2s: 6.95E+09 ir: 3.31E+02 iu: 6.95E+09 rsn:   0<br>
>   4 2f: 7.20E+04 2x: 7.65E+15 2s: 7.65E+15 ir: 6.73E+04 iu: 7.65E+15 rsn:   0<br>
>   5 2f: 4.01E+12 2x: 3.15E+16 2s: 3.92E+16 ir: 3.27E+12 iu: 3.92E+16 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut= 14[  0] t=  0.00000E+00 dt=  6.10352E-05<br>
>   1 2f: 8.13E-02 2x: 1.04E+06 2s: 1.33E+05 ir: 8.02E-02 iu: 1.31E+05 rsn:   0<br>
>   2 2f: 1.94E+02 2x: 1.14E+08 2s: 1.14E+08 ir: 1.33E+02 iu: 1.14E+08 rsn:   0<br>
>   3 2f: 2.16E-01 2x: 4.22E+08 2s: 5.36E+08 ir: 1.79E-01 iu: 5.36E+08 rsn:   0<br>
>   4 2f: 3.21E+28 2x: 1.07E+19 2s: 1.07E+19 ir: 2.62E+28 iu: 1.07E+19 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut= 15[  0] t=  0.00000E+00 dt=  3.05176E-05<br>
>   1 2f: 1.13E-05 2x: 1.05E+06 2s: 4.69E+04 ir: 1.13E-05 iu: 4.67E+04 rsn:   0<br>
>   2 2f: 1.21E-10 2x: 1.05E+06 2s: 6.87E+02 ir: 1.05E-10 iu: 6.87E+02 rsn: itol_res<br>
><br>
>  Step      1 Time=  3.05176E-05 Dt=  3.05176E-05 [y] snes_conv_reason:   10<br>
>   newton =  47 [      47] linear =    52 [        52] cuts = 15 [  15]<br>
>   --> SNES Linear/Non-Linear Iterations =            2  /            2<br>
>   --> SNES Residual:   1.209152E-10  1.209152E-12  1.045172E-10<br>
>   --> max chng: dpmx=   4.5981E+04 dtmpmx=   1.6500E+00<br>
><br>
><br>
> == TH FLOW =====================================================================<br>
>   1 2f: 1.62E-01 2x: 1.04E+06 2s: 7.34E+04 ir: 1.60E-01 iu: 7.27E+04 rsn:   0<br>
>   2 2f: 7.18E+01 2x: 6.44E+07 2s: 6.44E+07 ir: 4.68E+01 iu: 6.44E+07 rsn:   0<br>
>   3 2f: 2.52E-01 2x: 5.48E+07 2s: 1.19E+08 ir: 2.02E-01 iu: 1.19E+08 rsn:   0<br>
>   4 2f: 1.29E+09 2x: 1.44E+18 2s: 1.44E+18 ir: 1.29E+09 iu: 1.44E+18 rsn: max_norm<br>
>  -> Cut time step: snes=-10 icut=  1[ 15] t=  3.05176E-05 dt=  1.52588E-05<br>
>   1 2f: 3.23E-01 2x: 1.04E+06 2s: 3.15E+04 ir: 3.19E-01 iu: 3.13E+04 rsn:   0<br>
>   2 2f: 1.17E-03 2x: 3.08E+06 2s: 2.83E+06 ir: 1.09E-03 iu: 2.83E+06 rsn:   0<br>
>   3 2f: 3.23E-01 2x: 1.04E+06 2s: 2.83E+06 ir: 3.19E-01 iu: 2.83E+06 rsn:   0<br>
>   4 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>   5 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>   6 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>   7 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>   8 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>   9 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  10 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  11 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  12 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  13 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  14 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  15 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  16 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  17 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  18 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  19 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  20 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  21 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  22 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  23 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  24 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  25 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  26 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  27 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  28 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  29 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  30 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  31 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  32 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  33 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  34 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  35 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  36 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  37 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  38 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  39 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  40 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  41 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  42 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  43 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  44 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  45 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  46 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  47 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  48 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  49 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  50 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  51 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  52 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  53 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  54 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  55 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  56 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  57 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  58 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  59 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  60 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  61 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  62 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  63 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  64 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  65 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  66 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  67 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  68 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  69 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  70 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  71 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  72 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  73 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  74 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  75 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  76 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  77 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  78 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  79 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  80 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  81 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  82 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  83 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  84 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  85 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  86 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  87 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  88 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  89 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  90 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  91 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  92 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  93 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  94 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  95 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  96 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  97 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
>  98 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  99 2f: 3.23E-01 2x: 1.04E+06 2s: 2.89E+06 ir: 3.19E-01 iu: 2.89E+06 rsn:   0<br>
> 100 2f: 1.18E-03 2x: 3.14E+06 2s: 2.89E+06 ir: 1.10E-03 iu: 2.89E+06 rsn:   0<br>
>  -> Cut time step: snes= -5 icut=  2[ 15] t=  3.05176E-05 dt=  7.62939E-06<br>
>   1 2f: 6.23E-01 2x: 1.04E+06 2s: 1.39E+04 ir: 6.15E-01 iu: 1.38E+04 rsn:   0<br>
>   2 2f: 6.18E-04 2x: 1.06E+06 2s: 1.15E+05 ir: 5.25E-04 iu: 1.15E+05 rsn:   0<br>
>   3 2f: 6.23E-01 2x: 1.04E+06 2s: 1.15E+05 ir: 6.15E-01 iu: 1.15E+05 rsn:   0<br>
>   4 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>   5 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>   6 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>   7 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>   8 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>   9 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  10 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  11 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  12 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  13 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  14 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  15 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  16 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  17 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  18 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  19 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  20 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  21 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  22 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  23 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  24 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  25 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  26 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  27 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  28 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  29 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  30 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  31 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  32 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  33 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  34 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  35 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  36 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  37 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  38 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  39 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  40 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  41 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  42 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  43 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  44 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  45 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  46 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  47 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  48 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  49 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  50 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  51 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  52 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  53 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  54 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  55 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  56 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  57 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  58 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  59 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  60 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  61 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  62 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  63 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  64 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  65 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  66 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  67 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  68 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  69 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  70 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  71 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  72 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  73 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  74 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  75 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  76 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  77 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  78 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  79 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  80 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  81 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  82 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  83 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  84 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  85 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  86 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  87 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  88 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  89 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  90 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  91 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  92 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  93 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  94 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  95 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  96 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  97 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
>  98 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  99 2f: 6.23E-01 2x: 1.04E+06 2s: 1.16E+05 ir: 6.15E-01 iu: 1.16E+05 rsn:   0<br>
> 100 2f: 6.18E-04 2x: 1.06E+06 2s: 1.16E+05 ir: 5.25E-04 iu: 1.16E+05 rsn:   0<br>
>  -> Cut time step: snes= -5 icut=  3[ 15] t=  3.05176E-05 dt=  3.81470E-06<br>
>   1 2f: 8.15E-01 2x: 1.05E+06 2s: 6.36E+03 ir: 8.05E-01 iu: 6.33E+03 rsn:   0<br>
>   2 2f: 1.34E-03 2x: 1.05E+06 2s: 4.20E+03 ir: 1.31E-03 iu: 4.19E+03 rsn:   0<br>
>   3 2f: 4.65E-04 2x: 1.05E+06 2s: 2.99E+02 ir: 4.59E-04 iu: 2.50E+02 rsn:   0<br>
>   4 2f: 1.43E-04 2x: 1.05E+06 2s: 1.18E+02 ir: 1.41E-04 iu: 1.18E+02 rsn:   0<br>
>   5 2f: 4.35E-05 2x: 1.05E+06 2s: 8.37E+01 ir: 4.30E-05 iu: 8.37E+01 rsn:   0<br>
>   6 2f: 1.27E-05 2x: 1.05E+06 2s: 5.80E+01 ir: 1.25E-05 iu: 5.80E+01 rsn:   0<br>
>   7 2f: 3.26E-06 2x: 1.05E+06 2s: 3.69E+01 ir: 3.22E-06 iu: 3.69E+01 rsn:   0<br>
>   8 2f: 5.57E-07 2x: 1.05E+06 2s: 1.83E+01 ir: 5.50E-07 iu: 1.83E+01 rsn:   0<br>
>   9 2f: 2.98E-08 2x: 1.05E+06 2s: 4.65E+00 ir: 2.95E-08 iu: 4.65E+00 rsn:   0<br>
>  10 2f: 9.92E-11 2x: 1.05E+06 2s: 2.79E-01 ir: 9.78E-11 iu: 2.79E-01 rsn: itol_res<br>
><br>
>  Step      2 Time=  3.43323E-05 Dt=  3.81470E-06 [y] snes_conv_reason:   10<br>
>   newton = 214 [     261] linear =   214 [       266] cuts =  3 [  18]<br>
>   --> SNES Linear/Non-Linear Iterations =           10  /           10<br>
>   --> SNES Residual:   9.921423E-11  9.921423E-13  9.778422E-11<br>
>   --> max chng: dpmx=   1.6597E+03 dtmpmx=   1.9780E-01<br>
><br>
><br>
> --<br>
> You received this message because you are subscribed to the Google Groups "pflotran-dev" group.<br>
</div></div>> To view this discussion on the web visit <a href="https://groups.google.com/d/msgid/pflotran-dev/CAPz1TnfKQJov5Uxvghp_31uKpxz0SdJ1XLV%3Dy2pt5gOrkY_CHg%40mail.gmail.com" target="_blank">https://groups.google.com/d/msgid/pflotran-dev/CAPz1TnfKQJov5Uxvghp_31uKpxz0SdJ1XLV%3Dy2pt5gOrkY_CHg%40mail.gmail.com</a><<a href="https://groups.google.com/d/msgid/pflotran-dev/CAPz1TnfKQJov5Uxvghp_31uKpxz0SdJ1XLV%3Dy2pt5gOrkY_CHg%40mail.gmail.com?utm_medium=email&utm_source=footer" target="_blank">https://groups.google.com/d/msgid/pflotran-dev/CAPz1TnfKQJov5Uxvghp_31uKpxz0SdJ1XLV%3Dy2pt5gOrkY_CHg%40mail.gmail.com?utm_medium=email&utm_source=footer</a>>.<br>
<span>><br>
> --<br>
> You received this message because you are subscribed to the Google Groups "pflotran-dev" group.<br>
> To view this discussion on the web visit <a href="https://groups.google.com/d/msgid/pflotran-dev/92b8b510fceb47309cc0b8f7ada47ef4%40ES06AMSNLNT.srn.sandia.gov" target="_blank">https://groups.google.com/d/msgid/pflotran-dev/92b8b510fceb47309cc0b8f7ada47ef4%40ES06AMSNLNT.srn.sandia.gov</a>.<br>
<br>
</span><span>--<br>
You received this message because you are subscribed to the Google Groups "pflotran-dev" group.<br>
</span>To view this discussion on the web visit <a href="https://groups.google.com/d/msgid/pflotran-dev/87mw748t8f.fsf%40jedbrown.org" target="_blank">https://groups.google.com/d/msgid/pflotran-dev/87mw748t8f.fsf%40jedbrown.org</a>.<br>
</blockquote></div><br></div></div></div></div></div>
</blockquote></div><br></div>