[cig-commits] r16705 - short/3D/PyLith/trunk/examples/bar_shearwave/quad4

brad at geodynamics.org brad at geodynamics.org
Fri May 14 12:51:00 PDT 2010


Author: brad
Date: 2010-05-14 12:50:59 -0700 (Fri, 14 May 2010)
New Revision: 16705

Added:
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/dynamicfault.cfg
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/dynamicfault_shearwave.cfg
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematic_risetime.spatialdb
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematic_slip.spatialdb
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematic_sliptime.spatialdb
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematicfault.cfg
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave-ratestateageing.cfg
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave-slipweakening.cfg
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/static-sliding.cfg
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/static-stick.cfg
Removed:
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_risetime.spatialdb
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_slip.spatialdb
   short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_sliptime.spatialdb
Log:
Started reorganizing .cfg files to include friction examples.

Added: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/dynamicfault.cfg
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/dynamicfault.cfg	                        (rev 0)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/dynamicfault.cfg	2010-05-14 19:50:59 UTC (rev 16705)
@@ -0,0 +1,139 @@
+# -*- Python -*-
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# journal
+# ----------------------------------------------------------------------
+[pylithapp.journal.info]
+timedependent = 1
+#explicit = 1
+#petsc = 1
+#meshiocubit = 1
+#explicitelasticity = 1
+#quadrature2d = 1
+#fiatlagrange = 1
+#faultcohesivedyn = 1
+
+[pylithapp.journal.debug]
+#pylithapp = 1
+#problem = 1
+#explicit = 1
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+[pylithapp.mesh_generator]
+reader = pylith.meshio.MeshIOCubit
+
+[pylithapp.mesh_generator.reader]
+filename = bar_quad4_200m.exo
+coordsys.space_dim = 2
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+dimension = 2
+
+# Set interfaces to an array with 1 fault: 'fault'.
+interfaces = [fault]
+
+# Set materials to an array with 1 material 'elastic'.
+materials = [elastic]
+
+# Nondimensionalize problem using wave propagation parameters.
+normalizer = spatialdata.units.NondimElasticDynamic
+normalizer.shear_wave_speed = 1.0*km/s
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 0.0*s
+dt = 0.05*s
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.materials]
+elastic = pylith.materials.ElasticPlaneStrain
+
+[pylithapp.timedependent.materials.elastic]
+
+# Label for material
+label = Elastic material
+
+# Nodeset id from CUBIT
+id = 1
+
+# Spatial database with physical properties for elastic material
+db_properties.iohandler.filename = matprops.spatialdb
+
+# Set the basis functions and quadrature:
+# 2-D Lagrange cell with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 2
+quadrature.cell.quad_order = 2
+
+# ----------------------------------------------------------------------
+# PETSc
+# ----------------------------------------------------------------------
+[pylithapp.petsc]
+ksp_type = gmres
+pc_type = asm
+
+# Change the preconditioner settings.
+sub_pc_factor_shift_type = nonzero
+
+ksp_rtol = 1.0e-8
+ksp_atol = 1.0e-15
+ksp_max_it = 200
+ksp_gmres_restart = 250
+snes_max_it = 300
+
+#ksp_monitor = true
+#ksp_view = true
+ksp_converged_reason = true
+
+snes_rtol = 1.0e-8
+snes_atol = 1.0e-15
+#snes_monitor = true
+#snes_view = true
+snes_converged_reason = true
+
+#log_summary = true
+
+# Friction sensitivity solve
+friction_pc_type = asm
+friction_sub_pc_factor_shift_type = nonzero
+friction_ksp_max_it = 25
+friction_ksp_gmres_restart = 30
+#friction_ksp_monitor = true
+#friction_ksp_view = true
+friction_ksp_converged_reason = true
+
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# We set three output manager parameters for each type of output.
+#   skip - Number of time steps to skip between output
+#   writer.filename - Root name for VTK file
+#   writer.time_format - Format of time stamp (decimal point is removed)
+
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output]
+vertex_data_fields=[displacement,velocity]
+skip = 3
+writer.time_format = %05.2f
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+vertex_data_fields=[slip,slip_rate,traction]
+skip = 3
+writer.time_format = %05.2f
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.elastic.output]
+skip = 33
+writer.time_format = %05.2f
+
+# Averate state variables over cell
+cell_filter = pylith.meshio.CellFilterAvgMesh

Added: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/dynamicfault_shearwave.cfg
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/dynamicfault_shearwave.cfg	                        (rev 0)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/dynamicfault_shearwave.cfg	2010-05-14 19:50:59 UTC (rev 16705)
@@ -0,0 +1,124 @@
+# -*- Python -*-
+
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+
+formulation = pylith.problems.Explicit
+formulation.solver = pylith.problems.SolverNonlinear
+#formulation = pylith.problems.ExplicitLumped
+
+# Nondimensionalize problem using wave propagation parameters.
+normalizer = spatialdata.units.NondimElasticDynamic
+#normalizer.mass_density = 1000.0*kg/m**3
+#normalizer.shear_wave_speed = 1.0*m/s
+#normalizer.wave_period = 1.0*s
+
+bc = [x_pos,x_neg,all_nofault]
+
+# Change the DirichletPoints BC to the AbsorbingDampers BC
+bc.x_pos = pylith.bc.AbsorbingDampers
+bc.x_neg = pylith.bc.AbsorbingDampers
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 12.0*s
+dt = 0.05*s
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.bc.x_pos]
+# Absorbing BC on +x face of bar
+
+# Nodeset id from CUBIT
+label = 11
+
+# Specify label and filename for spatial database with physical properties
+db.label = Absorbing BC +x
+db.iohandler.filename = matprops.spatialdb
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+[pylithapp.timedependent.bc.x_neg]
+# Absorbing BC on -x face of bar
+
+# Nodeset id from CUBIT
+label = 12
+
+# Specify label and filename for spatial database with physical properties
+db.label = Absorbing BC -x
+db.iohandler.filename = matprops.spatialdb
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+[pylithapp.timedependent.bc.all_nofault]
+# Dirichlet BC on all vertices except fault vertices
+
+# Pin x and z degrees of freedom
+bc_dof = [0]
+
+# Nodeset id from CUBIT
+label = 13
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+
+# Provide information on the fault (interface).
+[pylithapp.timedependent.interfaces]
+
+fault = pylith.faults.FaultCohesiveDyn
+
+[pylithapp.timedependent.interfaces.fault]
+
+# Material id
+id = 100
+
+# Nodeset id from CUBIT
+label = 10
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+db_initial_tractions = spatialdata.spatialdb.UniformDB
+db_initial_tractions.label = Initial fault tractions
+db_initial_tractions.values = [traction-shear,traction-normal]
+db_initial_tractions.data = [-6.1*MPa, -10.0*MPa]
+
+friction = pylith.friction.StaticFriction
+
+friction.db_properties = spatialdata.spatialdb.UniformDB
+friction.db_properties.label = Static friction
+friction.db_properties.values = [friction-coefficient,cohesion]
+friction.db_properties.data = [0.6,0.0*Pa]
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output]
+vertex_data_fields = [displacement,velocity]
+writer.filename = output/shearwave.vtk
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+vertex_data_fields = [slip,slip_rate,traction]
+writer.filename = output/shearwave-fault.vtk
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.elastic.output]
+writer.filename = output/shearwave-statevars.vtk

Copied: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematic_risetime.spatialdb (from rev 16703, short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_risetime.spatialdb)
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematic_risetime.spatialdb	                        (rev 0)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematic_risetime.spatialdb	2010-05-14 19:50:59 UTC (rev 16705)
@@ -0,0 +1,25 @@
+#SPATIAL.ascii 1
+SimpleDB {
+  // number of values for rise time
+  num-values = 1
+
+  // Name and units for rise time
+  value-names =  rise-time
+  value-units =  s
+
+  // Number of locations where physical properties are given
+  // 1 location -> data is uniform -> data dimension is 0
+  num-locs = 1
+  data-dim = 0
+
+  // Problem is in 2-D
+  space-dim = 2
+
+  // Coordinate system (2-D with coordinates in meters)
+  cs-data = cartesian {
+    to-meters = 1.0
+    space-dim = 2
+  }
+}
+// Columns are x, y, rise-time
+0.0  0.0    2.0

Copied: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematic_slip.spatialdb (from rev 16703, short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_slip.spatialdb)
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematic_slip.spatialdb	                        (rev 0)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematic_slip.spatialdb	2010-05-14 19:50:59 UTC (rev 16705)
@@ -0,0 +1,25 @@
+#SPATIAL.ascii 1
+SimpleDB {
+  // number of values for final slip
+  num-values = 2
+
+  // Names and units of final slip values
+  value-names =  left-lateral-slip  fault-opening
+  value-units =  m  m
+
+  // Number of locations where physical properties are given
+  // 1 location -> data is uniform -> data dimension is 0
+  num-locs = 1
+  data-dim = 0
+
+  // Problem is in 2-D
+  space-dim = 2
+
+  // Coordinate system (2-D with coordinates in meters)
+  cs-data = cartesian {
+    to-meters = 1.0
+    space-dim = 2
+  }
+}
+// Columns are x, y, left-lateral-slip, fault-opening
+0.0  0.0   1.0  0.0

Copied: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematic_sliptime.spatialdb (from rev 16703, short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_sliptime.spatialdb)
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematic_sliptime.spatialdb	                        (rev 0)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematic_sliptime.spatialdb	2010-05-14 19:50:59 UTC (rev 16705)
@@ -0,0 +1,25 @@
+#SPATIAL.ascii 1
+SimpleDB {
+  // number of values for slip initiation time
+  num-values = 1
+
+  // Names and units of slip initiation time
+  value-names =  slip-time
+  value-units =  s
+
+  // Number of locations where physical properties are given
+  // 1 location -> data is uniform -> data dimension is 0
+  num-locs = 1
+  data-dim = 0
+
+  // Problem is in 2-D
+  space-dim = 2
+
+  // Coordinate system (2-D with coordinates in meters)
+  cs-data = cartesian {
+    to-meters = 1.0
+    space-dim = 2
+  }
+}
+// Columns are x, y, slip-time
+0.0 0.0   0.1

Added: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematicfault.cfg
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematicfault.cfg	                        (rev 0)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/kinematicfault.cfg	2010-05-14 19:50:59 UTC (rev 16705)
@@ -0,0 +1,223 @@
+# -*- Python -*-
+
+# These settings define an explicit time-stepping problem using a fault with
+# kinematically-specified slip.
+
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# journal
+# ----------------------------------------------------------------------
+[pylithapp.journal.info]
+timedependent = 1
+#explicit = 1
+#petsc = 1
+meshiocubit = 1
+#explicitelasticity = 1
+#quadrature2d = 1
+#fiatlagrange = 1
+#faultcohesivekin = 1
+
+[pylithapp.journal.debug]
+pylithapp = 1
+problem = 1
+explicit = 1
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+[pylithapp.mesh_generator]
+#debug = 1
+reader = pylith.meshio.MeshIOCubit
+
+[pylithapp.mesh_generator.reader]
+filename = bar_quad4_200m.exo
+coordsys.space_dim = 2
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+dimension = 2
+
+# Change to an explicit time stepping formulation
+#formulation = pylith.problems.Explicit
+formulation = pylith.problems.ExplicitLumped
+
+# Nondimensionalize problem using wave propagation parameters.
+normalizer = spatialdata.units.NondimElasticDynamic
+
+# Set bc to an array with 3 boundary conditions: 'x_neg', 'x_pos', and 'all_nofault'.
+bc = [x_pos,x_neg,all_nofault]
+
+# Change the DirichletPoints BC to the AbsorbingDampers BC
+bc.x_pos = pylith.bc.AbsorbingDampers
+bc.x_neg = pylith.bc.AbsorbingDampers
+
+# Set interfaces to an array with 1 fault: 'fault'.
+interfaces = [fault]
+
+# Set materials to an array with 1 material 'elastic'.
+materials = [elastic]
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 12.0*s
+dt = 0.05*s
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.materials]
+elastic = pylith.materials.ElasticPlaneStrain
+
+[pylithapp.timedependent.materials.elastic]
+
+# Label for material
+label = Elastic material
+
+# Nodeset id from CUBIT
+id = 1
+
+# Spatial database with physical properties for elastic material
+db_properties.iohandler.filename = matprops.spatialdb
+
+# Set the basis functions and quadrature:
+# 2-D Lagrange cell with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 2
+quadrature.cell.quad_order = 2
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.bc.x_pos]
+# Absorbing boundary condition on +x face of bar
+
+# Nodeset id from CUBIT
+label = 11
+
+# Specify label and filename for spatial database with physical properties
+db.label = Absorbing BC +x
+db.iohandler.filename = matprops.spatialdb
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+[pylithapp.timedependent.bc.x_neg]
+# Absorbing boundary condition on -x face of bar
+
+# Nodeset id from CUBIT
+label = 12
+
+# Specify label and filename for spatial database with physical properties
+db.label = Absorbing BC -x
+db.iohandler.filename = matprops.spatialdb
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+[pylithapp.timedependent.bc.all_nofault]
+# Dirichlet boundary condition on all vertices except fault vertices
+
+# Pin x and z degrees of freedom
+bc_dof = [0]
+
+# Nodeset id from CUBIT
+label = 13
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+# NOTE: It is possible to assign an ID number to a fault (e.g.,
+# 'id = 10').  Care must be taken when doing this, however, because the
+# assigned ID will become the material ID for the cohesive element.
+# This ID must not conflict with any of the material ID numbers for
+# volume elements.  The default ID for a fault is 100.  If you have a
+# fault in your mesh you must:
+# 1.  If you create your own fault ID, make sure it does not conflict
+#     with any of you material ID's.
+# 2.  If you use the default fault ID, make sure that none of your
+#     material ID's are equal to 100.
+
+[pylithapp.timedependent.interfaces.fault]
+
+# Material id
+id = 100
+
+# Nodeset id from CUBIT
+label = 10
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+# Switch to Brune slip time function
+eq_srcs.rupture.slip_function = pylith.faults.BruneSlipFn
+
+[pylithapp.timedependent.interfaces.fault.eq_srcs.rupture.slip_function]
+
+# Database specifying the final slip.
+slip.iohandler.filename = shearwave_slip.spatialdb
+
+# Database specifying rise_time.
+rise_time.iohandler.filename = shearwave_risetime.spatialdb
+
+# Database specifying time at which slip begins at each point.
+slip_time.iohandler.filename = shearwave_sliptime.spatialdb
+
+# ----------------------------------------------------------------------
+# PETSc
+# ----------------------------------------------------------------------
+[pylithapp.petsc]
+ksp_type = gmres
+pc_type = asm
+
+# Change the preconditioner settings.
+sub_pc_factor_shift_type = nonzero
+
+ksp_rtol = 1.0e-8
+ksp_atol = 1.0e-12
+ksp_max_it = 50
+ksp_gmres_restart = 75
+
+ksp_monitor = true
+ksp_view = true
+#log_summary = true
+
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# We set three output manager parameters for each type of output.
+#   skip - Number of time steps to skip between output
+#   writer.filename - Root name for VTK file
+#   writer.time_format - Format of time stamp (decimal point is removed)
+
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output]
+skip = 3
+writer.filename = output/shearwave.vtk
+writer.time_format = %05.2f
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+skip = 3
+writer.filename = output/shearwave-fault.vtk
+writer.time_format = %05.2f
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.elastic.output]
+skip = 33
+writer.filename = output/shearwave-statevars.vtk
+writer.time_format = %05.2f
+
+# Averate state variables over cell
+cell_filter = pylith.meshio.CellFilterAvgMesh

Added: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave-ratestateageing.cfg
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave-ratestateageing.cfg	                        (rev 0)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave-ratestateageing.cfg	2010-05-14 19:50:59 UTC (rev 16705)
@@ -0,0 +1,127 @@
+# -*- Python -*-
+
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+
+formulation = pylith.problems.Explicit
+formulation.solver = pylith.problems.SolverNonlinear
+#formulation = pylith.problems.ExplicitLumped
+
+# Nondimensionalize problem using wave propagation parameters.
+normalizer = spatialdata.units.NondimElasticDynamic
+#normalizer.mass_density = 1000.0*kg/m**3
+#normalizer.shear_wave_speed = 1.0*m/s
+#normalizer.wave_period = 1.0*s
+
+bc = [x_pos,x_neg,all_nofault]
+
+# Change the DirichletPoints BC to the AbsorbingDampers BC
+bc.x_pos = pylith.bc.AbsorbingDampers
+bc.x_neg = pylith.bc.AbsorbingDampers
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 12.0*s
+dt = 0.05*s
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.bc.x_pos]
+# Absorbing BC on +x face of bar
+
+# Nodeset id from CUBIT
+label = 11
+
+# Specify label and filename for spatial database with physical properties
+db.label = Absorbing BC +x
+db.iohandler.filename = matprops.spatialdb
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+[pylithapp.timedependent.bc.x_neg]
+# Absorbing BC on -x face of bar
+
+# Nodeset id from CUBIT
+label = 12
+
+# Specify label and filename for spatial database with physical properties
+db.label = Absorbing BC -x
+db.iohandler.filename = matprops.spatialdb
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+[pylithapp.timedependent.bc.all_nofault]
+# Dirichlet BC on all vertices except fault vertices
+
+# Pin x and z degrees of freedom
+bc_dof = [0]
+
+# Nodeset id from CUBIT
+label = 13
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+
+# Provide information on the fault (interface).
+[pylithapp.timedependent.interfaces]
+
+fault = pylith.faults.FaultCohesiveDyn
+
+[pylithapp.timedependent.interfaces.fault]
+
+# Material id
+id = 100
+
+# Nodeset id from CUBIT
+label = 10
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+db_initial_tractions = spatialdata.spatialdb.UniformDB
+db_initial_tractions.label = Initial fault tractions
+db_initial_tractions.values = [traction-shear,traction-normal]
+db_initial_tractions.data = [-6.1*MPa, -10.0*MPa]
+
+friction = pylith.friction.RateStateAgeing
+
+friction.db_properties = spatialdata.spatialdb.UniformDB
+friction.db_properties.label = Rate State Ageing
+friction.db_properties.values = [reference-friction-coefficient,reference-slip-rate,characteristic-slip-distance,constitutive-parameter-a,constitutive-parameter-b,cohesion]
+friction.db_properties.data = [0.6,0.000001*m/s,0.0370*m,0.0125,0.0172,0.0*Pa]
+
+friction.db_initial_state = spatialdata.spatialdb.UniformDB
+friction.db_initial_state.label = Rate State Ageing State
+friction.db_initial_state.values = [state-variable]
+friction.db_initial_state.data = [92.7*s]
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output]
+writer.filename = output/shearwave-ratestateageing.vtk
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+writer.filename = output/shearwave-ratestateageing-fault.vtk
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.elastic.output]
+writer.filename = output/shearwave-ratestateageing-statevars.vtk

Added: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave-slipweakening.cfg
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave-slipweakening.cfg	                        (rev 0)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave-slipweakening.cfg	2010-05-14 19:50:59 UTC (rev 16705)
@@ -0,0 +1,124 @@
+# -*- Python -*-
+
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+
+formulation = pylith.problems.Explicit
+formulation.solver = pylith.problems.SolverNonlinear
+#formulation = pylith.problems.ExplicitLumped
+
+# Nondimensionalize problem using wave propagation parameters.
+normalizer = spatialdata.units.NondimElasticDynamic
+#normalizer.mass_density = 1000.0*kg/m**3
+#normalizer.shear_wave_speed = 1.0*m/s
+#normalizer.wave_period = 1.0*s
+
+bc = [x_pos,x_neg,all_nofault]
+
+# Change the DirichletPoints BC to the AbsorbingDampers BC
+bc.x_pos = pylith.bc.AbsorbingDampers
+bc.x_neg = pylith.bc.AbsorbingDampers
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 1.0*s
+dt = 0.05*s
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.bc.x_pos]
+# Absorbing BC on +x face of bar
+
+# Nodeset id from CUBIT
+label = 11
+
+# Specify label and filename for spatial database with physical properties
+db.label = Absorbing BC +x
+db.iohandler.filename = matprops.spatialdb
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+[pylithapp.timedependent.bc.x_neg]
+# Absorbing BC on -x face of bar
+
+# Nodeset id from CUBIT
+label = 12
+
+# Specify label and filename for spatial database with physical properties
+db.label = Absorbing BC -x
+db.iohandler.filename = matprops.spatialdb
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+[pylithapp.timedependent.bc.all_nofault]
+# Dirichlet BC on all vertices except fault vertices
+
+# Pin x and z degrees of freedom
+bc_dof = [0]
+
+# Nodeset id from CUBIT
+label = 13
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+
+# Provide information on the fault (interface).
+[pylithapp.timedependent.interfaces]
+
+fault = pylith.faults.FaultCohesiveDyn
+
+[pylithapp.timedependent.interfaces.fault]
+
+# Material id
+id = 100
+
+# Nodeset id from CUBIT
+label = 10
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+db_initial_tractions = spatialdata.spatialdb.UniformDB
+db_initial_tractions.label = Initial fault tractions
+db_initial_tractions.values = [traction-shear,traction-normal]
+db_initial_tractions.data = [-6.1*MPa, -10.0*MPa]
+
+friction = pylith.friction.SlipWeakening
+
+friction.db_properties = spatialdata.spatialdb.UniformDB
+friction.db_properties.label = Slip weakening
+friction.db_properties.values = [static-coefficient,dynamic-coefficient,slip-weakening-parameter,cohesion]
+friction.db_properties.data = [0.6,0.5,0.2*m,0.0*Pa]
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output]
+writer.filename = output/shearwave-slipweakening.vtk
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+vertex_info_fields = [strike_dir,normal_dir,initial_traction,static_coefficient,dynamic_coefficient,slip_weakening_parameter,cohesion]
+vertex_data_fields = [slip,traction,cumulative_slip,previous_slip]
+writer.filename = output/shearwave-slipweakening-fault.vtk
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.elastic.output]
+writer.filename = output/shearwave-slipweakening-statevars.vtk

Deleted: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_risetime.spatialdb
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_risetime.spatialdb	2010-05-14 16:34:00 UTC (rev 16704)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_risetime.spatialdb	2010-05-14 19:50:59 UTC (rev 16705)
@@ -1,25 +0,0 @@
-#SPATIAL.ascii 1
-SimpleDB {
-  // number of values for rise time
-  num-values = 1
-
-  // Name and units for rise time
-  value-names =  rise-time
-  value-units =  s
-
-  // Number of locations where physical properties are given
-  // 1 location -> data is uniform -> data dimension is 0
-  num-locs = 1
-  data-dim = 0
-
-  // Problem is in 2-D
-  space-dim = 2
-
-  // Coordinate system (2-D with coordinates in meters)
-  cs-data = cartesian {
-    to-meters = 1.0
-    space-dim = 2
-  }
-}
-// Columns are x, y, rise-time
-0.0  0.0    2.0

Deleted: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_slip.spatialdb
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_slip.spatialdb	2010-05-14 16:34:00 UTC (rev 16704)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_slip.spatialdb	2010-05-14 19:50:59 UTC (rev 16705)
@@ -1,25 +0,0 @@
-#SPATIAL.ascii 1
-SimpleDB {
-  // number of values for final slip
-  num-values = 2
-
-  // Names and units of final slip values
-  value-names =  left-lateral-slip  fault-opening
-  value-units =  m  m
-
-  // Number of locations where physical properties are given
-  // 1 location -> data is uniform -> data dimension is 0
-  num-locs = 1
-  data-dim = 0
-
-  // Problem is in 2-D
-  space-dim = 2
-
-  // Coordinate system (2-D with coordinates in meters)
-  cs-data = cartesian {
-    to-meters = 1.0
-    space-dim = 2
-  }
-}
-// Columns are x, y, left-lateral-slip, fault-opening
-0.0  0.0   1.0  0.0

Deleted: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_sliptime.spatialdb
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_sliptime.spatialdb	2010-05-14 16:34:00 UTC (rev 16704)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/shearwave_sliptime.spatialdb	2010-05-14 19:50:59 UTC (rev 16705)
@@ -1,25 +0,0 @@
-#SPATIAL.ascii 1
-SimpleDB {
-  // number of values for slip initiation time
-  num-values = 1
-
-  // Names and units of slip initiation time
-  value-names =  slip-time
-  value-units =  s
-
-  // Number of locations where physical properties are given
-  // 1 location -> data is uniform -> data dimension is 0
-  num-locs = 1
-  data-dim = 0
-
-  // Problem is in 2-D
-  space-dim = 2
-
-  // Coordinate system (2-D with coordinates in meters)
-  cs-data = cartesian {
-    to-meters = 1.0
-    space-dim = 2
-  }
-}
-// Columns are x, y, slip-time
-0.0 0.0   0.1

Added: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/static-sliding.cfg
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/static-sliding.cfg	                        (rev 0)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/static-sliding.cfg	2010-05-14 19:50:59 UTC (rev 16705)
@@ -0,0 +1,99 @@
+# -*- Python -*-
+
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+
+# Change to an explicit time stepping formulation
+formulation = pylith.problems.Implicit
+formulation.solver = pylith.problems.SolverNonlinear
+
+# Set bc to an array with 3 boundary conditions: 'x_neg', 'x_pos', and 'y_pos'.
+bc = [x_pos,x_neg,all_nofault]
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.bc.x_pos]
+# Dirichlet BC on +x face of bar
+
+# Nodeset id from CUBIT
+label = 11
+
+bc_dof = [1]
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Dirichlet BC +x edge
+db_initial.values = [displacement-x,displacement-y]
+db_initial.data = [0.0*m,32.0*km]
+
+
+[pylithapp.timedependent.bc.x_neg]
+# Dirichlet BC on -x face of bar
+
+# Nodeset id from CUBIT
+label = 12
+
+bc_dof = [1]
+
+[pylithapp.timedependent.bc.all_nofault]
+# Dirichlet BC on all vertices except fault vertices
+
+# Pin x and z degrees of freedom
+bc_dof = [0]
+
+# Nodeset id from CUBIT
+label = 13
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+
+# Provide information on the fault (interface).
+[pylithapp.timedependent.interfaces]
+
+fault = pylith.faults.FaultCohesiveDyn
+
+[pylithapp.timedependent.interfaces.fault]
+
+# Material id
+id = 100
+
+# Nodeset id from CUBIT
+label = 10
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+db_initial_tractions = spatialdata.spatialdb.UniformDB
+db_initial_tractions.label = Initial fault tractions
+db_initial_tractions.values = [traction-shear,traction-normal]
+db_initial_tractions.data = [0.0*MPa, -10000.0*MPa]
+
+friction = pylith.friction.StaticFriction
+
+friction.db_properties = spatialdata.spatialdb.UniformDB
+friction.db_properties.label = Static friction
+friction.db_properties.values = [friction-coefficient,cohesion]
+friction.db_properties.data = [0.6*m,0.0*Pa]
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output]
+writer.filename = output/shear-sliding.vtk
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+writer.filename = output/shear-sliding-fault.vtk
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.elastic.output]
+writer.filename = output/shear-sliding-statevars.vtk

Added: short/3D/PyLith/trunk/examples/bar_shearwave/quad4/static-stick.cfg
===================================================================
--- short/3D/PyLith/trunk/examples/bar_shearwave/quad4/static-stick.cfg	                        (rev 0)
+++ short/3D/PyLith/trunk/examples/bar_shearwave/quad4/static-stick.cfg	2010-05-14 19:50:59 UTC (rev 16705)
@@ -0,0 +1,99 @@
+# -*- Python -*-
+
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+
+# Change to an explicit time stepping formulation
+formulation = pylith.problems.Implicit
+formulation.solver = pylith.problems.SolverNonlinear
+
+# Set bc to an array with 3 boundary conditions: 'x_neg', 'x_pos', and 'y_pos'.
+bc = [x_pos,x_neg,all_nofault]
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.bc.x_pos]
+# Dirichlet BC on +x face of bar
+
+# Nodeset id from CUBIT
+label = 11
+
+bc_dof = [1]
+db_initial = spatialdata.spatialdb.UniformDB
+db_initial.label = Dirichlet BC +x edge
+db_initial.values = [displacement-x,displacement-y]
+db_initial.data = [0.0*m,10.0*km]
+
+
+[pylithapp.timedependent.bc.x_neg]
+# Dirichlet BC on -x face of bar
+
+# Nodeset id from CUBIT
+label = 12
+
+bc_dof = [1]
+
+[pylithapp.timedependent.bc.all_nofault]
+# Dirichlet BC on all vertices except fault vertices
+
+# Pin x and z degrees of freedom
+bc_dof = [0]
+
+# Nodeset id from CUBIT
+label = 13
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+
+# Provide information on the fault (interface).
+[pylithapp.timedependent.interfaces]
+
+fault = pylith.faults.FaultCohesiveDyn
+
+[pylithapp.timedependent.interfaces.fault]
+
+# Material id
+id = 100
+
+# Nodeset id from CUBIT
+label = 10
+
+# Specify the basis functions and quadrature:
+# 1-D Lagrange cell in 2-D space with 2nd order quadrature
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+db_initial_tractions = spatialdata.spatialdb.UniformDB
+db_initial_tractions.label = Initial fault tractions
+db_initial_tractions.values = [traction-shear,traction-normal]
+db_initial_tractions.data = [0.0*MPa, -10000.0*MPa]
+
+friction = pylith.friction.StaticFriction
+
+friction.db_properties = spatialdata.spatialdb.UniformDB
+friction.db_properties.label = Static friction
+friction.db_properties.values = [friction-coefficient,cohesion]
+friction.db_properties.data = [0.6*m,0.0*Pa]
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output]
+writer.filename = output/shear-stick.vtk
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+writer.filename = output/shear-stick-fault.vtk
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.elastic.output]
+writer.filename = output/shear-stick-statevars.vtk



More information about the CIG-COMMITS mailing list