[cig-commits] r13353 - short/3D/PyLith/trunk/tests/1d/line2
brad at geodynamics.org
brad at geodynamics.org
Wed Nov 19 16:47:59 PST 2008
Author: brad
Date: 2008-11-19 16:47:59 -0800 (Wed, 19 Nov 2008)
New Revision: 13353
Removed:
short/3D/PyLith/trunk/tests/1d/line2/TestDislocationDyn.py
short/3D/PyLith/trunk/tests/1d/line2/TestDislocationStatic.py
short/3D/PyLith/trunk/tests/1d/line2/dislocation_disp.spatialdb
short/3D/PyLith/trunk/tests/1d/line2/dislocation_dyn.cfg
short/3D/PyLith/trunk/tests/1d/line2/dislocation_dyn_sliprate.spatialdb
short/3D/PyLith/trunk/tests/1d/line2/dislocation_dyn_sliptime.spatialdb
short/3D/PyLith/trunk/tests/1d/line2/dislocation_slip.spatialdb
short/3D/PyLith/trunk/tests/1d/line2/dislocation_sliprate.spatialdb
short/3D/PyLith/trunk/tests/1d/line2/dislocation_sliptime.spatialdb
short/3D/PyLith/trunk/tests/1d/line2/dislocation_static.cfg
Modified:
short/3D/PyLith/trunk/tests/1d/line2/Makefile.am
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/testpylith.py
Log:
Clean up of tests.
Modified: short/3D/PyLith/trunk/tests/1d/line2/Makefile.am
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/Makefile.am 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/Makefile.am 2008-11-20 00:47:59 UTC (rev 13353)
@@ -15,33 +15,19 @@
check_SCRIPTS = testpylith.py
noinst_PYTHON = \
- TestAxial.py \
- TestDislocationStatic.py \
- TestDislocationDyn.py
+ TestAxial.py
noinst_DATA = \
bar.mesh \
axialextension.cfg \
axialextension_disp.spatialdb \
- dislocation_static.cfg \
- dislocation_dyn.cfg \
- dislocation_disp.spatialdb \
- dislocation_slip.spatialdb \
- dislocation_sliprate.spatialdb \
- dislocation_sliptime.spatialdb \
- dislocation_dyn_sliprate.spatialdb \
- dislocation_dyn_sliptime.spatialdb \
matprops.spatialdb
noinst_TMP = \
- axialextension_t0.vtk \
- axialextension_t1.vtk \
- dislocation_static_t0.vtk \
- dislocation_static_t1.vtk \
- dislocation_dyn_t0.vtk \
- dislocation_dyn_t1.vtk
+ axialextension_t0000000.vtk \
+ axialextension-statevars-elastic_info.vtk \
+ axialextension-statevars-elastic_t0000000.vtk
-
TESTS_ENVIRONMENT = $(PYTHON)
Modified: short/3D/PyLith/trunk/tests/1d/line2/TestAxial.py
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/TestAxial.py 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/TestAxial.py 2008-11-20 00:47:59 UTC (rev 13353)
@@ -15,24 +15,26 @@
## @brief Test suite for testing pylith with 1-D axial extension.
import unittest
-#import numpy
-#import tables
+import numpy
+from pylith.utils.VTKDataReader import has_vtk
+from pylith.utils.VTKDataReader import VTKDataReader
+# Local version of PyLithApp
from pylith.PyLithApp import PyLithApp
-class AxialExtension(PyLithApp):
-
+class AxialPlaneStrainApp(PyLithApp):
def __init__(self):
- PyLithApp.__init__(self, "axialextension")
+ PyLithApp.__init__(self, name="axialextension")
return
+# Helper function to run PyLith
def run_pylith():
"""
Run pylith.
"""
if not "done" in dir(run_pylith):
- app = AxialExtension()
+ app = AxialPlaneStrainApp()
app.run()
run_pylith.done = True
return
@@ -48,14 +50,129 @@
Setup for test.
"""
run_pylith()
+ if has_vtk():
+ self.reader = VTKDataReader()
+ else:
+ self.reader = None
return
- def test_disp(self):
+ def test_elastic_info(self):
"""
- Check displacement field.
+ Check elastic info.
"""
+ if self.reader is None:
+ return
+
+ data = self.reader.read("axialextension-statevars-elastic_info.vtk")
+
+ # Check cells
+ ncellsE = 4
+ ncornersE = 2
+ (ncells, ncorners) = data['cells'].shape
+ self.assertEqual(ncellsE, ncells)
+ self.assertEqual(ncornersE, ncorners)
+
+ # Check vertices
+ nverticesE = 5
+ spaceDimE = 2
+ (nvertices, spaceDim) = data['vertices'].shape
+ self.assertEqual(nverticesE, nvertices)
+ self.assertEqual(spaceDimE, spaceDim)
+
+ # Check physical properties
+ tolerance = 1.0e-5
+ vsE = 3000.0
+ vpE = 5291.502622129181
+ densityE = 2500.0
+
+ # Lame's constant mu (shear modulus)
+ muE = densityE*vsE**2
+ diff = numpy.abs(1.0 - data['cell_fields']['mu']/muE)
+ okay = diff < tolerance
+ if numpy.sum(okay) != ncells:
+ print "Lame's constant mu: ",data['cell_fields']['mu']
+ self.assertEqual(ncells, numpy.sum(okay))
+
+ # Lame's constant lambda
+ lambdaE = densityE*vpE**2 - 2*muE
+ diff = numpy.abs(1.0 - data['cell_fields']['lambda']/lambdaE)
+ okay = diff < tolerance
+ if numpy.sum(okay) != ncells:
+ print "Lame's constant lambda: ",data['cell_fields']['lambda']
+ self.assertEqual(ncells, numpy.sum(okay))
+
+ # Density
+ diff = numpy.abs(1.0 - data['cell_fields']['density']/densityE)
+ okay = diff < tolerance
+ if numpy.sum(okay) != ncells:
+ print "Density: ",data['cell_fields']['density']
+ self.assertEqual(ncells, numpy.sum(okay))
return
+ def test_soln(self):
+ """
+ Check solution (displacement) field.
+ """
+ if self.reader is None:
+ return
+
+ data = self.reader.read("axialextension_t0000000.vtk")
+
+ # Check cells
+ ncellsE = 4
+ ncornersE = 2
+ (ncells, ncorners) = data['cells'].shape
+ self.assertEqual(ncellsE, ncells)
+ self.assertEqual(ncornersE, ncorners)
+
+ # Check vertices
+ nverticesE = 5
+ spaceDimE = 3
+ vertices = data['vertices']
+ (nvertices, spaceDim) = vertices.shape
+ self.assertEqual(nverticesE, nvertices)
+ self.assertEqual(spaceDimE, spaceDim)
+
+ # Check displacement solution
+ tolerance = 1.0e-5
+ dispE = numpy.zeros( (nvertices, spaceDim), dtype=numpy.float64)
+ dispE[:,0] = -0.2 + 0.1 * vertices[:,0]
+
+ disp = data['vertex_fields']['displacements']
+
+ # Check x displacements
+ diff = numpy.abs(disp[:,0] - dispE[:,0])
+ okay = diff < tolerance
+ if numpy.sum(okay) != nvertices:
+ print "Displacement field: ",disp
+ self.assertEqual(nvertices, numpy.sum(okay))
+
+ # Check y displacements
+ mask = dispE[:,1] > 0.0
+ diff = mask * numpy.abs(1.0 - disp[:,1] / dispE[:,1]) + \
+ ~mask * numpy.abs(disp[:,1] - dispE[:,1])
+ okay = diff < tolerance
+ if numpy.sum(okay) != nvertices:
+ print "Displacement field: ",disp
+ self.assertEqual(nvertices, numpy.sum(okay))
+
+ # Check z displacements
+ diff = numpy.abs(disp[:,2] - dispE[:,2])
+ okay = diff < tolerance
+ if numpy.sum(okay) != nvertices:
+ print "Displacement field: ",disp
+ self.assertEqual(nvertices, numpy.sum(okay))
+
+ return
+
+
+ def test_elastic_statevars(self):
+ """
+ Check elastic state variables.
+ """
+ return
+
+
# End of file
Deleted: short/3D/PyLith/trunk/tests/1d/line2/TestDislocationDyn.py
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/TestDislocationDyn.py 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/TestDislocationDyn.py 2008-11-20 00:47:59 UTC (rev 13353)
@@ -1,62 +0,0 @@
-#!/usr/bin/env python
-#
-# ----------------------------------------------------------------------
-#
-# Brad T. Aagaard
-# U.S. Geological Survey
-#
-# <LicenseText>
-#
-# ----------------------------------------------------------------------
-#
-
-## @file tests/1d/line2/TestDislocationDyn.py
-##
-## @brief Test suite for testing pylith with dynamic dislocation in
-## 1-D mesh.
-
-import unittest
-#import numpy
-#import tables
-
-
-from pylith.PyLithApp import PyLithApp
-class Dislocation(PyLithApp):
-
- def __init__(self):
- PyLithApp.__init__(self, "dislocation_dyn")
- return
-
-
-def run_pylith():
- """
- Run pylith.
- """
- if not "done" in dir(run_pylith):
- app = Dislocation()
- app.run()
- run_pylith.done = True
- return
-
-
-class TestDislocationDyn(unittest.TestCase):
- """
- Test suite for testing pylith with dynamic dislocation in 1-D mesh.
- """
-
- def setUp(self):
- """
- Setup for test.
- """
- run_pylith()
- return
-
-
- def test_disp(self):
- """
- Check displacement field.
- """
- return
-
-
-# End of file
Deleted: short/3D/PyLith/trunk/tests/1d/line2/TestDislocationStatic.py
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/TestDislocationStatic.py 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/TestDislocationStatic.py 2008-11-20 00:47:59 UTC (rev 13353)
@@ -1,62 +0,0 @@
-#!/usr/bin/env python
-#
-# ----------------------------------------------------------------------
-#
-# Brad T. Aagaard
-# U.S. Geological Survey
-#
-# <LicenseText>
-#
-# ----------------------------------------------------------------------
-#
-
-## @file tests/1d/line2/TestDislocation.py
-##
-## @brief Test suite for testing pylith with static dislocation in 1-D
-## mesh.
-
-import unittest
-#import numpy
-#import tables
-
-
-from pylith.PyLithApp import PyLithApp
-class Dislocation(PyLithApp):
-
- def __init__(self):
- PyLithApp.__init__(self, "dislocation_static")
- return
-
-
-def run_pylith():
- """
- Run pylith.
- """
- if not "done" in dir(run_pylith):
- app = Dislocation()
- app.run()
- run_pylith.done = True
- return
-
-
-class TestDislocationStatic(unittest.TestCase):
- """
- Test suite for testing pylith with static dislocation in 1-D mesh.
- """
-
- def setUp(self):
- """
- Setup for test.
- """
- run_pylith()
- return
-
-
- def test_disp(self):
- """
- Check displacement field.
- """
- return
-
-
-# End of file
Modified: short/3D/PyLith/trunk/tests/1d/line2/axialextension.cfg
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/axialextension.cfg 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/axialextension.cfg 2008-11-20 00:47:59 UTC (rev 13353)
@@ -9,10 +9,9 @@
#implicit = 1
#petsc = 1
#solverlinear = 1
-#meshioascii = 1
-#homogeneous = 1
+#meshiocubit = 1
#implicitelasticity = 1
-#quadrature1d = 1
+#quadrature2d = 1
#fiatsimplex = 1
# ----------------------------------------------------------------------
@@ -29,20 +28,21 @@
# problem
# ----------------------------------------------------------------------
[axialextension.timedependent]
-total_time = 0.0*s
-default_dt = 1.0*s
dimension = 1
-formulation = pylith.problems.Implicit
-bc = pylith.bc.BCSingle
+bc = [bc]
+[axialextension.timedependent.formulation.time_step]
+total_time = 0.0*s
+
# ----------------------------------------------------------------------
# materials
# ----------------------------------------------------------------------
-[axialextension.timedependent.materials]
-material = pylith.materials.ElasticStrain1D
+[axialextension.timedependent]
+materials = [elastic]
+materials.elastic = pylith.materials.ElasticStrain1D
-[axialextension.timedependent.materials.material]
-label = elastic material
+[axialextension.timedependent.materials.elastic]
+label = Elastic material
id = 1
db.iohandler.filename = matprops.spatialdb
quadrature = pylith.feassemble.quadrature.Quadrature1D
@@ -53,8 +53,8 @@
# ----------------------------------------------------------------------
[axialextension.timedependent.bc.bc]
fixed_dof = [0]
-id = 10
label = end points
+db = spatialdata.spatialdb.SimpleDB
db.label = Dirichlet BC
db.iohandler.filename = axialextension_disp.spatialdb
@@ -62,10 +62,21 @@
# PETSc
# ----------------------------------------------------------------------
[axialextension.petsc]
-pc_type = jacobi
+ksp_rtol = 1.0e-8
+pc_type = asm
+ksp_max_it = 100
+ksp_gmres_restart = 50
+#ksp_monitor = true
+#ksp_view = true
+#log_summary = true
+# start_in_debugger = true
# ----------------------------------------------------------------------
# output
# ----------------------------------------------------------------------
[axialextension.problem.formulation.output.output.writer]
filename = axialextension.vtk
+
+[axialextension.timedependent.materials.elastic.output]
+cell_filter = pylith.meshio.CellFilterAvg
+writer.filename = axialextension-statevars-elastic.vtk
Deleted: short/3D/PyLith/trunk/tests/1d/line2/dislocation_disp.spatialdb
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/dislocation_disp.spatialdb 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/dislocation_disp.spatialdb 2008-11-20 00:47:59 UTC (rev 13353)
@@ -1,14 +0,0 @@
-#SPATIAL.ascii 1
-SimpleDB {
- num-values = 1
- value-names = dof-0
- value-units = m
- num-locs = 1
- data-dim = 0
- space-dim = 1
- cs-data = cartesian {
- to-meters = 1.0
- space-dim = 1
- }
-}
-0.0 0.0
Deleted: short/3D/PyLith/trunk/tests/1d/line2/dislocation_dyn.cfg
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/dislocation_dyn.cfg 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/dislocation_dyn.cfg 2008-11-20 00:47:59 UTC (rev 13353)
@@ -1,109 +0,0 @@
-# -*- Python -*-
-[dislocation_dyn]
-
-# ----------------------------------------------------------------------
-# journal
-# ----------------------------------------------------------------------
-[dislocation_dyn.journal.info]
-#timedependent = 1
-#explicit = 1
-#petsc = 1
-#solverlinear = 1
-#meshioascii = 1
-#homogeneous = 1
-#explicitelasticity = 1
-#quadrature1d = 1
-#fiatsimplex = 1
-#faultcohesivekin = 1
-
-# ----------------------------------------------------------------------
-# mesh_generator
-# ----------------------------------------------------------------------
-[dislocation_dyn.mesh_generator]
-#debug = 1
-
-[dislocation_dyn.mesh_generator.importer]
-filename = bar.mesh
-coordsys.space_dim = 1
-
-# ----------------------------------------------------------------------
-# problem
-# ----------------------------------------------------------------------
-[dislocation_dyn.timedependent]
-total_time = 0.0175*s
-default_dt = 0.0001*s
-dimension = 1
-formulation = pylith.problems.Explicit
-bc = pylith.bc.BCSingle
-bc.bc = pylith.bc.AbsorbingDampers
-interfaces = pylith.faults.SingleFault
-
-# ----------------------------------------------------------------------
-# materials
-# ----------------------------------------------------------------------
-[dislocation_dyn.timedependent.materials]
-material = pylith.materials.ElasticStrain1D
-
-[dislocation_dyn.timedependent.materials.material]
-label = elastic material
-id = 1
-db.iohandler.filename = matprops.spatialdb
-quadrature = pylith.feassemble.quadrature.Quadrature1D
-quadrature.cell.shape = line
-quadrature.cell.quad_order = 2
-
-# ----------------------------------------------------------------------
-# boundary conditions
-# ----------------------------------------------------------------------
-[dislocation_dyn.timedependent.bc.bc]
-id = 10
-label = end points
-db.label = Absorbing BC
-db.iohandler.filename = matprops.spatialdb
-quadrature = pylith.feassemble.quadrature.Quadrature0D
-quadrature.cell.shape = point
-quadrature.cell.quad_order = 1
-
-# ----------------------------------------------------------------------
-# faults
-# ----------------------------------------------------------------------
-[dislocation_dyn.timedependent.interfaces]
-fault = pylith.faults.FaultCohesiveKin
-
-[dislocation_dyn.timedependent.interfaces.fault]
-id = 20
-label = fault
-quadrature = pylith.feassemble.quadrature.Quadrature0D
-quadrature.cell.shape = point
-mat_db.iohandler.filename = matprops.spatialdb
-
-[dislocation_dyn.timedependent.interfaces.fault.eq_src.slip_function]
-slip.iohandler.filename = dislocation_slip.spatialdb
-slip_rate.iohandler.filename = dislocation_dyn_sliprate.spatialdb
-slip_time.iohandler.filename = dislocation_dyn_sliptime.spatialdb
-
-
-# ----------------------------------------------------------------------
-# PETSc
-# ----------------------------------------------------------------------
-[dislocation_dyn.petsc]
-ksp_type = gmres
-pc_type = jacobi
-ksp_rtol = 1.0e-8
-ksp_max_it = 50
-ksp_gmres_restart = 10
-
-#ksp_type = preonly
-#pc_jacobi_rowsum = 1
-
-#ksp_monitor = true
-#ksp_view = true
-#log_summary = true
-
-
-# ----------------------------------------------------------------------
-# output
-# ----------------------------------------------------------------------
-[dislocation_dyn.problem.formulation.output.output.writer]
-filename = dislocation_dyn.vtk
-time_format = %08.6f
Deleted: short/3D/PyLith/trunk/tests/1d/line2/dislocation_dyn_sliprate.spatialdb
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/dislocation_dyn_sliprate.spatialdb 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/dislocation_dyn_sliprate.spatialdb 2008-11-20 00:47:59 UTC (rev 13353)
@@ -1,14 +0,0 @@
-#SPATIAL.ascii 1
-SimpleDB {
- num-values = 1
- value-names = slip-rate
- value-units = m/s
- num-locs = 1
- data-dim = 0
- space-dim = 1
- cs-data = cartesian {
- to-meters = 1.0
- space-dim = 1
- }
-}
-0.0 5.0e+2
Deleted: short/3D/PyLith/trunk/tests/1d/line2/dislocation_dyn_sliptime.spatialdb
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/dislocation_dyn_sliptime.spatialdb 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/dislocation_dyn_sliptime.spatialdb 2008-11-20 00:47:59 UTC (rev 13353)
@@ -1,14 +0,0 @@
-#SPATIAL.ascii 1
-SimpleDB {
- num-values = 1
- value-names = slip-time
- value-units = s
- num-locs = 1
- data-dim = 0
- space-dim = 1
- cs-data = cartesian {
- to-meters = 1.0
- space-dim = 1
- }
-}
-0.0 0.000350
Deleted: short/3D/PyLith/trunk/tests/1d/line2/dislocation_slip.spatialdb
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/dislocation_slip.spatialdb 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/dislocation_slip.spatialdb 2008-11-20 00:47:59 UTC (rev 13353)
@@ -1,14 +0,0 @@
-#SPATIAL.ascii 1
-SimpleDB {
- num-values = 1
- value-names = fault-opening
- value-units = m
- num-locs = 1
- data-dim = 0
- space-dim = 1
- cs-data = cartesian {
- to-meters = 1.0
- space-dim = 1
- }
-}
-0.0 1.0
Deleted: short/3D/PyLith/trunk/tests/1d/line2/dislocation_sliprate.spatialdb
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/dislocation_sliprate.spatialdb 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/dislocation_sliprate.spatialdb 2008-11-20 00:47:59 UTC (rev 13353)
@@ -1,14 +0,0 @@
-#SPATIAL.ascii 1
-SimpleDB {
- num-values = 1
- value-names = slip-rate
- value-units = m/s
- num-locs = 1
- data-dim = 0
- space-dim = 1
- cs-data = cartesian {
- to-meters = 1.0
- space-dim = 1
- }
-}
-0.0 1.0e+6
Deleted: short/3D/PyLith/trunk/tests/1d/line2/dislocation_sliptime.spatialdb
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/dislocation_sliptime.spatialdb 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/dislocation_sliptime.spatialdb 2008-11-20 00:47:59 UTC (rev 13353)
@@ -1,14 +0,0 @@
-#SPATIAL.ascii 1
-SimpleDB {
- num-values = 1
- value-names = slip-time
- value-units = s
- num-locs = 1
- data-dim = 0
- space-dim = 1
- cs-data = cartesian {
- to-meters = 1.0
- space-dim = 1
- }
-}
-0.0 -1.0
Deleted: short/3D/PyLith/trunk/tests/1d/line2/dislocation_static.cfg
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/dislocation_static.cfg 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/dislocation_static.cfg 2008-11-20 00:47:59 UTC (rev 13353)
@@ -1,92 +0,0 @@
-# -*- Python -*-
-[dislocation_static]
-
-# ----------------------------------------------------------------------
-# journal
-# ----------------------------------------------------------------------
-[dislocation_static.journal.info]
-#timedependent = 1
-#implicit = 1
-#petsc = 1
-#solverlinear = 1
-#meshioascii = 1
-#homogeneous = 1
-#implicitelasticity = 1
-#quadrature1d = 1
-#fiatsimplex = 1
-#faultcohesivekin = 1
-
-# ----------------------------------------------------------------------
-# mesh_generator
-# ----------------------------------------------------------------------
-[dislocation_static.mesh_generator]
-#debug = 1
-
-[dislocation_static.mesh_generator.importer]
-filename = bar.mesh
-coordsys.space_dim = 1
-
-# ----------------------------------------------------------------------
-# problem
-# ----------------------------------------------------------------------
-[dislocation_static.timedependent]
-total_time = 0.0*s
-default_dt = 1.0*s
-dimension = 1
-formulation = pylith.problems.Implicit
-bc = pylith.bc.BCSingle
-interfaces = pylith.faults.SingleFault
-
-# ----------------------------------------------------------------------
-# materials
-# ----------------------------------------------------------------------
-[dislocation_static.timedependent.materials]
-material = pylith.materials.ElasticStrain1D
-
-[dislocation_static.timedependent.materials.material]
-label = elastic material
-id = 1
-db.iohandler.filename = matprops.spatialdb
-quadrature = pylith.feassemble.quadrature.Quadrature1D
-quadrature.cell.shape = line
-
-# ----------------------------------------------------------------------
-# boundary conditions
-# ----------------------------------------------------------------------
-[dislocation_static.timedependent.bc.bc]
-fixed_dof = [0]
-id = 10
-label = end points
-db.label = Dirichlet BC
-db.iohandler.filename = dislocation_disp.spatialdb
-
-# ----------------------------------------------------------------------
-# faults
-# ----------------------------------------------------------------------
-[dislocation_static.timedependent.interfaces]
-fault = pylith.faults.FaultCohesiveKin
-
-[dislocation_static.timedependent.interfaces.fault]
-id = 20
-label = fault
-quadrature = pylith.feassemble.quadrature.Quadrature0D
-quadrature.cell.shape = point
-mat_db.iohandler.filename = matprops.spatialdb
-
-[dislocation_static.timedependent.interfaces.fault.eq_src.slip_function]
-slip.iohandler.filename = dislocation_slip.spatialdb
-slip_rate.iohandler.filename = dislocation_sliprate.spatialdb
-slip_time.iohandler.filename = dislocation_sliptime.spatialdb
-
-
-# ----------------------------------------------------------------------
-# PETSc
-# ----------------------------------------------------------------------
-[dislocation_static.petsc]
-pc_type = jacobi
-
-# ----------------------------------------------------------------------
-# output
-# ----------------------------------------------------------------------
-[dislocation_static.problem.formulation.output.output.writer]
-filename = dislocation_static.vtk
Modified: short/3D/PyLith/trunk/tests/1d/line2/testpylith.py
===================================================================
--- short/3D/PyLith/trunk/tests/1d/line2/testpylith.py 2008-11-20 00:29:25 UTC (rev 13352)
+++ short/3D/PyLith/trunk/tests/1d/line2/testpylith.py 2008-11-20 00:47:59 UTC (rev 13353)
@@ -23,12 +23,6 @@
from TestAxial import TestAxial
suite.addTest(unittest.makeSuite(TestAxial))
- from TestDislocationStatic import TestDislocationStatic
- suite.addTest(unittest.makeSuite(TestDislocationStatic))
-
- from TestDislocationDyn import TestDislocationDyn
- suite.addTest(unittest.makeSuite(TestDislocationDyn))
-
return suite
More information about the CIG-COMMITS
mailing list