[cig-commits] r16669 - in short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup: . tpv10-2d tpv205

surendra at geodynamics.org surendra at geodynamics.org
Sat May 8 16:35:19 PDT 2010


Author: surendra
Date: 2010-05-08 16:35:19 -0700 (Sat, 08 May 2010)
New Revision: 16669

Added:
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/createbc.jou
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/extractdata.py
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/friction.spatialdb
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/geometry.jou
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/matprops.spatialdb
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/output/
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/pylithapp.cfg
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/quad4_100m.cfg
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/quad4_100m.exo.gz
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/quad4_100m.jou
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tractions.spatialdb
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tri3_100m.cfg
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tri3_100m.exo.gz
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tri3_100m.jou
Modified:
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv205/test.cfg
   short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv205/test.jou
Log:
Added tpv10-2d files. det(J)=0 error appears when I try to run it

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/createbc.jou
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/createbc.jou	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/createbc.jou	2010-05-08 23:35:19 UTC (rev 16669)
@@ -0,0 +1,42 @@
+# ----------------------------------------------------------------------
+# Create blocks for materials
+# ----------------------------------------------------------------------
+block 1 surface 18 19
+block 1 name "elastic"
+
+# ----------------------------------------------------------------------
+# Create nodeset for fault
+# ----------------------------------------------------------------------
+group "fault" add node in curve 33
+group "fault" remove node with x_coord < -7.5001e+3
+nodeset 10 group fault
+nodeset 10 name "fault"
+
+# ----------------------------------------------------------------------
+# Create nodeset for +x face
+# ----------------------------------------------------------------------
+group "face_xpos" add node in curve 40
+nodeset 11 group face_xpos
+nodeset 11 name "face xpos"
+
+# ----------------------------------------------------------------------
+# Create nodeset for -x face
+# ----------------------------------------------------------------------
+group "face_xneg" add node in curve 35
+nodeset 12 group face_xneg
+nodeset 12 name "face xneg"
+
+# ----------------------------------------------------------------------
+# Create nodeset for +z face
+# ----------------------------------------------------------------------
+group "face_zpos" add node in curve 34
+group "face_zpos" add node in curve 39
+nodeset 13 group face_zpos
+nodeset 13 name "face zpos"
+
+# ----------------------------------------------------------------------
+# Create nodeset for -z face
+# ----------------------------------------------------------------------
+group "face_zneg" add node in curve 36
+nodeset 14 group face_zneg
+nodeset 14 name "face zneg"

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/extractdata.py
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/extractdata.py	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/extractdata.py	2010-05-08 23:35:19 UTC (rev 16669)
@@ -0,0 +1,108 @@
+outputRoot = "output/quad4_200m"
+
+import numpy
+
+from pylith.utils.VTKDataReader import VTKDataReader
+from numpy import *
+
+# ----------------------------------------------------------------------
+def feq(a,b):
+    if numpy.abs(a-b)<0.0001:
+        return 1
+    else:
+        return 0
+
+# ----------------------------------------------------------------------
+# Extract On Fault stations data ( Slip, Slip Rate, Tractions )
+# ----------------------------------------------------------------------
+nfileNames = numpy.arange(1,1201,5)
+filename = "%s-fault_t%04d.vtk" % (outputRoot,nfileNames[0])
+fieldNames = ["slip","slip_rate","traction"]
+reader = VTKDataReader()
+data = reader.read(filename)
+values = numpy.array(data['vertices'])
+(nvertices, spaceDim) = values.shape
+
+x_OnFltStat = numpy.array([0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0])
+y_OnFltStat = numpy.array([-12000.0, -7600.0, -4400.0, 0.0, 4400.0, 7600.0, 12000.0]) # CHECK THESE VALUES
+Index_OnFltStat = numpy.zeros(7)
+
+# Find the indices of On Fault Stations
+nFltStat = -1
+for i in xrange(nvertices):
+    if feq(values[i,1],y_OnFltStat[0]) or \
+       feq(values[i,1],y_OnFltStat[1]) or \
+       feq(values[i,1],y_OnFltStat[2]) or \
+       feq(values[i,1],y_OnFltStat[3]) or \
+       feq(values[i,1],y_OnFltStat[4]) or \
+       feq(values[i,1],y_OnFltStat[5]) or \
+       feq(values[i,1],y_OnFltStat[6]):
+        nFltStat += 1
+        Index_OnFltStat[nFltStat] = i
+
+Index_OnFltStat = numpy.int_(Index_OnFltStat)
+print "On-Fault indices", Index_OnFltStat
+
+# Extract values
+slip = numpy.zeros((240,7,3))  # 3-D array (ntime, nstats, ncomponents)
+slip_rate = numpy.zeros((240,7,3))
+traction = numpy.zeros((240,7,3))
+nFile = -1
+for i in nfileNames:
+    nFile += 1
+    filename = "%s-fault_t%04d.vtk" % (outputRoot,i)
+    data = reader.read(filename)
+    nField = 0
+    for name in fieldNames:
+        nField += 1
+        values = data['vertex_fields'][name]
+        if nField == 1:
+            slip[nFile,:,:] = values[Index_OnFltStat,:]
+#        elif nField == 2:
+#            slip_rate[nFile,:,:] = values[Index_OnFltStat,:]
+        elif nField == 3:
+            traction[nFile,:,:] = values[Index_OnFltStat,:]
+
+
+# ----------------------------------------------------------------------
+# Extract Off Fault stations data ( Displacements and Velocities )
+# ----------------------------------------------------------------------
+nfileNames = numpy.arange(1,1201,5)
+filename = "%s_t%04d.vtk" % (outputRoot,nfileNames[0])
+fieldNames = ["displacement","velocity"]
+reader = VTKDataReader()
+data = reader.read(filename)
+values = numpy.array(data['vertices'])
+(nvertices, spaceDim) = values.shape
+
+x_OffFltStat = numpy.array([3000.0, 3000.0])
+y_OffFltStat = numpy.array([-12000.0, 12000.0]) # CHECK THESE VALUES
+Index_OffFltStat = numpy.zeros(2)
+
+# Find the indices of On Fault Stations
+nFltStat = -1
+for i in xrange(nvertices):
+    if (feq(values[i,0],x_OffFltStat[0]) and feq(values[i,1],y_OffFltStat[0])) or \
+       (feq(values[i,0],x_OffFltStat[1]) and feq(values[i,1],y_OffFltStat[1])):
+        nFltStat += 1
+        Index_OffFltStat[nFltStat] = i
+
+Index_OffFltStat = numpy.int_(Index_OffFltStat)
+print "Off-fault indices", Index_OffFltStat
+
+# Extract values
+disp = numpy.zeros((240,2,3))  # 3-D array (ntime, nstats, ncomponents)
+vel = numpy.zeros((240,2,3))
+nFile = -1
+for i in nfileNames:
+    nFile += 1
+    filename = "%s_t%04d.vtk" % (outputRoot,i)
+    data = reader.read(filename)
+    nField = 0
+    for name in fieldNames:
+        nField += 1
+        values = data['vertex_fields'][name]
+        if nField == 1:
+            disp[nFile,:,:] = values[Index_OffFltStat,:]
+        elif nField == 2:
+            vel[nFile,:,:] = values[Index_OffFltStat,:]

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/friction.spatialdb
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/friction.spatialdb	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/friction.spatialdb	2010-05-08 23:35:19 UTC (rev 16669)
@@ -0,0 +1,16 @@
+#SPATIAL.ascii 1
+SimpleDB {
+  num-values = 4
+  value-names = static-coefficient dynamic-coefficient slip-weakening-parameter cohesion
+  value-units =  none none m MPa
+  num-locs = 2  
+  data-dim = 2
+  space-dim = 2
+  cs-data = cartesian {
+    to-meters = 1.0e+3  // x, y are in km
+    space-dim = 2
+  }
+}
+-7.4999	0.0	0.760	0.448	0.5	0.2
+-7.5001	0.0	10000.0	0.448	0.5	1000.0
+

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/geometry.jou
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/geometry.jou	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/geometry.jou	2010-05-08 23:35:19 UTC (rev 16669)
@@ -0,0 +1,44 @@
+# ----------------------------------------------------------------------
+# Create block
+# ----------------------------------------------------------------------
+# Block is 24.0 km x 12.0*sqrt(3) km
+# -12.0 km <= x <= 12.0 km
+# -12*Sqrt(3) km <= y <= 0 km
+#
+# We create the 2-D mesh by extracting the mid-surface from a 3-D mesh.
+reset
+brick x 24000 y 48000 z 20784.610
+
+# ----------------------------------------------------------------------
+# Set z=0 at free surface
+# ----------------------------------------------------------------------
+move volume 1 z -10392.305
+
+# ----------------------------------------------------------------------
+# Create interface surfaces
+# ----------------------------------------------------------------------
+create surface extended from surface 1
+body 2 rotate -60 about y 
+webcut volume 1 with plane surface 7
+
+delete surface 7
+
+# ----------------------------------------------------------------------
+# Extract the mid surfaces for 2-D
+# ----------------------------------------------------------------------
+create midsurface volume 1 surface 10 12
+create midsurface volume 3 surface 14 16
+
+delete volume 1
+delete volume 3
+
+# ----------------------------------------------------------------------
+# Imprint all volumes, merging surfaces
+# ----------------------------------------------------------------------
+imprint all
+merge all
+
+
+
+
+

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/matprops.spatialdb
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/matprops.spatialdb	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/matprops.spatialdb	2010-05-08 23:35:19 UTC (rev 16669)
@@ -0,0 +1,25 @@
+#SPATIAL.ascii 1
+SimpleDB {
+  // number of physical properties
+  num-values = 3
+
+  // Names and units of physical properties
+  value-names =  density vs vp
+  value-units =  kg/m**3  m/s  m/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, density, vs, vp
+0.0  0.0  2700.0	3300.0	 5716.0

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/pylithapp.cfg
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/pylithapp.cfg	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/pylithapp.cfg	2010-05-08 23:35:19 UTC (rev 16669)
@@ -0,0 +1,197 @@
+# -*- Python -*-
+
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# journal
+# ----------------------------------------------------------------------
+[pylithapp.journal.info]
+timedependent = 1
+explicit = 1
+petsc = 1
+meshiocubit = 1
+elasticityexplicit = 1
+meshimporter = 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
+reorder_mesh = True
+
+[pylithapp.mesh_generator.reader]
+coordsys.space_dim = 2
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+
+dimension = 2
+
+# Set interfaces to an array with 1 faults: 'fault'.
+interfaces = [fault]
+
+# Set materials to an array with 1 material 'elastic'.
+materials = [elastic]
+
+#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_neg,x_pos,z_neg,z_pos]
+
+# Change the DirichletPoints BC to the AbsorbingDampers BC
+bc.x_neg = pylith.bc.AbsorbingDampers
+bc.x_pos = pylith.bc.AbsorbingDampers
+bc.z_neg = pylith.bc.AbsorbingDampers
+bc.z_pos = pylith.bc.AbsorbingDampers
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 15.01*s
+dt = 0.01*s
+
+
+# Set subdomain component to OutputSolnSubset (subset of domain).
+#output.subdomain = pylith.meshio.OutputSolnSubset
+
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+
+materials = [elastic]
+materials.elastic = pylith.materials.ElasticPlaneStrain
+
+[pylithapp.timedependent.materials.elastic]
+label = Elastic material
+id = 1
+db_properties.iohandler.filename = matprops.spatialdb
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.bc.x_pos]
+label = 11
+db.label = Absorbing BC +x
+db.iohandler.filename = matprops.spatialdb
+
+[pylithapp.timedependent.bc.x_neg]
+label = 12
+db.label = Absorbing BC -x
+db.iohandler.filename = matprops.spatialdb
+
+[pylithapp.timedependent.bc.z_pos]
+label = 13
+db.label = Absorbing BC +z
+db.iohandler.filename = matprops.spatialdb
+
+[pylithapp.timedependent.bc.z_neg]
+label = 14
+db.label = Absorbing BC -z
+db.iohandler.filename = matprops.spatialdb
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+
+# Provide information on the fault (interface).
+[pylithapp.timedependent.interfaces]
+
+fault = pylith.faults.FaultCohesiveDyn
+
+[pylithapp.timedependent.interfaces.fault]
+
+# Material id
+id = 10
+
+# Nodeset id from CUBIT
+label = 10
+
+db_initial_tractions = spatialdata.spatialdb.SimpleDB
+db_initial_tractions.iohandler.filename = tractions.spatialdb
+db_initial_tractions.label = "Initial fault tractions"
+
+friction = pylith.friction.SlipWeakening
+
+friction.db_properties = spatialdata.spatialdb.SimpleDB
+friction.db_properties.iohandler.filename = friction.spatialdb
+friction.db_properties.label = Slip weakening
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output]
+vertex_data_fields=[displacement,velocity]
+output_freq = time_step
+time_step = 0.04999*s
+writer.time_format = %06.3f
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+vertex_info_fields = [strike_dir,normal_dir,initial_traction]
+vertex_data_fields = [slip,slip_rate,traction]
+output_freq = time_step
+time_step = 0.04999*s
+writer.time_format = %06.3f
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.elastic.output]
+cell_filter = pylith.meshio.CellFilterAvgMesh
+output_freq = time_step
+time_step = 15.0*s
+writer.time_format = %06.3f
+
+# ----------------------------------------------------------------------
+# PETSc
+# ----------------------------------------------------------------------
+[pylithapp.petsc]
+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 = 100
+ksp_gmres_restart = 50
+snes_max_it = 200
+
+ksp_monitor = true
+ksp_view = true
+ksp_converged_reason = true
+
+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
+

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/quad4_100m.cfg
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/quad4_100m.cfg	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/quad4_100m.cfg	2010-05-08 23:35:19 UTC (rev 16669)
@@ -0,0 +1,73 @@
+# -*- Python -*-
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+[pylithapp.mesh_generator.reader]
+filename = quad4_100m.exo
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.formulation.time_step]
+dt = 0.01*s
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.materials.elastic]
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 2
+
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.bc.x_pos]
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+[pylithapp.timedependent.bc.x_neg]
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+[pylithapp.timedependent.bc.z_pos]
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+[pylithapp.timedependent.bc.z_neg]
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 1
+quadrature.cell.quad_order = 2
+
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+
+# Provide information on the fault (interface).
+[pylithapp.timedependent.interfaces.fault]
+# 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
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output]
+writer.filename = output/quad4_100m.vtk
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+writer.filename = output/quad4_100m-fault.vtk
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.elastic.output]
+writer.filename = output/quad4_100m-elastic.vtk

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/quad4_100m.exo.gz
===================================================================
(Binary files differ)


Property changes on: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/quad4_100m.exo.gz
___________________________________________________________________
Name: svn:mime-type
   + application/octet-stream

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/quad4_100m.jou
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/quad4_100m.jou	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/quad4_100m.jou	2010-05-08 23:35:19 UTC (rev 16669)
@@ -0,0 +1,28 @@
+# ----------------------------------------------------------------------
+# Create quad4 mesh at 100m resolution.
+# ----------------------------------------------------------------------
+
+# ----------------------------------------------------------------------
+# Generate geometry
+# ----------------------------------------------------------------------
+playback 'geometry.jou'
+
+# ----------------------------------------------------------------------
+# Set discretization size
+# ----------------------------------------------------------------------
+surface all size 100
+
+# ----------------------------------------------------------------------
+# Generate the mesh
+# ----------------------------------------------------------------------
+mesh surface all
+
+# ----------------------------------------------------------------------
+# Setup boundary conditions.
+# ----------------------------------------------------------------------
+playback 'createbc.jou'
+
+# ----------------------------------------------------------------------
+# Export exodus file
+# ----------------------------------------------------------------------
+export mesh "quad4_100m.exo" dimension 2 overwrite

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tractions.spatialdb
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tractions.spatialdb	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tractions.spatialdb	2010-05-08 23:35:19 UTC (rev 16669)
@@ -0,0 +1,19 @@
+#SPATIAL.ascii 1
+SimpleDB {
+  num-values = 2
+  value-names =  traction-shear traction-normal
+  value-units =  Pa   Pa
+  num-locs = 6 
+  data-dim = 2
+  space-dim = 2
+  cs-data = cartesian {
+    to-meters = 1.0e+3  // x, y are in km
+    space-dim = 2
+  }
+}
+0.0		0.0	0.0		0.0
+-5.2495		0.0	42603.8921	77461.622
+-5.25		0.0	259318.0133	77469.000
+-6.75		0.0	276266.0171	99603.000
+-6.7505		0.0	54785.7079	99610.378
+-7.5		0.0	60868.5		110670.00

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tri3_100m.cfg
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tri3_100m.cfg	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tri3_100m.cfg	2010-05-08 23:35:19 UTC (rev 16669)
@@ -0,0 +1,63 @@
+# -*- Python -*-
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+[pylithapp.mesh_generator.reader]
+filename = tri3_100m.exo
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.formulation.time_step]
+dt = 0.01*s
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.materials.elastic]
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = triangle
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.bc.x_pos]
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = line
+
+[pylithapp.timedependent.bc.x_neg]
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = line
+
+[pylithapp.timedependent.bc.z_pos]
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = line
+
+[pylithapp.timedependent.bc.z_neg]
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = line
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.interfaces.fault]
+# Specify the basis functions and quadrature:
+quadrature.cell = pylith.feassemble.FIATSimplex
+quadrature.cell.shape = line
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output]
+writer.filename = output/tri3_100m.vtk
+
+# Give basename for VTK fault output.
+[pylithapp.timedependent.interfaces.fault.output]
+writer.filename = output/tri3_100m-fault.vtk
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.elastic.output]
+writer.filename = output/tri3_100m-elastic.vtk

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tri3_100m.exo.gz
===================================================================
(Binary files differ)


Property changes on: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tri3_100m.exo.gz
___________________________________________________________________
Name: svn:mime-type
   + application/octet-stream

Added: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tri3_100m.jou
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tri3_100m.jou	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv10-2d/tri3_100m.jou	2010-05-08 23:35:19 UTC (rev 16669)
@@ -0,0 +1,32 @@
+# ----------------------------------------------------------------------
+# Create tri3 mesh at 100m resolution.
+# ----------------------------------------------------------------------
+
+# ----------------------------------------------------------------------
+# Generate geometry
+# ----------------------------------------------------------------------
+playback 'geometry.jou'
+
+# ----------------------------------------------------------------------
+# Set discretization size and scheme
+# ----------------------------------------------------------------------
+surface all size 100
+surface all scheme trimesh 
+
+# ----------------------------------------------------------------------
+# Generate the mesh
+# ----------------------------------------------------------------------
+mesh surface all
+
+# ----------------------------------------------------------------------
+# Setup boundary conditions.
+# ----------------------------------------------------------------------
+playback 'createbc.jou'
+
+# ----------------------------------------------------------------------
+# Export exodus file
+# ----------------------------------------------------------------------
+export mesh "tri3_100m.exo" dimension 2 overwrite
+
+
+

Modified: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv205/test.cfg
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv205/test.cfg	2010-05-08 22:26:30 UTC (rev 16668)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv205/test.cfg	2010-05-08 23:35:19 UTC (rev 16669)
@@ -44,9 +44,9 @@
 # Set materials to an array with 1 material 'elastic'.
 materials = [elastic]
 
-formulation = pylith.problems.Explicit
-formulation.solver = pylith.problems.SolverNonlinear
-#formulation = pylith.problems.ExplicitLumped
+#formulation = pylith.problems.Explicit
+#formulation.solver = pylith.problems.SolverNonlinear
+formulation = pylith.problems.ExplicitLumped
 
 # Nondimensionalize problem using wave propagation parameters.
 normalizer = spatialdata.units.NondimElasticDynamic
@@ -61,8 +61,8 @@
 bc.y_pos = pylith.bc.AbsorbingDampers
 
 [pylithapp.timedependent.formulation.time_step]
-total_time = 0.5*s
-dt = 0.1*s
+total_time = 1.0*s
+dt = 0.01*s
 
 
 # ----------------------------------------------------------------------
@@ -173,11 +173,11 @@
 ksp_gmres_restart = 50
 snes_max_it = 200
 
-ksp_monitor = true
-ksp_view = true
+#ksp_monitor = true
+#ksp_view = true
 ksp_converged_reason = true
 
-snes_monitor = true
+#snes_monitor = true
 snes_view = true
 snes_converged_reason = true
 
@@ -188,8 +188,8 @@
 friction_ksp_max_it = 25
 friction_ksp_gmres_restart = 30
 
-friction_ksp_monitor = true
-friction_ksp_view = true
+#friction_ksp_monitor = true
+#friction_ksp_view = true
 friction_ksp_converged_reason = true
 
 # ----------------------------------------------------------------------
@@ -197,14 +197,23 @@
 # ----------------------------------------------------------------------
 # Give basename for VTK domain output of solution over domain.
 [pylithapp.problem.formulation.output.output]
+output_freq = time_step
+time_step = 0.05*s
 writer.filename = output/test.vtk
+writer.time_format = %05.2f
 
 # Give basename for VTK fault output.
 [pylithapp.timedependent.interfaces.fault.output]
+output_freq = time_step
+time_step = 0.05*s
 vertex_info_fields = [strike_dir,normal_dir,initial_traction]
 writer.filename = output/test-fault.vtk
+writer.time_format = %05.2f
 
 # Give basename for VTK output of state variables.
 [pylithapp.timedependent.materials.elastic.output]
+output_freq = time_step
+time_step = 1.0*s
 cell_filter = pylith.meshio.CellFilterAvgMesh
 writer.filename = output/test-elastic.vtk
+writer.time_format = %05.2f

Modified: short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv205/test.jou
===================================================================
--- short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv205/test.jou	2010-05-08 22:26:30 UTC (rev 16668)
+++ short/3D/PyLith/benchmarks/trunk/dynamic/scecdynrup/tpv205/test.jou	2010-05-08 23:35:19 UTC (rev 16669)
@@ -2,15 +2,15 @@
 # Create block
 # ----------------------------------------------------------------------
 
-# Block is 7 km x 2 km x 6 km
-# -3.5 km <= x <= 3.5 km
+# Block is 8 km x 2 km x 6.5 km
+# -4 km <= x <= 4 km
 # -1 km <= y <= 1 km
-# -6 km <= z <= 0 km
+# -6.5 km <= z <= 0 km
 reset
-brick x 7000 y 2000 z 6000
+brick x 8000 y 2000 z 6500
 
 # Translate block so the top is at z=0
-volume 1 move x 0 y 0 z -3000
+volume 1 move x 0 y 0 z -3250
 
 # ----------------------------------------------------------------------
 # Create interface surfaces
@@ -53,6 +53,9 @@
 # Create nodesets for faults
 # ----------------------------------------------------------------------
 group "fault" add node in surface fault_surface
+group "fault" remove node with x_coord > +3.5001e+3
+group "fault" remove node with x_coord < -3.5001e+3
+group "fault" remove node with z_coord < -6.0001e+3
 nodeset 10 group fault
 nodeset 10 name "fault"
 
@@ -132,3 +135,4 @@
 export mesh "test.exo" dimension 3 overwrite
 
 
+



More information about the CIG-COMMITS mailing list