[cig-commits] r15519 - short/3D/PyLith/trunk/tests/1d/line2

brad at geodynamics.org brad at geodynamics.org
Wed Aug 5 12:07:40 PDT 2009


Author: brad
Date: 2009-08-05 12:07:39 -0700 (Wed, 05 Aug 2009)
New Revision: 15519

Added:
   short/3D/PyLith/trunk/tests/1d/line2/TestExtensionDisp.py
   short/3D/PyLith/trunk/tests/1d/line2/TestExtensionForce.py
   short/3D/PyLith/trunk/tests/1d/line2/extensiondisp.cfg
   short/3D/PyLith/trunk/tests/1d/line2/extensiondisp_disp.spatialdb
   short/3D/PyLith/trunk/tests/1d/line2/extensionforce.cfg
   short/3D/PyLith/trunk/tests/1d/line2/extensionforce_force.spatialdb
Removed:
   short/3D/PyLith/trunk/tests/1d/line2/TestAxial.py
   short/3D/PyLith/trunk/tests/1d/line2/axialextension.cfg
   short/3D/PyLith/trunk/tests/1d/line2/axialextension_disp.spatialdb
Modified:
   short/3D/PyLith/trunk/tests/1d/line2/Makefile.am
   short/3D/PyLith/trunk/tests/1d/line2/README
   short/3D/PyLith/trunk/tests/1d/line2/dislocation.cfg
   short/3D/PyLith/trunk/tests/1d/line2/testpylith.py
Log:
Added extension test with point forces.

Modified: short/3D/PyLith/trunk/tests/1d/line2/Makefile.am
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/Makefile.am	2009-08-05 18:37:59 UTC (rev 15518)
+++ short/3D/PyLith/trunk/tests/1d/line2/Makefile.am	2009-08-05 19:07:39 UTC (rev 15519)
@@ -16,23 +16,29 @@
 
 dist_noinst_PYTHON = \
 	TestLine2.py \
-	TestAxial.py \
+	TestExtensionDisp.py \
+	TestExtensionForce.py \
 	TestDislocation.py \
 	testpylith.py
 
 dist_noinst_DATA = \
 	bar.mesh \
 	matprops.spatialdb \
-	axialextension.cfg \
-	axialextension_disp.spatialdb \
+	extensiondisp.cfg \
+	extensiondisp_disp.spatialdb \
+	extensionforce.cfg \
+	extensionforce_force.spatialdb \
 	dislocation.cfg \
 	finalslip.spatialdb \
 	sliptime.spatialdb
 
 noinst_TMP = \
-	axialextension_t0000000.vtk \
-	axialextension-elastic_info.vtk \
-	axialextension-elastic_t0000000.vtk \
+	extensiondisp_t0000000.vtk \
+	extensiondisp-elastic_info.vtk \
+	extensiondisp-elastic_t0000000.vtk \
+	extensionforce_t0000000.vtk \
+	extensionforce-elastic_info.vtk \
+	extensionforce-elastic_t0000000.vtk \
 	dislocation-fault_info.vtk \
 	dislocation-fault_t0000000.vtk \
 	dislocation-elastic_info.vtk \

Modified: short/3D/PyLith/trunk/tests/1d/line2/README
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/README	2009-08-05 18:37:59 UTC (rev 15518)
+++ short/3D/PyLith/trunk/tests/1d/line2/README	2009-08-05 19:07:39 UTC (rev 15519)
@@ -11,9 +11,9 @@
   4        4.0
 
 
-AXIAL EXTENSION
+AXIAL EXTENSION (displacements)
 
-1-D axial extension.
+1-D axial extension with displacements.
 
 Dirichlet boundary conditions
   u(0) = -0.2
@@ -23,6 +23,17 @@
   u(x) = -0.2 + 0.1 * x
 
 
+AXIAL EXTENSION (point forces)
+
+1-D axial extension with point forces.
+
+Dirichlet boundary conditions
+  u(2) = 0.0
+
+Analytical solution
+  u(x) = 3/7 * (x - 2.0)
+
+
 DISLOCATION
 
 1-D axial extension with dislocation.

Deleted: short/3D/PyLith/trunk/tests/1d/line2/TestAxial.py
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/TestAxial.py	2009-08-05 18:37:59 UTC (rev 15518)
+++ short/3D/PyLith/trunk/tests/1d/line2/TestAxial.py	2009-08-05 19:07:39 UTC (rev 15519)
@@ -1,96 +0,0 @@
-#!/usr/bin/env python
-#
-# ----------------------------------------------------------------------
-#
-#                           Brad T. Aagaard
-#                        U.S. Geological Survey
-#
-# <LicenseText>
-#
-# ----------------------------------------------------------------------
-#
-
-## @file tests/1d/line2/TestAxial.py
-##
-## @brief Test suite for testing pylith with 1-D axial extension.
-
-import numpy
-from TestLine2 import TestLine2
-from pylith.utils.VTKDataReader import has_vtk
-from pylith.utils.VTKDataReader import VTKDataReader
-
-
-# Local version of PyLithApp
-from pylith.apps.PyLithApp import PyLithApp
-class AxialApp(PyLithApp):
-  def __init__(self):
-    PyLithApp.__init__(self, name="axialextension")
-    return
-
-
-# Helper function to run PyLith
-def run_pylith():
-  """
-  Run pylith.
-  """
-  if not "done" in dir(run_pylith):
-    app = AxialApp()
-    app.run()
-    run_pylith.done = True
-  return
-
-
-class TestAxial(TestLine2):
-  """
-  Test suite for testing pylith with 1-D axial extension.
-  """
-
-  def setUp(self):
-    """
-    Setup for test.
-    """
-    TestLine2.setUp(self)
-    run_pylith()
-    self.outputRoot = "axialextension"
-    if has_vtk():
-      self.reader = VTKDataReader()
-    else:
-      self.reader = None
-    return
-
-
-  def calcDisplacements(self, vertices):
-    """
-    Calculate displacement field given coordinates of vertices.
-    """
-    nvertices = self.mesh['nvertices']
-    spaceDim = self.mesh['spaceDim']    
-    disp = numpy.zeros( (nvertices, spaceDim), dtype=numpy.float64)
-    disp[:,0] = -0.2 + 0.1 * vertices[:,0]
-
-    return disp
-
-
-  def calcStateVar(self, name, vertices, cells):
-    """
-    Calculate state variable.
-    """
-    exx = 0.1
-
-    ncells = self.mesh['ncells']
-    tensorSize = self.mesh['tensorSize']
-
-    if name == "total_strain":
-      stateVar = exx*numpy.ones( (ncells, tensorSize), dtype=numpy.float64)
-    
-    elif name == "stress":
-      lp2m = self.density*self.vp**2
-      stateVar = lp2m*exx * numpy.ones( (ncells, tensorSize), 
-                                       dtype=numpy.float64)
-    else:
-      raise ValueError("Unknown state variable '%s'." % name)
-
-    return stateVar
-
-
-# End of file 

Copied: short/3D/PyLith/trunk/tests/1d/line2/TestExtensionDisp.py (from rev 15517, short/3D/PyLith/trunk/tests/1d/line2/TestAxial.py)
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/TestExtensionDisp.py	                        (rev 0)
+++ short/3D/PyLith/trunk/tests/1d/line2/TestExtensionDisp.py	2009-08-05 19:07:39 UTC (rev 15519)
@@ -0,0 +1,96 @@
+#!/usr/bin/env python
+#
+# ----------------------------------------------------------------------
+#
+#                           Brad T. Aagaard
+#                        U.S. Geological Survey
+#
+# <LicenseText>
+#
+# ----------------------------------------------------------------------
+#
+
+## @file tests/1d/line2/TestExtensionDisp.py
+##
+## @brief Test suite for testing pylith with 1-D axial extension.
+
+import numpy
+from TestLine2 import TestLine2
+from pylith.utils.VTKDataReader import has_vtk
+from pylith.utils.VTKDataReader import VTKDataReader
+
+
+# Local version of PyLithApp
+from pylith.apps.PyLithApp import PyLithApp
+class AxialApp(PyLithApp):
+  def __init__(self):
+    PyLithApp.__init__(self, name="extensiondisp")
+    return
+
+
+# Helper function to run PyLith
+def run_pylith():
+  """
+  Run pylith.
+  """
+  if not "done" in dir(run_pylith):
+    app = AxialApp()
+    app.run()
+    run_pylith.done = True
+  return
+
+
+class TestExtensionDisp(TestLine2):
+  """
+  Test suite for testing pylith with 1-D axial extension.
+  """
+
+  def setUp(self):
+    """
+    Setup for test.
+    """
+    TestLine2.setUp(self)
+    run_pylith()
+    self.outputRoot = "extensiondisp"
+    if has_vtk():
+      self.reader = VTKDataReader()
+    else:
+      self.reader = None
+    return
+
+
+  def calcDisplacements(self, vertices):
+    """
+    Calculate displacement field given coordinates of vertices.
+    """
+    nvertices = self.mesh['nvertices']
+    spaceDim = self.mesh['spaceDim']    
+    disp = numpy.zeros( (nvertices, spaceDim), dtype=numpy.float64)
+    disp[:,0] = -0.2 + 0.1 * vertices[:,0]
+
+    return disp
+
+
+  def calcStateVar(self, name, vertices, cells):
+    """
+    Calculate state variable.
+    """
+    exx = 0.1
+
+    ncells = self.mesh['ncells']
+    tensorSize = self.mesh['tensorSize']
+
+    if name == "total_strain":
+      stateVar = exx*numpy.ones( (ncells, tensorSize), dtype=numpy.float64)
+    
+    elif name == "stress":
+      lp2m = self.density*self.vp**2
+      stateVar = lp2m*exx * numpy.ones( (ncells, tensorSize), 
+                                       dtype=numpy.float64)
+    else:
+      raise ValueError("Unknown state variable '%s'." % name)
+
+    return stateVar
+
+
+# End of file 

Added: short/3D/PyLith/trunk/tests/1d/line2/TestExtensionForce.py
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/TestExtensionForce.py	                        (rev 0)
+++ short/3D/PyLith/trunk/tests/1d/line2/TestExtensionForce.py	2009-08-05 19:07:39 UTC (rev 15519)
@@ -0,0 +1,97 @@
+#!/usr/bin/env python
+#
+# ----------------------------------------------------------------------
+#
+#                           Brad T. Aagaard
+#                        U.S. Geological Survey
+#
+# <LicenseText>
+#
+# ----------------------------------------------------------------------
+#
+
+## @file tests/1d/line2/TestExtensionForce.py
+##
+## @brief Test suite for testing pylith with 1-D axial extension using
+## point forces.
+
+import numpy
+from TestLine2 import TestLine2
+from pylith.utils.VTKDataReader import has_vtk
+from pylith.utils.VTKDataReader import VTKDataReader
+
+
+# Local version of PyLithApp
+from pylith.apps.PyLithApp import PyLithApp
+class AxialApp(PyLithApp):
+  def __init__(self):
+    PyLithApp.__init__(self, name="extensionforce")
+    return
+
+
+# Helper function to run PyLith
+def run_pylith():
+  """
+  Run pylith.
+  """
+  if not "done" in dir(run_pylith):
+    app = AxialApp()
+    app.run()
+    run_pylith.done = True
+  return
+
+
+class TestExtensionForce(TestLine2):
+  """
+  Test suite for testing pylith with 1-D axial extension with point forces.
+  """
+
+  def setUp(self):
+    """
+    Setup for test.
+    """
+    TestLine2.setUp(self)
+    run_pylith()
+    self.outputRoot = "extensionforce"
+    if has_vtk():
+      self.reader = VTKDataReader()
+    else:
+      self.reader = None
+    return
+
+
+  def calcDisplacements(self, vertices):
+    """
+    Calculate displacement field given coordinates of vertices.
+    """
+    nvertices = self.mesh['nvertices']
+    spaceDim = self.mesh['spaceDim']    
+    disp = numpy.zeros( (nvertices, spaceDim), dtype=numpy.float64)
+    disp[:,0] = 3.0/7.0 * (-2.0 + vertices[:,0])
+
+    return disp
+
+
+  def calcStateVar(self, name, vertices, cells):
+    """
+    Calculate state variable.
+    """
+    exx = 3.0/7.0
+
+    ncells = self.mesh['ncells']
+    tensorSize = self.mesh['tensorSize']
+
+    if name == "total_strain":
+      stateVar = exx*numpy.ones( (ncells, tensorSize), dtype=numpy.float64)
+    
+    elif name == "stress":
+      lp2m = self.density*self.vp**2
+      stateVar = lp2m*exx * numpy.ones( (ncells, tensorSize), 
+                                       dtype=numpy.float64)
+    else:
+      raise ValueError("Unknown state variable '%s'." % name)
+
+    return stateVar
+
+
+# End of file 

Deleted: short/3D/PyLith/trunk/tests/1d/line2/axialextension.cfg
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/axialextension.cfg	2009-08-05 18:37:59 UTC (rev 15518)
+++ short/3D/PyLith/trunk/tests/1d/line2/axialextension.cfg	2009-08-05 19:07:39 UTC (rev 15519)
@@ -1,93 +0,0 @@
-# -*- Python -*-
-[axialextension]
-
-[axialextension.launcher] # WARNING: THIS IS NOT PORTABLE
-command = mpirun -np ${nodes}
-
-# ----------------------------------------------------------------------
-# journal
-# ----------------------------------------------------------------------
-[axialextension.journal.info]
-#timedependent = 1
-#implicit = 1
-#petsc = 1
-#solverlinear = 1
-#meshioascii = 1
-#implicitelasticity = 1
-#quadrature = 1
-#fiatsimplex = 1
-
-# ----------------------------------------------------------------------
-# mesh_generator
-# ----------------------------------------------------------------------
-[axialextension.mesh_generator]
-#debug = 1
-
-[axialextension.mesh_generator.reader]
-filename = bar.mesh
-coordsys.space_dim = 1
-
-# ----------------------------------------------------------------------
-# problem
-# ----------------------------------------------------------------------
-[axialextension.timedependent]
-dimension = 1
-bc = [bc]
-
-#formulation.solver = pylith.problems.SolverNonlinear
-
-[axialextension.timedependent.formulation.time_step]
-total_time = 0.0*s
-
-# ----------------------------------------------------------------------
-# materials
-# ----------------------------------------------------------------------
-[axialextension.timedependent]
-materials = [elastic]
-materials.elastic = pylith.materials.ElasticStrain1D
-
-[axialextension.timedependent.materials.elastic]
-label = Elastic material
-id = 1
-db_properties.iohandler.filename = matprops.spatialdb
-quadrature.cell.shape = line
-
-# ----------------------------------------------------------------------
-# boundary conditions
-# ----------------------------------------------------------------------
-[axialextension.timedependent.bc.bc]
-bc_dof = [0]
-label = end points
-db_initial = spatialdata.spatialdb.SimpleDB
-db_initial.label = Dirichlet BC
-db_initial.iohandler.filename = axialextension_disp.spatialdb
-
-# ----------------------------------------------------------------------
-# PETSc
-# ----------------------------------------------------------------------
-[axialextension.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_max_it = 100
-ksp_gmres_restart = 50
-#ksp_monitor = true
-#ksp_view = true
-#log_summary = true
-#start_in_debugger = true
-#snes_monitor = true
-#snes_view = true
-
-# ----------------------------------------------------------------------
-# output
-# ----------------------------------------------------------------------
-[axialextension.problem.formulation.output.output.writer]
-filename = axialextension.vtk
-
-[axialextension.timedependent.materials.elastic.output]
-cell_filter = pylith.meshio.CellFilterAvgMesh
-writer.filename = axialextension-elastic.vtk

Deleted: short/3D/PyLith/trunk/tests/1d/line2/axialextension_disp.spatialdb
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/axialextension_disp.spatialdb	2009-08-05 18:37:59 UTC (rev 15518)
+++ short/3D/PyLith/trunk/tests/1d/line2/axialextension_disp.spatialdb	2009-08-05 19:07:39 UTC (rev 15519)
@@ -1,15 +0,0 @@
-#SPATIAL.ascii 1
-SimpleDB {
-  num-values = 1
-  value-names =  displacement-x
-  value-units =  m
-  num-locs = 2
-  data-dim = 1
-  space-dim = 1
-  cs-data = cartesian {
-    to-meters = 1.0
-    space-dim = 1
-  }
-}
-0.0   -0.2
-4.0   +0.2

Modified: short/3D/PyLith/trunk/tests/1d/line2/dislocation.cfg
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/dislocation.cfg	2009-08-05 18:37:59 UTC (rev 15518)
+++ short/3D/PyLith/trunk/tests/1d/line2/dislocation.cfg	2009-08-05 19:07:39 UTC (rev 15519)
@@ -62,7 +62,7 @@
 label = end points
 db_initial = spatialdata.spatialdb.SimpleDB
 db_initial.label = Dirichlet BC
-db_initial.iohandler.filename = axialextension_disp.spatialdb
+db_initial.iohandler.filename = extensiondisp_disp.spatialdb
 
 # ----------------------------------------------------------------------
 # faults

Copied: short/3D/PyLith/trunk/tests/1d/line2/extensiondisp.cfg (from rev 15517, short/3D/PyLith/trunk/tests/1d/line2/axialextension.cfg)
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/extensiondisp.cfg	                        (rev 0)
+++ short/3D/PyLith/trunk/tests/1d/line2/extensiondisp.cfg	2009-08-05 19:07:39 UTC (rev 15519)
@@ -0,0 +1,93 @@
+# -*- Python -*-
+[extensiondisp]
+
+[extensiondisp.launcher] # WARNING: THIS IS NOT PORTABLE
+command = mpirun -np ${nodes}
+
+# ----------------------------------------------------------------------
+# journal
+# ----------------------------------------------------------------------
+[extensiondisp.journal.info]
+#timedependent = 1
+#implicit = 1
+#petsc = 1
+#solverlinear = 1
+#meshioascii = 1
+#implicitelasticity = 1
+#quadrature = 1
+#fiatsimplex = 1
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+[extensiondisp.mesh_generator]
+#debug = 1
+
+[extensiondisp.mesh_generator.reader]
+filename = bar.mesh
+coordsys.space_dim = 1
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[extensiondisp.timedependent]
+dimension = 1
+bc = [bc]
+
+#formulation.solver = pylith.problems.SolverNonlinear
+
+[extensiondisp.timedependent.formulation.time_step]
+total_time = 0.0*s
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[extensiondisp.timedependent]
+materials = [elastic]
+materials.elastic = pylith.materials.ElasticStrain1D
+
+[extensiondisp.timedependent.materials.elastic]
+label = Elastic material
+id = 1
+db_properties.iohandler.filename = matprops.spatialdb
+quadrature.cell.shape = line
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[extensiondisp.timedependent.bc.bc]
+bc_dof = [0]
+label = end points
+db_initial = spatialdata.spatialdb.SimpleDB
+db_initial.label = Dirichlet BC
+db_initial.iohandler.filename = extensiondisp_disp.spatialdb
+
+# ----------------------------------------------------------------------
+# PETSc
+# ----------------------------------------------------------------------
+[extensiondisp.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_max_it = 100
+ksp_gmres_restart = 50
+#ksp_monitor = true
+#ksp_view = true
+#log_summary = true
+#start_in_debugger = true
+#snes_monitor = true
+#snes_view = true
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+[extensiondisp.problem.formulation.output.output.writer]
+filename = extensiondisp.vtk
+
+[extensiondisp.timedependent.materials.elastic.output]
+cell_filter = pylith.meshio.CellFilterAvgMesh
+writer.filename = extensiondisp-elastic.vtk

Copied: short/3D/PyLith/trunk/tests/1d/line2/extensiondisp_disp.spatialdb (from rev 15517, short/3D/PyLith/trunk/tests/1d/line2/axialextension_disp.spatialdb)
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/extensiondisp_disp.spatialdb	                        (rev 0)
+++ short/3D/PyLith/trunk/tests/1d/line2/extensiondisp_disp.spatialdb	2009-08-05 19:07:39 UTC (rev 15519)
@@ -0,0 +1,15 @@
+#SPATIAL.ascii 1
+SimpleDB {
+  num-values = 1
+  value-names =  displacement-x
+  value-units =  m
+  num-locs = 2
+  data-dim = 1
+  space-dim = 1
+  cs-data = cartesian {
+    to-meters = 1.0
+    space-dim = 1
+  }
+}
+0.0   -0.2
+4.0   +0.2

Added: short/3D/PyLith/trunk/tests/1d/line2/extensionforce.cfg
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/extensionforce.cfg	                        (rev 0)
+++ short/3D/PyLith/trunk/tests/1d/line2/extensionforce.cfg	2009-08-05 19:07:39 UTC (rev 15519)
@@ -0,0 +1,97 @@
+# -*- Python -*-
+[extensionforce]
+
+[extensionforce.launcher] # WARNING: THIS IS NOT PORTABLE
+command = mpirun -np ${nodes}
+
+# ----------------------------------------------------------------------
+# journal
+# ----------------------------------------------------------------------
+[extensionforce.journal.info]
+#timedependent = 1
+#implicit = 1
+#petsc = 1
+#solverlinear = 1
+#meshioascii = 1
+#implicitelasticity = 1
+#quadrature = 1
+#fiatsimplex = 1
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+[extensionforce.mesh_generator]
+#debug = 1
+
+[extensionforce.mesh_generator.reader]
+filename = bar.mesh
+coordsys.space_dim = 1
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[extensionforce.timedependent]
+dimension = 1
+bc = [force,fixed]
+bc.force = pylith.bc.PointForce
+
+[extensionforce.timedependent.formulation.time_step]
+total_time = 0.0*s
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[extensionforce.timedependent]
+materials = [elastic]
+materials.elastic = pylith.materials.ElasticStrain1D
+
+[extensionforce.timedependent.materials.elastic]
+label = Elastic material
+id = 1
+db_properties.iohandler.filename = matprops.spatialdb
+quadrature.cell.shape = line
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[extensionforce.timedependent.bc.force]
+bc_dof = [0]
+label = end points
+db_initial = spatialdata.spatialdb.SimpleDB
+db_initial.label = Dirichlet BC
+db_initial.iohandler.filename = extensionforce_force.spatialdb
+
+[extensionforce.timedependent.bc.fixed]
+bc_dof = [0]
+label = fault
+
+
+# ----------------------------------------------------------------------
+# PETSc
+# ----------------------------------------------------------------------
+[extensionforce.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_max_it = 100
+ksp_gmres_restart = 50
+#ksp_monitor = true
+#ksp_view = true
+#log_summary = true
+#start_in_debugger = true
+#snes_monitor = true
+#snes_view = true
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+[extensionforce.problem.formulation.output.output.writer]
+filename = extensionforce.vtk
+
+[extensionforce.timedependent.materials.elastic.output]
+cell_filter = pylith.meshio.CellFilterAvgMesh
+writer.filename = extensionforce-elastic.vtk

Added: short/3D/PyLith/trunk/tests/1d/line2/extensionforce_force.spatialdb
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/extensionforce_force.spatialdb	                        (rev 0)
+++ short/3D/PyLith/trunk/tests/1d/line2/extensionforce_force.spatialdb	2009-08-05 19:07:39 UTC (rev 15519)
@@ -0,0 +1,15 @@
+#SPATIAL.ascii 1
+SimpleDB {
+  num-values = 1
+  value-names =  force-x
+  value-units =  newton
+  num-locs = 2
+  data-dim = 1
+  space-dim = 1
+  cs-data = cartesian {
+    to-meters = 1.0
+    space-dim = 1
+  }
+}
+0.0   -3.0e+16
+4.0   +3.0e+16

Modified: short/3D/PyLith/trunk/tests/1d/line2/testpylith.py
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/testpylith.py	2009-08-05 18:37:59 UTC (rev 15518)
+++ short/3D/PyLith/trunk/tests/1d/line2/testpylith.py	2009-08-05 19:07:39 UTC (rev 15519)
@@ -20,9 +20,12 @@
   """
   suite = unittest.TestSuite()
 
-  from TestAxial import TestAxial
-  suite.addTest(unittest.makeSuite(TestAxial))
+  from TestExtensionDisp import TestExtensionDisp
+  suite.addTest(unittest.makeSuite(TestExtensionDisp))
 
+  from TestExtensionForce import TestExtensionForce
+  suite.addTest(unittest.makeSuite(TestExtensionForce))
+
   from TestDislocation import TestDislocation
   suite.addTest(unittest.makeSuite(TestDislocation))
 



More information about the CIG-COMMITS mailing list