[cig-commits] r16107 - short/3D/PyLith/trunk/playpen/friction/tet4

surendra at geodynamics.org surendra at geodynamics.org
Wed Dec 16 22:25:50 PST 2009


Author: surendra
Date: 2009-12-16 22:25:49 -0800 (Wed, 16 Dec 2009)
New Revision: 16107

Added:
   short/3D/PyLith/trunk/playpen/friction/tet4/matelastic3D.spatialdb
   short/3D/PyLith/trunk/playpen/friction/tet4/opening.cfg
   short/3D/PyLith/trunk/playpen/friction/tet4/shear-sliding.cfg
   short/3D/PyLith/trunk/playpen/friction/tet4/shear-stick.cfg
Modified:
   short/3D/PyLith/trunk/playpen/friction/tet4/tet4.mesh
Log:
Added tet4 (opening,shear-stick,shear-sliding) friction examples

Added: short/3D/PyLith/trunk/playpen/friction/tet4/matelastic3D.spatialdb
===================================================================
--- short/3D/PyLith/trunk/playpen/friction/tet4/matelastic3D.spatialdb	                        (rev 0)
+++ short/3D/PyLith/trunk/playpen/friction/tet4/matelastic3D.spatialdb	2009-12-17 06:25:49 UTC (rev 16107)
@@ -0,0 +1,17 @@
+#SPATIAL.ascii 1
+
+SimpleDB {
+
+  num-values = 3
+  value-names =  density vs vp
+  value-units =  kg/m**3  m/s  m/s
+  num-locs = 1
+  data-dim = 0
+  space-dim = 3
+
+  cs-data = cartesian {
+    to-meters = 1.0
+    space-dim = 3
+  }
+}
+0.0  0.0  0.0   2700.0  3333.333333333333  5773.502691896258 

Added: short/3D/PyLith/trunk/playpen/friction/tet4/opening.cfg
===================================================================
--- short/3D/PyLith/trunk/playpen/friction/tet4/opening.cfg	                        (rev 0)
+++ short/3D/PyLith/trunk/playpen/friction/tet4/opening.cfg	2009-12-17 06:25:49 UTC (rev 16107)
@@ -0,0 +1,163 @@
+# -*- Python -*-
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# journal
+# ----------------------------------------------------------------------
+[pylithapp.journal.info]
+timedependent = 1
+implicit = 1
+petsc = 1
+solvernonlinear = 1
+meshioascii = 1
+homogeneous = 1
+elasticityimplicit = 1
+fiatlagrange = 1
+quadrature3d = 1
+faultcohesivedyn = 1
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+[pylithapp.mesh_generator]
+debug = 0
+
+[pylithapp.mesh_generator.reader]
+filename = tet4.mesh
+coordsys.space_dim = 3
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+dimension = 3
+normalizer.length_scale = 1.0*m
+formulation = pylith.problems.Implicit
+formulation.solver = pylith.problems.SolverNonlinear
+
+# Set bc to an array with 2 boundary conditions: 'x_neg' and 'x_pos'.
+bc = [x_neg,x_pos]
+
+# Set interfaces to an array with 1 fault: 'fault'.
+interfaces = [fault]
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 0.0*s
+dt = 1.0*s
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.materials]
+material = pylith.materials.ElasticIsotropic3D
+
+[pylithapp.timedependent.materials.material]
+
+# We give a label of 'elastic isotropic 3D material' to this material.
+label = Elastic isotropic 3D material
+
+# The cells associated with this material are given a material ID of 1
+# in the mesh file.
+id = 1
+
+db_properties.iohandler.filename = matelastic3D.spatialdb
+
+# We are doing 3D quadrature for a tet4.
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = tetrahedron
+
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 0.0*s
+dt = 1.0*s
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+# Boundary conditions to be applied to the negative x-side of the mesh.
+[pylithapp.timedependent.bc.x_neg]
+
+# We are fixing the 0 (x), 1 (y) and 2 (z) degrees of freedom.
+bc_dof = [0,1,2]
+
+# The nodes associated with this boundary condition have the name
+# 'x_neg' in the mesh file.
+label = x_neg
+
+# Boundary conditions to be applied to the positive x-side of the mesh.
+[pylithapp.timedependent.bc.x_pos]
+
+# We are prescribing the 0 (x) and fixing 1 (y), 2 (z) degrees of freedom.
+bc_dof = [0,1,2]
+
+# The nodes associated with this boundary condition have the name
+# 'x_pos' in the mesh file.
+label = x_pos
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Dirichlet BC +x edge
+db_initial.values = [displacement-x,displacement-y,displacement-z]
+db_initial.data = [1.0*m,0.0*m,0.0*m]
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.interfaces]
+fault = pylith.faults.FaultCohesiveDynL
+
+[pylithapp.timedependent.interfaces.fault]
+
+# The nodes associated with this fault have the name 'fault' in the mesh file.
+label = fault
+
+# The quadrature for a 3D fault is 2D with a linear shape.
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+db_initial_tractions = spatialdata.spatialdb.UniformDB
+db_initial_tractions.label = "Initial fault tractions"
+db_initial_tractions.values = [traction-shear-leftlateral,traction-shear-updip,traction-normal]
+db_initial_tractions.data = [0.0*Pa,0.0*Pa, -10000.0*MPa]
+
+# ----------------------------------------------------------------------
+# PETSc
+# ----------------------------------------------------------------------
+# We are using all of the default settings for PETSc except for
+# specifying the block Jacobi preconditioner.  Additional PETSc
+# command-line arguments may be found in the PETSc documentation.
+[pylithapp.petsc]
+ksp_rtol = 1.0e-8
+pc_type = asm
+# Change the preconditioner settings (must turn off
+# shift_positive_definite and turn on shift_nonzero).
+sub_pc_factor_shift_positive_definite = 0
+sub_pc_factor_shift_nonzero = 
+
+ksp_monitor = true
+ksp_view = true
+#log_summary = true
+ksp_max_it = 100
+ksp_gmres_restart = 50
+#start_in_debugger = true
+
+snes_monitor = true
+snes_view = true
+ksp_converged_reason = true
+snes_converged_reason = true
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output.writer]
+filename = tet4-opening.vtk
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+writer.filename = tet4-opening-fault.vtk
+vertex_info_fields = [strike_dir,normal_dir,dip_dir,initial_traction]
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.material.output]
+cell_filter = pylith.meshio.CellFilterAvgMesh
+writer.filename = tet4-opening-statevars.vtk

Added: short/3D/PyLith/trunk/playpen/friction/tet4/shear-sliding.cfg
===================================================================
--- short/3D/PyLith/trunk/playpen/friction/tet4/shear-sliding.cfg	                        (rev 0)
+++ short/3D/PyLith/trunk/playpen/friction/tet4/shear-sliding.cfg	2009-12-17 06:25:49 UTC (rev 16107)
@@ -0,0 +1,250 @@
+# -*- Python -*-
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# journal
+# ----------------------------------------------------------------------
+[pylithapp.journal.info]
+timedependent = 1
+implicit = 1
+petsc = 1
+solvernonlinear = 1
+meshioascii = 1
+homogeneous = 1
+elasticityimplicit = 1
+fiatlagrange = 1
+quadrature3d = 1
+faultcohesivedyn = 1
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+[pylithapp.mesh_generator]
+debug = 0
+
+[pylithapp.mesh_generator.reader]
+filename = tet4.mesh
+coordsys.space_dim = 3
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+dimension = 3
+normalizer.length_scale = 1.0*m
+formulation = pylith.problems.Implicit
+formulation.solver = pylith.problems.SolverNonlinear
+
+# Set bc to an array with 2 boundary conditions: 'x_neg' and 'x_pos'.
+bc = [x_neg,x_pos,y_pos,y_neg,z_pos,z_neg]
+#bc = [x_neg,x_pos,y_pos,y_neg]
+bc.x_pos = pylith.bc.DirichletBoundary
+bc.y_pos = pylith.bc.Neumann
+bc.y_neg = pylith.bc.Neumann
+bc.z_pos = pylith.bc.Neumann
+bc.z_neg = pylith.bc.Neumann
+
+# Set interfaces to an array with 1 fault: 'fault'.
+interfaces = [fault]
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 0.0*s
+dt = 1.0*s
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.materials]
+material = pylith.materials.ElasticIsotropic3D
+
+[pylithapp.timedependent.materials.material]
+
+# We give a label of 'elastic isotropic 3D material' to this material.
+label = Elastic isotropic 3D material
+
+# The cells associated with this material are given a material ID of 1
+# in the mesh file.
+id = 1
+
+db_properties.iohandler.filename = matelastic3D.spatialdb
+
+# We are doing 3D quadrature for a tet4.
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = tetrahedron
+
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 0.0*s
+dt = 1.0*s
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+# Boundary conditions to be applied to the negative x-side of the mesh.
+[pylithapp.timedependent.bc.x_neg]
+
+# We are fixing the 0 (x), 1 (y) and 2 (z) degrees of freedom.
+bc_dof = [0,1,2]
+
+# The nodes associated with this boundary condition have the name
+# 'x_neg' in the mesh file.
+label = x_neg
+
+# Boundary conditions to be applied to the positive x-side of the mesh.
+[pylithapp.timedependent.bc.x_pos]
+
+# We are  fixing 0 (x) and prescribing 1 (y) and 2 (z) degrees of freedom.
+bc_dof = [0,1,2]
+
+# The nodes associated with this boundary condition have the name
+# 'x_pos' in the mesh file.
+label = x_pos
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Dirichlet BC +x edge
+db_initial.values = [displacement-x,displacement-y,displacement-z]
+db_initial.data = [0.0*m,1.8*m,2.4*m]
+
+
+
+
+
+
+
+# Boundary conditions to be applied to the positive y-side of the mesh.
+[pylithapp.timedependent.bc.y_pos]
+
+# The nodes associated with this boundary condition have the name
+# 'y_pos' in the mesh file.
+label = y_pos
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC +y edge
+db_initial.values = [traction-shear-horiz,traction-shear-vert,traction-normal]
+db_initial.data = [-3600.0*MPa,0.0*MPa,0.0*MPa]
+
+# 2-D simplex cell in 3-D space 
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+
+# Boundary conditions to be applied to the negative y-side of the mesh.
+[pylithapp.timedependent.bc.y_neg]
+
+# The nodes associated with this boundary condition have the name
+# 'y_neg' in the mesh file.
+label = y_neg
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC -y edge
+db_initial.values = [traction-shear-horiz,traction-shear-vert,traction-normal]
+db_initial.data = [-3600.0*MPa,0.0*MPa,0.0*MPa]
+
+# 2-D simplex cell in 3-D space 
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+
+
+
+# Boundary conditions to be applied to the positive z-side of the mesh.
+[pylithapp.timedependent.bc.z_pos]
+
+# The nodes associated with this boundary condition have the name
+# 'z_pos' in the mesh file.
+label = z_pos
+
+up_dir = [1, 0, 0]
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC +z edge
+db_initial.values = [traction-shear-horiz,traction-shear-vert,traction-normal]
+db_initial.data = [0.0*MPa,4800.0*MPa,0.0*MPa]
+
+# 2-D simplex cell in 3-D space 
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+
+# Boundary conditions to be applied to the negative z-side of the mesh.
+[pylithapp.timedependent.bc.z_neg]
+
+# The nodes associated with this boundary condition have the name
+# 'z_neg' in the mesh file.
+label = z_neg
+
+up_dir = [-1, 0, 0]
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC -z edge
+db_initial.values = [traction-shear-horiz,traction-shear-vert,traction-normal]
+db_initial.data = [0.0*MPa,4800.0*MPa,0.0*MPa]
+
+# 2-D simplex cell in 3-D space 
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.interfaces]
+fault = pylith.faults.FaultCohesiveDynL
+
+[pylithapp.timedependent.interfaces.fault]
+
+# The nodes associated with this fault have the name 'fault' in the mesh file.
+label = fault
+
+# 2-D simplex fault in 3-D space 
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+db_initial_tractions = spatialdata.spatialdb.UniformDB
+db_initial_tractions.label = "Initial fault tractions"
+db_initial_tractions.values = [traction-shear-leftlateral,traction-shear-updip,traction-normal]
+db_initial_tractions.data = [0.0*Pa,0.0*Pa, -10000.0*MPa]
+
+# ----------------------------------------------------------------------
+# PETSc
+# ----------------------------------------------------------------------
+# We are using all of the default settings for PETSc except for
+# specifying the block Jacobi preconditioner.  Additional PETSc
+# command-line arguments may be found in the PETSc documentation.
+[pylithapp.petsc]
+ksp_rtol = 1.0e-8
+pc_type = asm
+# Change the preconditioner settings (must turn off
+# shift_positive_definite and turn on shift_nonzero).
+sub_pc_factor_shift_positive_definite = 0
+sub_pc_factor_shift_nonzero = 
+
+ksp_monitor = true
+ksp_view = true
+#log_summary = true
+ksp_max_it = 100
+ksp_gmres_restart = 50
+#start_in_debugger = true
+
+snes_monitor = true
+snes_view = true
+ksp_converged_reason = true
+snes_converged_reason = true
+snes_max_it = 200
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output.writer]
+filename = tet4-shear-sliding.vtk
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+writer.filename = tet4-shear-sliding-fault.vtk
+vertex_info_fields = [strike_dir,normal_dir,dip_dir,initial_traction]
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.material.output]
+cell_filter = pylith.meshio.CellFilterAvgMesh
+writer.filename = tet4-shear-sliding-statevars.vtk

Added: short/3D/PyLith/trunk/playpen/friction/tet4/shear-stick.cfg
===================================================================
--- short/3D/PyLith/trunk/playpen/friction/tet4/shear-stick.cfg	                        (rev 0)
+++ short/3D/PyLith/trunk/playpen/friction/tet4/shear-stick.cfg	2009-12-17 06:25:49 UTC (rev 16107)
@@ -0,0 +1,263 @@
+# -*- Python -*-
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# journal
+# ----------------------------------------------------------------------
+[pylithapp.journal.info]
+timedependent = 1
+implicit = 1
+petsc = 1
+solvernonlinear = 1
+meshioascii = 1
+homogeneous = 1
+elasticityimplicit = 1
+fiatlagrange = 1
+quadrature3d = 1
+faultcohesivedyn = 1
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+[pylithapp.mesh_generator]
+debug = 0
+
+[pylithapp.mesh_generator.reader]
+filename = tet4.mesh
+coordsys.space_dim = 3
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+dimension = 3
+normalizer.length_scale = 1.0*m
+formulation = pylith.problems.Implicit
+formulation.solver = pylith.problems.SolverNonlinear
+
+# Set bc to an array with 3 boundary conditions: 'x_neg', 'x_pos_disp', 'x_pos_tract'
+bc = [x_neg,x_pos_disp,x_pos_tract,y_pos,y_neg,z_pos,z_neg]
+bc.x_pos_tract = pylith.bc.Neumann
+bc.y_pos = pylith.bc.Neumann
+bc.y_neg = pylith.bc.Neumann
+bc.z_pos = pylith.bc.Neumann
+bc.z_neg = pylith.bc.Neumann
+
+# Set interfaces to an array with 1 fault: 'fault'.
+interfaces = [fault]
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 0.0*s
+dt = 1.0*s
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.materials]
+material = pylith.materials.ElasticIsotropic3D
+
+[pylithapp.timedependent.materials.material]
+
+# We give a label of 'elastic isotropic 3D material' to this material.
+label = Elastic isotropic 3D material
+
+# The cells associated with this material are given a material ID of 1
+# in the mesh file.
+id = 1
+
+db_properties.iohandler.filename = matelastic3D.spatialdb
+
+# We are doing 3D quadrature for a tet4.
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = tetrahedron
+
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 0.0*s
+dt = 1.0*s
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+# Boundary conditions to be applied to the negative x-side of the mesh.
+[pylithapp.timedependent.bc.x_neg]
+
+# We are fixing the 0 (x), 1 (y) and 2 (z) degrees of freedom.
+bc_dof = [0,1,2]
+
+# The nodes associated with this boundary condition have the name
+# 'x_neg' in the mesh file.
+label = x_neg
+
+# Boundary conditions to be applied to the positive x-side of the mesh.
+[pylithapp.timedependent.bc.x_pos_disp]
+
+# We are fixing the 0 (x) degree of freedom.
+bc_dof = [0]
+
+# The nodes associated with this boundary condition have the name
+# 'x_pos' in the mesh file.
+label = x_pos
+
+# Boundary conditions to be applied to the positive x-side of the mesh.
+[pylithapp.timedependent.bc.x_pos_tract]
+
+# The nodes associated with this boundary condition have the name
+# 'x_pos' in the mesh file.
+label = x_pos
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC +x edge
+db_initial.values = [traction-shear-horiz,traction-shear-vert,traction-normal]
+db_initial.data = [3000.0*MPa,2000.0*MPa,0.0*MPa]
+
+# 2-D simplex cell in 3-D space 
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+
+
+# Boundary conditions to be applied to the positive y-side of the mesh.
+[pylithapp.timedependent.bc.y_pos]
+
+# The nodes associated with this boundary condition have the name
+# 'y_pos' in the mesh file.
+label = y_pos
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC +y edge
+db_initial.values = [traction-shear-horiz,traction-shear-vert,traction-normal]
+db_initial.data = [-3000.0*MPa,0.0*MPa,0.0*MPa]
+
+# 2-D simplex cell in 3-D space 
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+
+
+# Boundary conditions to be applied to the negative y-side of the mesh.
+[pylithapp.timedependent.bc.y_neg]
+
+# The nodes associated with this boundary condition have the name
+# 'y_neg' in the mesh file.
+label = y_neg
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC -y edge
+db_initial.values = [traction-shear-horiz,traction-shear-vert,traction-normal]
+db_initial.data = [-3000.0*MPa,0.0*MPa,0.0*MPa]
+
+# 2-D simplex cell in 3-D space 
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+
+
+
+# Boundary conditions to be applied to the positive z-side of the mesh.
+[pylithapp.timedependent.bc.z_pos]
+
+# The nodes associated with this boundary condition have the name
+# 'z_pos' in the mesh file.
+label = z_pos
+
+up_dir = [0, 1, 0]
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC +z edge
+db_initial.values = [traction-shear-horiz,traction-shear-vert,traction-normal]
+db_initial.data = [2000.0*MPa,0.0*MPa,0.0*MPa]
+
+# 2-D simplex cell in 3-D space 
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+
+
+# Boundary conditions to be applied to the negative z-side of the mesh.
+[pylithapp.timedependent.bc.z_neg]
+
+# The nodes associated with this boundary condition have the name
+# 'z_neg' in the mesh file.
+label = z_neg
+
+up_dir = [0, 1, 0]
+
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Neumann BC -z edge
+db_initial.values = [traction-shear-horiz,traction-shear-vert,traction-normal]
+db_initial.data = [2000.0*MPa,0.0*MPa,0.0*MPa]
+
+# 2-D simplex cell in 3-D space 
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+
+
+
+
+
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.interfaces]
+fault = pylith.faults.FaultCohesiveDynL
+
+[pylithapp.timedependent.interfaces.fault]
+
+# The nodes associated with this fault have the name 'fault' in the mesh file.
+label = fault
+
+# 2-D simplex fault in 3-D space 
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+db_initial_tractions = spatialdata.spatialdb.UniformDB
+db_initial_tractions.label = "Initial fault tractions"
+db_initial_tractions.values = [traction-shear-leftlateral,traction-shear-updip,traction-normal]
+db_initial_tractions.data = [0.0*Pa,0.0*Pa, -10000.0*MPa]
+
+# ----------------------------------------------------------------------
+# PETSc
+# ----------------------------------------------------------------------
+# We are using all of the default settings for PETSc except for
+# specifying the block Jacobi preconditioner.  Additional PETSc
+# command-line arguments may be found in the PETSc documentation.
+[pylithapp.petsc]
+ksp_rtol = 1.0e-8
+pc_type = asm
+# Change the preconditioner settings (must turn off
+# shift_positive_definite and turn on shift_nonzero).
+sub_pc_factor_shift_positive_definite = 0
+sub_pc_factor_shift_nonzero = 
+
+ksp_monitor = true
+ksp_view = true
+#log_summary = true
+ksp_max_it = 100
+ksp_gmres_restart = 50
+#start_in_debugger = true
+
+snes_monitor = true
+snes_view = true
+ksp_converged_reason = true
+snes_converged_reason = true
+snes_max_it = 200
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output.writer]
+filename = tet4-shear-stick.vtk
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+writer.filename = tet4-shear-stick-fault.vtk
+vertex_info_fields = [strike_dir,normal_dir,dip_dir,initial_traction]
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.material.output]
+cell_filter = pylith.meshio.CellFilterAvgMesh
+writer.filename = tet4-shear-stick-statevars.vtk

Modified: short/3D/PyLith/trunk/playpen/friction/tet4/tet4.mesh
===================================================================
--- short/3D/PyLith/trunk/playpen/friction/tet4/tet4.mesh	2009-12-16 21:50:54 UTC (rev 16106)
+++ short/3D/PyLith/trunk/playpen/friction/tet4/tet4.mesh	2009-12-17 06:25:49 UTC (rev 16107)
@@ -49,18 +49,18 @@
     // List the information as:
     // Cell number (starting from zero), vertex 0, vertex 1, etc.
     simplices = {
-             0       0  2  1  6 // reversed
-             1       2  1  6  7
-             2       2  7  6  8
-             3       3  1  2  9 // reversed
-             4       1  2  9  8
-             5       1  8  9  7
-             6       2  4  3  8 // reversed
-             7       4  3  8  9 // repeated node
-             8       4  9  8 10 
-             9       5  3  4 11
-            10       3  4 11 10
-            11       3 10 11  9
+             0       8  1  0  7
+             1       8  1  7  9
+             2       8  1  9  2
+             3       8  1  2  0
+             4       0  8  7  6
+             5       1  9  2  3
+             6       8  4  5 11
+             7       8 11  5  9 
+             8       8  9  5  2 
+             9       8  2  5  4
+            10       4 11  8 10
+            11       5  2  9  3
     }
 
     // List the material ID's associated with each cell.



More information about the CIG-COMMITS mailing list