[cig-commits] r20719 - in short/3D/PyLith/branches/v1.7-stable/tests: 2d 2d/stressoutput 3d 3d/stressoutput

willic3 at geodynamics.org willic3 at geodynamics.org
Sun Sep 16 19:56:57 PDT 2012


Author: willic3
Date: 2012-09-16 19:56:57 -0700 (Sun, 16 Sep 2012)
New Revision: 20719

Added:
   short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/
   short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/Makefile.am
   short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/README
   short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/onequad4.mesh
   short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/output_hdf5.cfg
   short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/output_vtk.cfg
   short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/pylithapp.cfg
   short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/
   short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/Makefile.am
   short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/README
   short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/onehex8.mesh
   short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/output_hdf5.cfg
   short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/output_vtk.cfg
   short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/pylithapp.cfg
Log:
Added extremely simple tests to evaluate tensor output for VTK vs. HDF5
output.



Added: short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/Makefile.am
===================================================================
--- short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/Makefile.am	                        (rev 0)
+++ short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/Makefile.am	2012-09-17 02:56:57 UTC (rev 20719)
@@ -0,0 +1,27 @@
+# -*- Makefile -*-
+#
+# ----------------------------------------------------------------------
+#
+# Brad T. Aagaard, U.S. Geological Survey
+# Charles A. Williams, GNS Science
+# Matthew G. Knepley, University of Chicago
+#
+# This code was developed as part of the Computational Infrastructure
+# for Geodynamics (http://geodynamics.org).
+#
+# Copyright (c) 2010-2012 University of California, Davis
+#
+# See COPYING for license information.
+#
+# ----------------------------------------------------------------------
+#
+
+dist_noinst_DATA = \
+	README \
+	onequad4.mesh \
+	output_hdf5.cfg \
+	output_vtk.cfg \
+	pylithapp.cfg
+
+
+# End of file 

Added: short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/README
===================================================================
--- short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/README	                        (rev 0)
+++ short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/README	2012-09-17 02:56:57 UTC (rev 20719)
@@ -0,0 +1,6 @@
+This is a very simple test to make sure the stress/strain output for
+HDF5 is consistent with output for VTK files. We use the same problem
+setup for both cases (simple combination of Dirichlet and Neumann BC),
+and then run the problem once using VTK output (output_vtk.cfg) and once
+using HDF5 output (output_hdf5.cfg). The tensor components should match,
+and should be consistent with what is in the PyLith manual.

Added: short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/onequad4.mesh
===================================================================
--- short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/onequad4.mesh	                        (rev 0)
+++ short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/onequad4.mesh	2012-09-17 02:56:57 UTC (rev 20719)
@@ -0,0 +1,128 @@
+// Finite-element mesh with one quad4 cell.
+//
+//
+//  1 ----- 3
+//  |       |
+//  |       |
+//  |       |
+//  0 ----- 2
+//
+// Each edge has a length of 2.0.
+//
+mesh = {
+
+  // Dimenion associated with topology of mesh.
+  dimension = 2
+
+  // We are using zero-based indexing (default, C style) rather than 
+  // one-based (Fortran style) indexing.
+  use-index-zero = true
+
+  // Vertices in the mesh.
+  vertices = {
+
+    // Dimension of coordinate system for vertices.
+    dimension = 2
+
+    // Number of vertices in mesh.
+    count = 4
+
+    // Coordinates are listed as:
+    // Vertex number (starting from zero), x-coord, y-coord
+    // Use coordinate units that are consistent with the other units used.
+    coordinates = {
+             0     -2.0 -1.0
+             1     -2.0  1.0
+             2      0.0 -1.0
+             3      0.0  1.0
+    }
+  }
+
+  // Finite-element cells in the mesh.
+  cells = {
+
+    // There is 1 cell.
+    count = 1
+
+    // These are bilinear quadrilateral cells, so there are 4 corners per cell.
+    num-corners = 4
+
+    // List the vertices composing each cell, moving counter-clockwise 
+    // around the cell.
+    // List the information as:
+    // Cell number (starting from zero), vertex 0, vertex 1, vertex 2, vertex 3
+    simplices = {
+             0       0  2  3  1
+    }
+
+    // List the material ID's associated with each cell.
+    // Different ID's may be used to specify a different material type, or
+    // to use a different spatial database for each material ID.
+    // In this example, cell 0 is associated with material ID 0.
+    material-ids = {
+             0   0
+    }
+  }
+
+  // Here we list different groups (cells or vertices) that we want to 
+  // associate with a particular name.
+
+  // This group of vertices may be used to specify boundary conditions.
+  // There are 2 vertices corresponding to indices 0, 2.
+  group = {
+    name = y_neg
+    type = vertices
+    count = 2
+    indices = {
+      0
+      2
+    }
+  }
+
+  // This group of vertices may be used to specify boundary conditions.
+  // There are 2 vertices corresponding to indices 0 and 1.
+  group = {
+    name = x_neg
+    type = vertices
+    count = 2
+    indices = {
+      0
+      1
+    }
+  }
+
+  // This group of vertices may be used to specify boundary conditions.
+  // There are 2 vertices corresponding to indices 2 and 3.
+  group = {
+    name = x_pos
+    type = vertices
+    count = 2
+    indices = {
+      2
+      3
+    }
+  }
+
+  // This group of vertices may be used to specify boundary conditions.
+  // There are 2 vertices corresponding to indices 1 and 3.
+  group = {
+    name = y_pos
+    type = vertices
+    count = 2
+    indices = {
+      1
+      3
+    }
+  }
+
+  // This group of vertices may be used to specify boundary conditions.
+  // There is 1 vertex corresponding to index 0.
+  group = {
+    name = ll_corner
+    type = vertices
+    count = 1
+    indices = {
+      0
+    }
+  }
+}

Added: short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/output_hdf5.cfg
===================================================================
--- short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/output_hdf5.cfg	                        (rev 0)
+++ short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/output_hdf5.cfg	2012-09-17 02:56:57 UTC (rev 20719)
@@ -0,0 +1,13 @@
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.formulation.output.domain]
+writer = pylith.meshio.DataWriterHDF5Mesh
+writer.filename = stressoutput_test.h5
+
+[pylithapp.timedependent.materials.elastic.output]
+writer = pylith.meshio.DataWriterHDF5Mesh
+cell_filter = pylith.meshio.CellFilterAvgMesh
+writer.filename = stressoutput_test-statevars.h5

Added: short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/output_vtk.cfg
===================================================================
--- short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/output_vtk.cfg	                        (rev 0)
+++ short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/output_vtk.cfg	2012-09-17 02:56:57 UTC (rev 20719)
@@ -0,0 +1,11 @@
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.formulation.output.domain]
+writer.filename = stressoutput_test.vtk
+
+[pylithapp.timedependent.materials.elastic.output]
+cell_filter = pylith.meshio.CellFilterAvgMesh
+writer.filename = stressoutput_test-statevars.vtk

Added: short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/pylithapp.cfg
===================================================================
--- short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/pylithapp.cfg	                        (rev 0)
+++ short/3D/PyLith/branches/v1.7-stable/tests/2d/stressoutput/pylithapp.cfg	2012-09-17 02:56:57 UTC (rev 20719)
@@ -0,0 +1,133 @@
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# journal
+# ----------------------------------------------------------------------
+# The settings below turn on journal info for the specified components.
+# If you want less output to stdout, you can turn these off.
+[pylithapp.journal.info]
+timedependent = 1
+implicit = 1
+petsc = 1
+solverlinear = 1
+meshioascii = 1
+homogeneous = 1
+elasticityimplicit = 1
+fiatlagrange = 1
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+# The settings below control the mesh generation (importing mesh info).
+# Turn on debugging output for mesh generation.
+[pylithapp.mesh_generator.reader]
+filename = onequad4.mesh
+coordsys.space_dim = 2
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+# Specify the problem settings.
+[pylithapp.timedependent]
+normalizer.length_scale = 1.0*m
+dimension = 2
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 0.0*year
+dt = 1.0*year
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+materials = [elastic]
+materials.elastic = pylith.materials.ElasticPlaneStrain
+
+[pylithapp.timedependent.materials.elastic]
+label = Elastic material
+id = 0
+
+# We specify a uniform DB and give the properties in this file.
+db_properties = spatialdata.spatialdb.UniformDB
+db_properties.label = Elastic spatialdb
+db_properties.values = [vp,vs,density]
+db_properties.data = [5291.502622129181*m/s,3000.0*m/s,2700.0*kg/m**3]
+
+# Set cell type to FIAT Lagrange.
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 2
+
+# Set cell info and output fields
+output.cell_info_fields = [density,mu,lambda]
+output.cell_data_fields = [total_strain,stress]
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+bc = [x_neg,y_neg,x_pos,y_pos]
+# bc = [y_neg,ll_corner]
+implicit.output = [domain]
+
+bc.x_pos = pylith.bc.Neumann
+bc.y_pos = pylith.bc.Neumann
+
+[pylithapp.timedependent.bc.x_neg]
+bc_dof = [0]
+label = x_neg
+db_initial.label = Dirichlet BC on -x
+
+[pylithapp.timedependent.bc.y_neg]
+bc_dof = [1]
+label = y_neg
+db_initial.label = Dirichlet BC on -y
+
+[pylithapp.timedependent.bc.x_pos]
+label = x_pos
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC on +x
+db_initial.values = [traction-shear,traction-normal]
+db_initial.data = [-0.1*kPa,-2.0*kPa]
+
+[pylithapp.timedependent.bc.y_pos]
+label = y_pos
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC on +y
+db_initial.values = [traction-shear,traction-normal]
+db_initial.data = [0.1*kPa,-1.0*kPa]
+
+# ----------------------------------------------------------------------
+# PETSc
+# ----------------------------------------------------------------------
+[pylithapp.petsc]
+pc_type = asm
+
+# Change the preconditioner settings.
+sub_pc_factor_shift_type = nonzero
+
+ksp_rtol = 1.0e-10
+ksp_atol = 1.0e-20
+ksp_max_it = 100
+ksp_gmres_restart = 50
+
+ksp_monitor = true
+ksp_view = true
+ksp_converged_reason = true
+
+snes_rtol = 1.0e-10
+snes_atol = 1.0e-20
+snes_max_it = 100
+snes_monitor = true
+snes_view = true
+snes_converged_reason = true
+
+log_summary = true
+# start_in_debugger = true

Added: short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/Makefile.am
===================================================================
--- short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/Makefile.am	                        (rev 0)
+++ short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/Makefile.am	2012-09-17 02:56:57 UTC (rev 20719)
@@ -0,0 +1,27 @@
+# -*- Makefile -*-
+#
+# ----------------------------------------------------------------------
+#
+# Brad T. Aagaard, U.S. Geological Survey
+# Charles A. Williams, GNS Science
+# Matthew G. Knepley, University of Chicago
+#
+# This code was developed as part of the Computational Infrastructure
+# for Geodynamics (http://geodynamics.org).
+#
+# Copyright (c) 2010-2012 University of California, Davis
+#
+# See COPYING for license information.
+#
+# ----------------------------------------------------------------------
+#
+
+dist_noinst_DATA = \
+	README \
+	onehex8.mesh \
+	output_hdf5.cfg \
+	output_vtk.cfg \
+	pylithapp.cfg
+
+
+# End of file 

Added: short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/README
===================================================================
--- short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/README	                        (rev 0)
+++ short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/README	2012-09-17 02:56:57 UTC (rev 20719)
@@ -0,0 +1,6 @@
+This is a very simple test to make sure the stress/strain output for
+HDF5 is consistent with output for VTK files. We use the same problem
+setup for both cases (simple combination of Dirichlet and Neumann BC),
+and then run the problem once using VTK output (output_vtk.cfg) and once
+using HDF5 output (output_hdf5.cfg). The tensor components should match,
+and should be consistent with what is in the PyLith manual.

Added: short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/onehex8.mesh
===================================================================
--- short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/onehex8.mesh	                        (rev 0)
+++ short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/onehex8.mesh	2012-09-17 02:56:57 UTC (rev 20719)
@@ -0,0 +1,77 @@
+mesh = {
+  dimension = 3
+  use-index-zero = true
+  vertices = {
+    dimension = 3
+    count = 8
+    coordinates = {
+             0      0.0  0.0  0.0
+             1      0.0  1.0  0.0
+             2      0.0  0.0  1.0
+             3      0.0  1.0  1.0
+             4      1.0  0.0  0.0
+             5      1.0  1.0  0.0
+             6      1.0  0.0  1.0
+             7      1.0  1.0  1.0
+    }
+  }
+  cells = {
+    count = 1
+    num-corners = 8
+    simplices = {
+             0       0  4  5  1  2  6  7  3
+    }
+    material-ids = {
+             0   0
+    }
+  }
+
+  group = {
+    name = x_neg
+    type = vertices
+    count = 4
+    indices = {
+      0  1  2  3
+    }
+  }
+  group = {
+    name = x_pos
+    type = vertices
+    count = 4
+    indices = {
+      4  5  6  7
+    }
+  }
+  group = {
+    name = y_neg
+    type = vertices
+    count = 4
+    indices = {
+      0  2  4  6
+    }
+  }
+  group = {
+    name = y_pos
+    type = vertices
+    count = 4
+    indices = {
+      1  3  5  7
+    }
+  }
+  group = {
+    name = z_neg
+    type = vertices
+    count = 4
+    indices = {
+      0  1  4  5
+    }
+  }
+  group = {
+    name = z_pos
+    type = vertices
+    count = 4
+    indices = {
+      2  3  6  7
+    }
+  }
+}

Added: short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/output_hdf5.cfg
===================================================================
--- short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/output_hdf5.cfg	                        (rev 0)
+++ short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/output_hdf5.cfg	2012-09-17 02:56:57 UTC (rev 20719)
@@ -0,0 +1,13 @@
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.formulation.output.domain]
+writer = pylith.meshio.DataWriterHDF5Mesh
+writer.filename = stressoutput_test.h5
+
+[pylithapp.timedependent.materials.elastic.output]
+writer = pylith.meshio.DataWriterHDF5Mesh
+cell_filter = pylith.meshio.CellFilterAvgMesh
+writer.filename = stressoutput_test-statevars.h5

Added: short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/output_vtk.cfg
===================================================================
--- short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/output_vtk.cfg	                        (rev 0)
+++ short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/output_vtk.cfg	2012-09-17 02:56:57 UTC (rev 20719)
@@ -0,0 +1,11 @@
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.formulation.output.domain]
+writer.filename = stressoutput_test.vtk
+
+[pylithapp.timedependent.materials.elastic.output]
+cell_filter = pylith.meshio.CellFilterAvgMesh
+writer.filename = stressoutput_test-statevars.vtk

Added: short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/pylithapp.cfg
===================================================================
--- short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/pylithapp.cfg	                        (rev 0)
+++ short/3D/PyLith/branches/v1.7-stable/tests/3d/stressoutput/pylithapp.cfg	2012-09-17 02:56:57 UTC (rev 20719)
@@ -0,0 +1,149 @@
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# journal
+# ----------------------------------------------------------------------
+# The settings below turn on journal info for the specified components.
+# If you want less output to stdout, you can turn these off.
+[pylithapp.journal.info]
+timedependent = 1
+implicit = 1
+petsc = 1
+solverlinear = 1
+meshioascii = 1
+homogeneous = 1
+elasticityimplicit = 1
+fiatlagrange = 1
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+# The settings below control the mesh generation (importing mesh info).
+# Turn on debugging output for mesh generation.
+[pylithapp.mesh_generator.reader]
+filename = onehex8.mesh
+coordsys.space_dim = 3
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+# Specify the problem settings.
+[pylithapp.timedependent]
+normalizer.length_scale = 1.0*m
+dimension = 3
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 0.0*year
+dt = 1.0*year
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+materials = [elastic]
+
+[pylithapp.timedependent.materials.elastic]
+label = Elastic material
+id = 0
+
+# We specify a uniform DB and give the properties in this file.
+db_properties = spatialdata.spatialdb.UniformDB
+db_properties.label = Elastic spatialdb
+db_properties.values = [vp,vs,density]
+db_properties.data = [5291.502622129181*m/s,3000.0*m/s,2700.0*kg/m**3]
+
+# Set cell type to FIAT Lagrange.
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 3
+
+# Set cell info and output fields
+output.cell_info_fields = [density,mu,lambda]
+output.cell_data_fields = [total_strain,stress]
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+bc = [x_neg,y_neg,z_neg,x_pos,y_pos,z_pos]
+implicit.output = [domain]
+
+bc.x_pos = pylith.bc.Neumann
+bc.y_pos = pylith.bc.Neumann
+bc.z_pos = pylith.bc.Neumann
+
+[pylithapp.timedependent.bc.x_neg]
+bc_dof = [0]
+label = x_neg
+db_initial.label = Dirichlet BC on -x
+
+[pylithapp.timedependent.bc.y_neg]
+bc_dof = [1]
+label = y_neg
+db_initial.label = Dirichlet BC on -y
+
+[pylithapp.timedependent.bc.z_neg]
+bc_dof = [2]
+label = z_neg
+db_initial.label = Dirichlet BC on -z
+
+[pylithapp.timedependent.bc.x_pos]
+label = x_pos
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 2
+quadrature.cell.quad_order = 2
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC on +x
+db_initial.values = [traction-shear-horiz,traction-shear-vert,traction-normal]
+db_initial.data = [-0.1*kPa,-0.01*kPa,-3.0*kPa]
+
+[pylithapp.timedependent.bc.y_pos]
+label = y_pos
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 2
+quadrature.cell.quad_order = 2
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC on +y
+db_initial.values = [traction-shear-horiz,traction-shear-vert,traction-normal]
+db_initial.data = [0.1*kPa,-0.001*kPa,-2.0*kPa]
+
+[pylithapp.timedependent.bc.z_pos]
+label = z_pos
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 2
+quadrature.cell.quad_order = 2
+
+up_dir = [1.0,0.0,0.0]
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC on +z
+db_initial.values = [traction-shear-horiz,traction-shear-vert,traction-normal]
+db_initial.data = [0.1*kPa,-0.001*kPa,-1.0*kPa]
+
+# ----------------------------------------------------------------------
+# PETSc
+# ----------------------------------------------------------------------
+[pylithapp.petsc]
+pc_type = asm
+
+# Change the preconditioner settings.
+sub_pc_factor_shift_type = nonzero
+
+ksp_rtol = 1.0e-10
+ksp_atol = 1.0e-20
+ksp_max_it = 100
+ksp_gmres_restart = 50
+
+ksp_monitor = true
+ksp_view = true
+ksp_converged_reason = true
+
+snes_rtol = 1.0e-10
+snes_atol = 1.0e-20
+snes_max_it = 100
+snes_monitor = true
+snes_view = true
+snes_converged_reason = true
+
+log_summary = true
+# start_in_debugger = true



More information about the CIG-COMMITS mailing list