[petsc-dev] ts/examples/tutorials/ex11 test garbage?
Richard Katz
richard.katz at earth.ox.ac.uk
Wed Aug 17 11:05:54 CDT 2011
Hi Jed
Thanks for your help with this.
At the moment, it seems that
-ts_type alpha -ts_alpha_adapt -ts_exact_final_time 0
is not working. Maybe you forgot to push an essential change? Anyway, output below.
Rich
[magmox:src]$ porbandsim -ts_type alpha -ts_alpha_adapt
--------------porbandsim: Wed Aug 17 17:01:29 2011---------------
Processes: 1, DOFs/Process: 1400
#PETSc Option Table entries:
-ts_alpha_adapt
-ts_type alpha
#End of PETSc Option Table entries
-----------------------------------------------------------------
PetscBag Object: ParameterBag params for porosity band simulation
height = 1; Domain height in compaction lengths
phi0 = 0.1; Initial porosity, dim'less
phi1 = 0.001; Amplitude of porosity perturbation, dim'less
lambda = 27; Porosity-weakening exponent in shear viscosity
kexp = 3; Exponent in porosity--permeability relationship
n = 1; Exponent in stress--strain rate relationship
test = FALSE; Just load parameters and then exit
output_file = null; Name base for output files
output_all = FALSE; Make output after each time-step (T/F)
ni = 20; Grid points in x-direction, incl buffer points
nj = 14; Grid points in y-direction, incl buffer points
nb = 2; Number of buffer rows at top and bottom of domain
ns = 1000000; Maximum number of time-steps
nplot = 0; Output counter
advect = 2; Advection scheme: 0=FV, 1=Fromm, 2=TVD
time = 0; Time at current step, dim'less
cfl = 0.5; Courant-Friedrichs-Lewy number, dim'less
tmax = 4; Maximimum simulated time, dim'less
tout = 0.11; Output interval, dim'less
-------------------------END PARAM REPORT------------------------
Continuation in lambda for initial condition
Solved with lambda = 1.0
Solved with lambda = 2.0
Solved with lambda = 4.0
Solved with lambda = 8.0
Solved with lambda = 16.0
Solved with lambda = 27.0
-----------------------------------------------------------------
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: !
[0]PETSC ERROR: TSStep has failed!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Development HG revision: 3355da69360b77c0d25d19b1fadc404887744412 HG Date: Mon Aug 15 03:38:03 2011 -0500
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: porbandsim on a optimize_ named magmox.earth.ox.ac.uk by katz Wed Aug 17 17:01:29 2011
[0]PETSC ERROR: Libraries linked from /Applications/Utilities/PETSc/petsc-dev/optimize_openmpi/lib
[0]PETSC ERROR: Configure run at Tue Aug 16 11:12:07 2011
[0]PETSC ERROR: Configure options --with-cxx=0 --with-fortran=0 --with-mpi-dir=/usr --with-debugging=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: TSSolve() line 1851 in /Applications/Utilities/PETSc/petsc-dev/src/ts/interface/ts.c
[0]PETSC ERROR: DoSolve() line 56 in porbandsim.c
[0]PETSC ERROR: main() line 30 in porbandsim.c
[magmox.earth.ox.ac.uk:45755] MPI_ABORT invoked on rank 0 in communicator MPI_COMM_WORLD with errorcode 91
[magmox:src]$ cd $PETSC_DIR
/Applications/Utilities/PETSc/petsc-dev
[magmox:petsc-dev]$ hg tip
changeset: 19935:edece12f8f80
tag: tip
parent: 19934:8b8b9f964535
parent: 19932:fdf88f5fb6ab
user: Peter Brune <brune at cs.uchicago.edu>
date: Wed Aug 17 10:32:27 2011 -0500
summary: merge
On 17 Aug 2011, at 15:47, Jed Brown wrote:
> On Wed, Aug 17, 2011 at 07:36, Jed Brown <jedbrown at mcs.anl.gov> wrote:
> TSInterpolate_Alpha is missing, will fix)
>
> For now, you can run your example with
>
> ./porbandsim -ts_type alpha -ts_alpha_adapt -ts_exact_final_time 0
>
> though this will fail after a few steps due to rejections or something. I'm teaching a tutorial today, so I might be a bit useless on the email front.
________________________________
Richard Foa Katz
Dept Earth Sciences, Univ Oxford
http://foalab.earth.ox.ac.uk
More information about the petsc-dev
mailing list