[cig-commits] r14330 - in short/3D/PyLith/branches/pylith-swig: libsrc/feassemble unittests/libtests/feassemble

brad at geodynamics.org brad at geodynamics.org
Sun Mar 15 19:04:37 PDT 2009


Author: brad
Date: 2009-03-15 19:04:37 -0700 (Sun, 15 Mar 2009)
New Revision: 14330

Modified:
   short/3D/PyLith/branches/pylith-swig/libsrc/feassemble/ElasticityImplicit.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/Makefile.am
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityExplicit.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit.hh
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DLinear.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DLinear.hh
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DQuadratic.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DQuadratic.hh
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DLinear.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DLinear.hh
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DQuadratic.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DQuadratic.hh
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DLinear.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DLinear.hh
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DQuadratic.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DQuadratic.hh
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DLinear.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DLinear.hh
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DQuadratic.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DQuadratic.hh
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DLinear.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DLinear.hh
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DQuadratic.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DQuadratic.hh
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DLinear.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DLinear.hh
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DQuadratic.cc
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DQuadratic.hh
Log:
Finished updating C++ testing of elasticity integrators.

Modified: short/3D/PyLith/branches/pylith-swig/libsrc/feassemble/ElasticityImplicit.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/libsrc/feassemble/ElasticityImplicit.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/libsrc/feassemble/ElasticityImplicit.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -165,7 +165,7 @@
 
   // Get sections
   const ALE::Obj<RealSection>& dispTBctpdtSection = 
-    fields->get("disp(T), bc(t+dt)").section();
+    fields->get("disp(t), bc(t+dt)").section();
   assert(!dispTBctpdtSection.isNull());
   topology::Mesh::RestrictVisitor dispTBctpdtVisitor(*dispTBctpdtSection,
 						     numBasis*spaceDim, 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/Makefile.am
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/Makefile.am	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/Makefile.am	2009-03-16 02:04:37 UTC (rev 14330)
@@ -53,21 +53,21 @@
 	TestElasticityExplicit2DQuadratic.cc \
 	TestElasticityExplicit3DLinear.cc \
 	TestElasticityExplicit3DQuadratic.cc \
+	TestElasticityImplicit.cc \
+	TestElasticityImplicit1DLinear.cc \
+	TestElasticityImplicit1DQuadratic.cc \
+	TestElasticityImplicit2DLinear.cc \
+	TestElasticityImplicit2DQuadratic.cc \
+	TestElasticityImplicit3DLinear.cc \
+	TestElasticityImplicit3DQuadratic.cc \
+	TestElasticityImplicitGrav1DLinear.cc \
+	TestElasticityImplicitGrav1DQuadratic.cc \
+	TestElasticityImplicitGrav2DLinear.cc \
+	TestElasticityImplicitGrav2DQuadratic.cc \
+	TestElasticityImplicitGrav3DLinear.cc \
+	TestElasticityImplicitGrav3DQuadratic.cc \
 	test_feassemble.cc
 
-# 	TestElasticityImplicit.cc \
-# 	TestElasticityImplicit1DLinear.cc \
-# 	TestElasticityImplicit1DQuadratic.cc \
-# 	TestElasticityImplicit2DLinear.cc \
-# 	TestElasticityImplicit2DQuadratic.cc \
-# 	TestElasticityImplicit3DLinear.cc \
-# 	TestElasticityImplicit3DQuadratic.cc \
-# 	TestElasticityImplicitGrav1DLinear.cc \
-# 	TestElasticityImplicitGrav1DQuadratic.cc \
-# 	TestElasticityImplicitGrav2DLinear.cc \
-# 	TestElasticityImplicitGrav2DQuadratic.cc \
-# 	TestElasticityImplicitGrav3DLinear.cc \
-# 	TestElasticityImplicitGrav3DQuadratic.cc
 
 
 noinst_HEADERS = \

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityExplicit.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityExplicit.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityExplicit.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -218,7 +218,6 @@
   const double t = 1.0;
   integrator.integrateJacobian(&jacobian, t, &fields);
   CPPUNIT_ASSERT_EQUAL(false, integrator.needNewJacobian());
-
   jacobian.assemble("final_assembly");
 
   const double* valsE = _data->valsJacobian;
@@ -289,6 +288,7 @@
   CPPUNIT_ASSERT(0 != _quadrature);
   CPPUNIT_ASSERT(0 != _material);
 
+  // Setup mesh
   spatialdata::geocoords::CSCart cs;
   cs.setSpaceDim(_data->spaceDim);
   cs.initialize();

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -20,7 +20,9 @@
 #include "pylith/utils/constdefs.h" // USES MAXDOUBLE
 #include "pylith/materials/ElasticIsotropic3D.hh" // USES ElasticIsotropic3D
 #include "pylith/feassemble/Quadrature.hh" // USES Quadrature
-#include "pylith/topology/FieldsManager.hh" // USES FieldsManager
+#include "pylith/topology/Mesh.hh" // USES Mesh
+#include "pylith/topology/SolutionFields.hh" // USES SolutionFields
+#include "pylith/topology/Jacobian.hh" // USES Jacobian
 
 #include "spatialdata/geocoords/CSCart.hh" // USES CSCart
 #include "spatialdata/spatialdb/SimpleDB.hh" // USES SimpleDB
@@ -34,12 +36,16 @@
 CPPUNIT_TEST_SUITE_REGISTRATION( pylith::feassemble::TestElasticityImplicit );
 
 // ----------------------------------------------------------------------
+typedef pylith::topology::Mesh::SieveMesh SieveMesh;
+typedef pylith::topology::Mesh::RealSection RealSection;
+
+// ----------------------------------------------------------------------
 // Setup testing data.
 void
 pylith::feassemble::TestElasticityImplicit::setUp(void)
 { // setUp
+  _quadrature = new Quadrature<topology::Mesh>();
   _data = 0;
-  _quadrature = 0;
   _material = 0;
   _gravityField = 0;
 } // setUp
@@ -146,23 +152,18 @@
 } // testUseSolnIncr
 
 // ----------------------------------------------------------------------
-// Test updateState().
+// Test initialize().
 void 
-pylith::feassemble::TestElasticityImplicit::testUpdateState(void)
-{ // testUpdateState
+pylith::feassemble::TestElasticityImplicit::testInitialize(void)
+{ // testInitialize
   CPPUNIT_ASSERT(0 != _data);
 
-  ALE::Obj<Mesh> mesh;
+  topology::Mesh mesh;
   ElasticityImplicit integrator;
-  topology::FieldsManager fields(mesh);
+  topology::SolutionFields fields(mesh);
   _initialize(&mesh, &integrator, &fields);
 
-  const ALE::Obj<real_section_type>& dispTBctpdt = 
-    fields.getReal("dispTBctpdt");
-  CPPUNIT_ASSERT(!dispTBctpdt.isNull());
-  const double t = 1.0;
-  integrator.updateState(t, &fields, mesh);
-} // testUpdateState
+} // testInitialize
 
 // ----------------------------------------------------------------------
 // Test integrateResidual().
@@ -171,25 +172,22 @@
 { // testIntegrateResidual
   CPPUNIT_ASSERT(0 != _data);
 
-  ALE::Obj<Mesh> mesh;
+  topology::Mesh mesh;
   ElasticityImplicit integrator;
-  topology::FieldsManager fields(mesh);
+  topology::SolutionFields fields(mesh);
   _initialize(&mesh, &integrator, &fields);
 
-  spatialdata::geocoords::CSCart cs;
-  cs.setSpaceDim((mesh)->getDimension());
-  cs.initialize();
-
-  const ALE::Obj<real_section_type>& residual = fields.getReal("residual");
-  CPPUNIT_ASSERT(!residual.isNull());
+  topology::Field<topology::Mesh>& residual = fields.get("residual");
   const double t = 1.0;
-  integrator.integrateResidual(residual, t, &fields, mesh, &cs);
+  integrator.integrateResidual(residual, t, &fields);
 
   const double* valsE = _data->valsResidual;
   const int sizeE = _data->spaceDim * _data->numVertices;
 
-  const double* vals = residual->restrictSpace();
-  const int size = residual->sizeWithBC();
+  const ALE::Obj<RealSection>& residualSection = residual.section();
+  CPPUNIT_ASSERT(!residualSection.isNull());
+  const double* vals = residualSection->restrictSpace();
+  const int size = residualSection->sizeWithBC();
   CPPUNIT_ASSERT_EQUAL(sizeE, size);
 
   const double tolerance = 1.0e-06;
@@ -207,44 +205,36 @@
 { // testIntegrateJacobian
   CPPUNIT_ASSERT(0 != _data);
 
-  ALE::Obj<Mesh> mesh;
+  topology::Mesh mesh;
   ElasticityImplicit integrator;
-  topology::FieldsManager fields(mesh);
+  topology::SolutionFields fields(mesh);
   _initialize(&mesh, &integrator, &fields);
   integrator._needNewJacobian = true;
 
-  const ALE::Obj<pylith::real_section_type>& dispTBctpdt = 
-    fields.getReal("dispTBctpdt");
-  CPPUNIT_ASSERT(!dispTBctpdt.isNull());
+  topology::Jacobian jacobian(fields);
 
-  PetscMat jacobian;
-  PetscErrorCode err = MeshCreateMatrix(mesh, dispTBctpdt, MATMPIBAIJ, &jacobian);
-  CPPUNIT_ASSERT(0 == err);
-
   const double t = 1.0;
   //mesh->getSieve()->setDebug(10);
-  integrator.integrateJacobian(&jacobian, t, &fields, mesh);
+  integrator.integrateJacobian(&jacobian, t, &fields);
   CPPUNIT_ASSERT_EQUAL(false, integrator.needNewJacobian());
   //mesh->getSieve()->setDebug(0);
+  jacobian.assemble("final_assembly");
 
-  err = MatAssemblyBegin(jacobian, MAT_FINAL_ASSEMBLY);
-  CPPUNIT_ASSERT(0 == err);
-  err = MatAssemblyEnd(jacobian, MAT_FINAL_ASSEMBLY);
-  CPPUNIT_ASSERT(0 == err);
-
   const double* valsE = _data->valsJacobian;
   const int nrowsE = _data->numVertices * _data->spaceDim;
   const int ncolsE = _data->numVertices * _data->spaceDim;
 
+  const PetscMat* jacobianMat = jacobian.matrix();
+
   int nrows = 0;
   int ncols = 0;
-  MatGetSize(jacobian, &nrows, &ncols);
+  MatGetSize(*jacobianMat, &nrows, &ncols);
   CPPUNIT_ASSERT_EQUAL(nrowsE, nrows);
   CPPUNIT_ASSERT_EQUAL(ncolsE, ncols);
 
   PetscMat jDense;
   PetscMat jSparseAIJ;
-  MatConvert(jacobian, MATSEQAIJ, MAT_INITIAL_MATRIX, &jSparseAIJ);
+  MatConvert(*jacobianMat, MATSEQAIJ, MAT_INITIAL_MATRIX, &jSparseAIJ);
   MatConvert(jSparseAIJ, MATSEQDENSE, MAT_INITIAL_MATRIX, &jDense);
 
   double_array vals(nrows*ncols);
@@ -269,12 +259,28 @@
 } // testIntegrateJacobian
 
 // ----------------------------------------------------------------------
+// Test updateStateVars().
+void 
+pylith::feassemble::TestElasticityImplicit::testUpdateStateVars(void)
+{ // testUpdateStateVars
+  CPPUNIT_ASSERT(0 != _data);
+
+  topology::Mesh mesh;
+  ElasticityImplicit integrator;
+  topology::SolutionFields fields(mesh);
+  _initialize(&mesh, &integrator, &fields);
+
+  const double t = 1.0;
+  integrator.updateStateVars(t, &fields);
+} // testUpdateStateVars
+
+// ----------------------------------------------------------------------
 // Initialize elasticity integrator.
 void
 pylith::feassemble::TestElasticityImplicit::_initialize(
-					 ALE::Obj<Mesh>* mesh,
+					 topology::Mesh* mesh,
 					 ElasticityImplicit* const integrator,
-					 topology::FieldsManager* fields)
+					 topology::SolutionFields* fields)
 { // _initialize
   CPPUNIT_ASSERT(0 != mesh);
   CPPUNIT_ASSERT(0 != integrator);
@@ -286,82 +292,94 @@
   spatialdata::geocoords::CSCart cs;
   cs.setSpaceDim(_data->spaceDim);
   cs.initialize();
-  *mesh = new Mesh(PETSC_COMM_WORLD, _data->cellDim);
-  CPPUNIT_ASSERT(!mesh->isNull());
-  ALE::Obj<sieve_type> sieve = new sieve_type((*mesh)->comm());
+  mesh->coordsys(&cs);
+  mesh->createSieveMesh(_data->cellDim);
+  const ALE::Obj<SieveMesh>& sieveMesh = mesh->sieveMesh();
+  CPPUNIT_ASSERT(!sieveMesh.isNull());
+  ALE::Obj<SieveMesh::sieve_type> sieve = 
+    new SieveMesh::sieve_type(mesh->comm());
   CPPUNIT_ASSERT(!sieve.isNull());
+
+  // Cells and vertices
   const bool interpolate = false;
-  ALE::Obj<ALE::Mesh::sieve_type> s = new ALE::Mesh::sieve_type(sieve->comm(), sieve->debug());
+  ALE::Obj<ALE::Mesh::sieve_type> s = 
+    new ALE::Mesh::sieve_type(sieve->comm(), sieve->debug());
+  
+  ALE::SieveBuilder<ALE::Mesh>::buildTopology(s, 
+					      _data->cellDim, _data->numCells,
+                                              const_cast<int*>(_data->cells), 
+					      _data->numVertices,
+                                              interpolate, _data->numBasis);
+  std::map<ALE::Mesh::point_type,ALE::Mesh::point_type> renumbering;
+  ALE::ISieveConverter::convertSieve(*s, *sieve, renumbering);
+  sieveMesh->setSieve(sieve);
+  sieveMesh->stratify();
+  ALE::SieveBuilder<SieveMesh>::buildCoordinates(sieveMesh, _data->spaceDim, 
+						 _data->vertices);
 
-  ALE::SieveBuilder<ALE::Mesh>::buildTopology(s, _data->cellDim, 
-	       _data->numCells, const_cast<int*>(_data->cells), 
-	       _data->numVertices, interpolate, _data->numBasis);
-  std::map<Mesh::point_type,Mesh::point_type> renumbering;
-  ALE::ISieveConverter::convertSieve(*s, *sieve, renumbering, false);
-  (*mesh)->setSieve(sieve);
-  (*mesh)->stratify();
-  //std::cout << "Mesh chart: " << (*mesh)->getSieve()->getChart() << std::endl;
-  ALE::SieveBuilder<Mesh>::buildCoordinates((*mesh), _data->spaceDim,
-					    _data->vertices);
-  const ALE::Obj<Mesh::label_type>& labelMaterials = 
-    (*mesh)->createLabel("material-id");  
+  // Material ids
+  const ALE::Obj<SieveMesh::label_sequence>& cells = 
+    sieveMesh->heightStratum(0);
+  CPPUNIT_ASSERT(!cells.isNull());
+  const ALE::Obj<SieveMesh::label_type>& labelMaterials = 
+    sieveMesh->createLabel("material-id");
+  CPPUNIT_ASSERT(!labelMaterials.isNull());
   int i = 0;
-  const ALE::Obj<Mesh::label_sequence>& cells = (*mesh)->heightStratum(0);
-  CPPUNIT_ASSERT(!cells.isNull());
-  for(Mesh::label_sequence::iterator c_iter = cells->begin();
-      c_iter != cells->end();
-      ++c_iter)
-    (*mesh)->setValue(labelMaterials, *c_iter, _data->matId);
-  (*mesh)->getFactory()->clear(); // clear numberings
+  for(SieveMesh::label_sequence::iterator e_iter=cells->begin(); 
+      e_iter != cells->end();
+      ++e_iter)
+    sieveMesh->setValue(labelMaterials, *e_iter, _data->matId);
+  sieveMesh->getFactory()->clear(); // clear numberings
 
   // Setup quadrature
-  _quadrature->initialize(_data->basis, _data->basisDerivRef, _data->quadPts,
-			  _data->quadWts, _data->cellDim, _data->numBasis,
-			  _data->numQuadPts, _data->spaceDim);
-  // Setup gravityField
-  // _gravityField = 0;
+  _quadrature->initialize(_data->basis, _data->numQuadPts, _data->numBasis,
+			  _data->basisDerivRef, _data->numQuadPts,
+			  _data->numBasis, _data->cellDim,
+			  _data->quadPts, _data->numQuadPts, _data->cellDim,
+			  _data->quadWts, _data->numQuadPts,
+			  _data->spaceDim);
 
   // Setup material
   spatialdata::spatialdb::SimpleIOAscii iohandler;
   iohandler.filename(_data->matDBFilename);
-  spatialdata::spatialdb::SimpleDB db;
-  db.ioHandler(&iohandler);
+  spatialdata::spatialdb::SimpleDB dbProperties;
+  dbProperties.ioHandler(&iohandler);
   
   spatialdata::units::Nondimensional normalizer;
 
   _material->id(_data->matId);
   _material->label(_data->matLabel);
-  _material->db(&db);
+  _material->dbProperties(&dbProperties);
   _material->normalizer(normalizer);
-  _material->initialize(*mesh, &cs, _quadrature);
 
   integrator->quadrature(_quadrature);
   integrator->gravityField(_gravityField);
   integrator->timeStep(_data->dt);
   integrator->material(_material);
+  integrator->initialize(*mesh);
 
   // Setup fields
   CPPUNIT_ASSERT(0 != fields);
-  fields->addReal("residual");
-  fields->addReal("dispTBctpdt");
+  fields->add("residual");
+  fields->add("disp(t), bc(t+dt)");
+  fields->add("dispIncr(t->t+dt)");
+  fields->solutionName("dispIncr(t->t+dt)");
   
-  const ALE::Obj<real_section_type>& residual = fields->getReal("residual");
-  CPPUNIT_ASSERT(!residual.isNull());
-  residual->setChart((*mesh)->getSieve()->getChart());
-  residual->setFiberDimension((*mesh)->depthStratum(0), _data->spaceDim);
-  (*mesh)->allocate(residual);
-  residual->zero();
-  //residual->view("Residual");
+  topology::Field<topology::Mesh>& residual = fields->get("residual");
+  residual.newSection(topology::FieldBase::VERTICES_FIELD, _data->spaceDim);
+  residual.allocate();
+  residual.zero();
   fields->copyLayout("residual");
 
   const int fieldSize = _data->spaceDim * _data->numVertices;
-  const ALE::Obj<real_section_type>& dispTBctpdt = 
-    fields->getReal("dispTBctpdt");
-  CPPUNIT_ASSERT(!dispTBctpdt.isNull());
+  topology::Field<topology::Mesh>& dispTBctpdt = 
+    fields->get("disp(t), bc(t+dt)");
+  const ALE::Obj<RealSection>& dispTBctpdtSection = dispTBctpdt.section();
+  CPPUNIT_ASSERT(!dispTBctpdtSection.isNull());
   const int offset = _data->numCells;
   for (int iVertex=0; iVertex < _data->numVertices; ++iVertex) {
-    dispTBctpdt->updatePoint(iVertex+offset, 
-			     &_data->fieldTpdt[iVertex*_data->spaceDim]);
+    dispTBctpdtSection->updatePoint(iVertex+offset, 
+				    &_data->fieldTpdt[iVertex*_data->spaceDim]);
   } // for
 } // _initialize
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -23,35 +23,20 @@
 
 #include <cppunit/extensions/HelperMacros.h>
 
-#include "pylith/utils/sievetypes.hh" // USES PETSc Mesh
+#include "pylith/feassemble/feassemblefwd.hh" // forward declarations
+#include "pylith/topology/topologyfwd.hh" // USES Mesh, SolutionFields
+#include "pylith/materials/materialsfwd.hh" // USES ElasticMaterial
 
-#include "spatialdata/spatialdb/GravityField.hh" // USES GravityField
+#include "spatialdata/spatialdb/spatialdbfwd.hh" // USES GravityField
 
 /// Namespace for pylith package
 namespace pylith {
   namespace feassemble {
     class TestElasticityImplicit;
-
-    class ElasticityImplicit; // USES ElasticityImplicit
-    class IntegratorData; // HOLDSA IntegratorData
-    class Quadrature; // HOLDSA Quadrature
+    class IntegratorData;
   } // feassemble
-
-  namespace materials {
-    class ElasticMaterial; // HOLDSA ElasticMaterial
-  } // materials
-
-  namespace topology {
-    class FieldsManager; // USES FieldsManager
-  } // topology
 } // pylith
 
-namespace spatialdata {
-  namespace spatialdb {
-    class GravityField; // HOLDSA GravityField
-  } // spatialdb
-} // spatialdata
-
 /// C++ unit testing for ElasticityImplicit
 class pylith::feassemble::TestElasticityImplicit : public CppUnit::TestFixture
 { // class TestElasticityImplicit
@@ -65,9 +50,11 @@
   CPPUNIT_TEST( testMaterial );
   CPPUNIT_TEST( testNeedNewJacobian );
   CPPUNIT_TEST( testUseSolnIncr );
-  CPPUNIT_TEST( testIntegrateResidual );
-  CPPUNIT_TEST( testIntegrateJacobian );
 
+  // Testing of initialize(), integrateResidual(),
+  // integrateJacobian(), and updateStateVars() handled by derived
+  // classes.
+
   CPPUNIT_TEST_SUITE_END();
 
   // PUBLIC METHODS /////////////////////////////////////////////////////
@@ -97,8 +84,8 @@
   /// Test useSolnIncr().
   void testUseSolnIncr(void);
 
-  /// Test updateState().
-  void testUpdateState(void);
+  /// Test initialize().
+  void testInitialize(void);
 
   /// Test integrateResidual().
   void testIntegrateResidual(void);
@@ -106,12 +93,15 @@
   /// Test integrateJacobian().
   void testIntegrateJacobian(void);
 
+  /// Test updateStateVars().
+  void testUpdateStateVars(void);
+
   // PROTECTED MEMBERS //////////////////////////////////////////////////
 protected :
 
   IntegratorData* _data; ///< Data for testing.
   materials::ElasticMaterial* _material; ///< Elastic material.
-  Quadrature* _quadrature; ///< Quadrature information.
+  Quadrature<topology::Mesh>* _quadrature; ///< Quadrature information.
   spatialdata::spatialdb::GravityField* _gravityField; ///< Gravity field.
 
   // PRIVATE METHODS ////////////////////////////////////////////////////
@@ -119,13 +109,13 @@
 
   /** Initialize elasticity integrator.
    *
-   * @param mesh PETSc mesh to initialize.
+   * @param mesh Finite-element mesh to initialize.
    * @param integrator ElasticityIntegrator to initialize.
    * @param fields Solution fields.
    */
-  void _initialize(ALE::Obj<Mesh>* mesh,
+  void _initialize(topology::Mesh* mesh,
 		   ElasticityImplicit* const integrator,
-		   topology::FieldsManager* const fields);
+		   topology::SolutionFields* const fields);
 
 }; // class TestElasticityImplicit
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DLinear.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DLinear.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DLinear.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -16,7 +16,8 @@
 
 #include "data/ElasticityImplicitData1DLinear.hh"
 
-#include "pylith/feassemble/Quadrature1D.hh" // USES Quadrature1D
+#include "pylith/topology/Mesh.hh" // USES Quadrature<Mesh>
+#include "pylith/feassemble/Quadrature.hh" // USES Quadrature
 #include "pylith/feassemble/GeometryLine1D.hh" // USES GeometryLine1D
 #include "pylith/materials/ElasticStrain1D.hh" // USES ElasticStrain1D
 
@@ -28,8 +29,9 @@
 void
 pylith::feassemble::TestElasticityImplicit1DLinear::setUp(void)
 { // setUp
+  TestElasticityImplicit::setUp();
+
   _data = new ElasticityImplicitData1DLinear();
-  _quadrature = new Quadrature1D();
   _gravityField = 0;
   GeometryLine1D geometry;
   CPPUNIT_ASSERT(0 != _quadrature);

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DLinear.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DLinear.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DLinear.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -38,9 +38,10 @@
   // CPPUNIT TEST SUITE /////////////////////////////////////////////////
   CPPUNIT_TEST_SUITE( TestElasticityImplicit1DLinear );
 
-  CPPUNIT_TEST( testUpdateState );
+  CPPUNIT_TEST( testInitialize );
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
+  CPPUNIT_TEST( testUpdateStateVars );
 
   CPPUNIT_TEST_SUITE_END();
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DQuadratic.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DQuadratic.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DQuadratic.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -16,7 +16,8 @@
 
 #include "data/ElasticityImplicitData1DQuadratic.hh"
 
-#include "pylith/feassemble/Quadrature1D.hh" // USES Quadrature1D
+#include "pylith/topology/Mesh.hh" // USES Quadrature<Mesh>
+#include "pylith/feassemble/Quadrature.hh" // USES Quadrature
 #include "pylith/feassemble/GeometryLine1D.hh" // USES GeometryLine1D
 #include "pylith/materials/ElasticStrain1D.hh" // USES ElasticStrain1D
 
@@ -28,8 +29,9 @@
 void
 pylith::feassemble::TestElasticityImplicit1DQuadratic::setUp(void)
 { // setUp
+  TestElasticityImplicit::setUp();
+
   _data = new ElasticityImplicitData1DQuadratic();
-  _quadrature = new Quadrature1D();
   _gravityField = 0;
   GeometryLine1D geometry;
   CPPUNIT_ASSERT(0 != _quadrature);

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DQuadratic.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DQuadratic.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit1DQuadratic.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -38,9 +38,10 @@
   // CPPUNIT TEST SUITE /////////////////////////////////////////////////
   CPPUNIT_TEST_SUITE( TestElasticityImplicit1DQuadratic );
 
-  CPPUNIT_TEST( testUpdateState );
+  CPPUNIT_TEST( testInitialize );
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
+  CPPUNIT_TEST( testUpdateStateVars );
 
   CPPUNIT_TEST_SUITE_END();
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DLinear.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DLinear.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DLinear.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -16,7 +16,8 @@
 
 #include "data/ElasticityImplicitData2DLinear.hh"
 
-#include "pylith/feassemble/Quadrature2D.hh" // USES Quadrature2D
+#include "pylith/topology/Mesh.hh" // USES Quadrature<Mesh>
+#include "pylith/feassemble/Quadrature.hh" // USES Quadrature
 #include "pylith/feassemble/GeometryTri2D.hh" // USES GeometryTri2D
 #include "pylith/materials/ElasticPlaneStrain.hh" // USES ElasticPlaneStrain
 
@@ -28,8 +29,9 @@
 void
 pylith::feassemble::TestElasticityImplicit2DLinear::setUp(void)
 { // setUp
+  TestElasticityImplicit::setUp();
+
   _data = new ElasticityImplicitData2DLinear();
-  _quadrature = new Quadrature2D();
   _gravityField = 0;
   CPPUNIT_ASSERT(0 != _quadrature);
   GeometryTri2D geometry;

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DLinear.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DLinear.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DLinear.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -38,9 +38,10 @@
   // CPPUNIT TEST SUITE /////////////////////////////////////////////////
   CPPUNIT_TEST_SUITE( TestElasticityImplicit2DLinear );
 
-  CPPUNIT_TEST( testUpdateState );
+  CPPUNIT_TEST( testInitialize );
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
+  CPPUNIT_TEST( testUpdateStateVars );
 
   CPPUNIT_TEST_SUITE_END();
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DQuadratic.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DQuadratic.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DQuadratic.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -16,7 +16,8 @@
 
 #include "data/ElasticityImplicitData2DQuadratic.hh"
 
-#include "pylith/feassemble/Quadrature2D.hh" // USES Quadrature2D
+#include "pylith/topology/Mesh.hh" // USES Quadrature<Mesh>
+#include "pylith/feassemble/Quadrature.hh" // USES Quadrature
 #include "pylith/feassemble/GeometryTri2D.hh" // USES GeometryTri2D
 #include "pylith/materials/ElasticPlaneStrain.hh" // USES ElasticPlaneStrain
 
@@ -28,8 +29,9 @@
 void
 pylith::feassemble::TestElasticityImplicit2DQuadratic::setUp(void)
 { // setUp
+  TestElasticityImplicit::setUp();
+
   _data = new ElasticityImplicitData2DQuadratic();
-  _quadrature = new Quadrature2D();
   _gravityField = 0;
   CPPUNIT_ASSERT(0 != _quadrature);
   GeometryTri2D geometry;

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DQuadratic.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DQuadratic.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit2DQuadratic.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -38,9 +38,10 @@
   // CPPUNIT TEST SUITE /////////////////////////////////////////////////
   CPPUNIT_TEST_SUITE( TestElasticityImplicit2DQuadratic );
 
-  CPPUNIT_TEST( testUpdateState );
+  CPPUNIT_TEST( testInitialize );
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
+  CPPUNIT_TEST( testUpdateStateVars );
 
   CPPUNIT_TEST_SUITE_END();
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DLinear.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DLinear.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DLinear.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -16,7 +16,8 @@
 
 #include "data/ElasticityImplicitData3DLinear.hh"
 
-#include "pylith/feassemble/Quadrature3D.hh" // USES Quadrature3D
+#include "pylith/topology/Mesh.hh" // USES Quadrature<Mesh>
+#include "pylith/feassemble/Quadrature.hh" // USES Quadrature
 #include "pylith/feassemble/GeometryTet3D.hh" // USES GeometryTet3D
 #include "pylith/materials/ElasticIsotropic3D.hh" // USES ElasticIsotropic3D
 
@@ -28,8 +29,9 @@
 void
 pylith::feassemble::TestElasticityImplicit3DLinear::setUp(void)
 { // setUp
+  TestElasticityImplicit::setUp();
+
   _data = new ElasticityImplicitData3DLinear();
-  _quadrature = new Quadrature3D();
   _gravityField = 0;
   CPPUNIT_ASSERT(0 != _quadrature);
   GeometryTet3D geometry;

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DLinear.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DLinear.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DLinear.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -38,9 +38,10 @@
   // CPPUNIT TEST SUITE /////////////////////////////////////////////////
   CPPUNIT_TEST_SUITE( TestElasticityImplicit3DLinear );
 
-  CPPUNIT_TEST( testUpdateState );
+  CPPUNIT_TEST( testInitialize );
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
+  CPPUNIT_TEST( testUpdateStateVars );
 
   CPPUNIT_TEST_SUITE_END();
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DQuadratic.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DQuadratic.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DQuadratic.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -16,7 +16,8 @@
 
 #include "data/ElasticityImplicitData3DQuadratic.hh"
 
-#include "pylith/feassemble/Quadrature3D.hh" // USES Quadrature3D
+#include "pylith/topology/Mesh.hh" // USES Quadrature<Mesh>
+#include "pylith/feassemble/Quadrature.hh" // USES Quadrature
 #include "pylith/feassemble/GeometryTet3D.hh" // USES GeometryTet3D
 #include "pylith/materials/ElasticIsotropic3D.hh" // USES ElasticIsotropic3D
 
@@ -28,8 +29,9 @@
 void
 pylith::feassemble::TestElasticityImplicit3DQuadratic::setUp(void)
 { // setUp
+  TestElasticityImplicit::setUp();
+
   _data = new ElasticityImplicitData3DQuadratic();
-  _quadrature = new Quadrature3D();
   _gravityField = 0;
   CPPUNIT_ASSERT(0 != _quadrature);
   GeometryTet3D geometry;

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DQuadratic.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DQuadratic.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicit3DQuadratic.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -38,9 +38,10 @@
   // CPPUNIT TEST SUITE /////////////////////////////////////////////////
   CPPUNIT_TEST_SUITE( TestElasticityImplicit3DQuadratic );
 
-  CPPUNIT_TEST( testUpdateState );
+  CPPUNIT_TEST( testInitialize );
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
+  CPPUNIT_TEST( testUpdateStateVars );
 
   CPPUNIT_TEST_SUITE_END();
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DLinear.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DLinear.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DLinear.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -16,7 +16,8 @@
 
 #include "data/ElasticityImplicitGravData1DLinear.hh"
 
-#include "pylith/feassemble/Quadrature1D.hh" // USES Quadrature1D
+#include "pylith/topology/Mesh.hh" // USES Quadrature<Mesh>
+#include "pylith/feassemble/Quadrature.hh" // USES Quadrature
 #include "pylith/feassemble/GeometryLine1D.hh" // USES GeometryLine1D
 #include "pylith/materials/ElasticStrain1D.hh" // USES ElasticStrain1D
 #include "spatialdata/spatialdb/GravityField.hh" // USES GravityField
@@ -29,8 +30,9 @@
 void
 pylith::feassemble::TestElasticityImplicitGrav1DLinear::setUp(void)
 { // setUp
+  TestElasticityImplicit::setUp();
+
   _data = new ElasticityImplicitGravData1DLinear();
-  _quadrature = new Quadrature1D();
   _gravityField = new spatialdata::spatialdb::GravityField();
   CPPUNIT_ASSERT(0 != _quadrature);
   CPPUNIT_ASSERT(0 != _gravityField);

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DLinear.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DLinear.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DLinear.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -38,9 +38,10 @@
   // CPPUNIT TEST SUITE /////////////////////////////////////////////////
   CPPUNIT_TEST_SUITE( TestElasticityImplicitGrav1DLinear );
 
-  CPPUNIT_TEST( testUpdateState );
+  CPPUNIT_TEST( testInitialize );
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
+  CPPUNIT_TEST( testUpdateStateVars );
 
   CPPUNIT_TEST_SUITE_END();
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DQuadratic.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DQuadratic.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DQuadratic.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -16,7 +16,8 @@
 
 #include "data/ElasticityImplicitGravData1DQuadratic.hh"
 
-#include "pylith/feassemble/Quadrature1D.hh" // USES Quadrature1D
+#include "pylith/topology/Mesh.hh" // USES Quadrature<Mesh>
+#include "pylith/feassemble/Quadrature.hh" // USES Quadrature
 #include "pylith/feassemble/GeometryLine1D.hh" // USES GeometryLine1D
 #include "pylith/materials/ElasticStrain1D.hh" // USES ElasticStrain1D
 #include "spatialdata/spatialdb/GravityField.hh" // USES GravityField
@@ -29,8 +30,9 @@
 void
 pylith::feassemble::TestElasticityImplicitGrav1DQuadratic::setUp(void)
 { // setUp
+  TestElasticityImplicit::setUp();
+
   _data = new ElasticityImplicitGravData1DQuadratic();
-  _quadrature = new Quadrature1D();
   _gravityField = new spatialdata::spatialdb::GravityField();
   CPPUNIT_ASSERT(0 != _quadrature);
   CPPUNIT_ASSERT(0 != _gravityField);

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DQuadratic.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DQuadratic.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav1DQuadratic.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -38,9 +38,10 @@
   // CPPUNIT TEST SUITE /////////////////////////////////////////////////
   CPPUNIT_TEST_SUITE( TestElasticityImplicitGrav1DQuadratic );
 
-  CPPUNIT_TEST( testUpdateState );
+  CPPUNIT_TEST( testInitialize );
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
+  CPPUNIT_TEST( testUpdateStateVars );
 
   CPPUNIT_TEST_SUITE_END();
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DLinear.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DLinear.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DLinear.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -16,7 +16,8 @@
 
 #include "data/ElasticityImplicitGravData2DLinear.hh"
 
-#include "pylith/feassemble/Quadrature2D.hh" // USES Quadrature2D
+#include "pylith/topology/Mesh.hh" // USES Quadrature<Mesh>
+#include "pylith/feassemble/Quadrature.hh" // USES Quadrature
 #include "pylith/feassemble/GeometryTri2D.hh" // USES GeometryTri2D
 #include "pylith/materials/ElasticPlaneStrain.hh" // USES ElasticPlaneStrain
 #include "spatialdata/spatialdb/GravityField.hh" // USES GravityField
@@ -29,8 +30,9 @@
 void
 pylith::feassemble::TestElasticityImplicitGrav2DLinear::setUp(void)
 { // setUp
+  TestElasticityImplicit::setUp();
+
   _data = new ElasticityImplicitGravData2DLinear();
-  _quadrature = new Quadrature2D();
   _gravityField = new spatialdata::spatialdb::GravityField();
   CPPUNIT_ASSERT(0 != _quadrature);
   CPPUNIT_ASSERT(0 != _gravityField);

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DLinear.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DLinear.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DLinear.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -38,9 +38,10 @@
   // CPPUNIT TEST SUITE /////////////////////////////////////////////////
   CPPUNIT_TEST_SUITE( TestElasticityImplicitGrav2DLinear );
 
-  CPPUNIT_TEST( testUpdateState );
+  CPPUNIT_TEST( testInitialize );
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
+  CPPUNIT_TEST( testUpdateStateVars );
 
   CPPUNIT_TEST_SUITE_END();
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DQuadratic.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DQuadratic.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DQuadratic.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -16,7 +16,8 @@
 
 #include "data/ElasticityImplicitGravData2DQuadratic.hh"
 
-#include "pylith/feassemble/Quadrature2D.hh" // USES Quadrature2D
+#include "pylith/topology/Mesh.hh" // USES Quadrature<Mesh>
+#include "pylith/feassemble/Quadrature.hh" // USES Quadrature
 #include "pylith/feassemble/GeometryTri2D.hh" // USES GeometryTri2D
 #include "pylith/materials/ElasticPlaneStrain.hh" // USES ElasticPlaneStrain
 #include "spatialdata/spatialdb/GravityField.hh" // USES GravityField
@@ -29,8 +30,9 @@
 void
 pylith::feassemble::TestElasticityImplicitGrav2DQuadratic::setUp(void)
 { // setUp
+  TestElasticityImplicit::setUp();
+
   _data = new ElasticityImplicitGravData2DQuadratic();
-  _quadrature = new Quadrature2D();
   _gravityField = new spatialdata::spatialdb::GravityField();
   CPPUNIT_ASSERT(0 != _quadrature);
   CPPUNIT_ASSERT(0 != _gravityField);

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DQuadratic.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DQuadratic.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav2DQuadratic.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -38,9 +38,10 @@
   // CPPUNIT TEST SUITE /////////////////////////////////////////////////
   CPPUNIT_TEST_SUITE( TestElasticityImplicitGrav2DQuadratic );
 
-  CPPUNIT_TEST( testUpdateState );
+  CPPUNIT_TEST( testInitialize );
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
+  CPPUNIT_TEST( testUpdateStateVars );
 
   CPPUNIT_TEST_SUITE_END();
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DLinear.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DLinear.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DLinear.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -16,6 +16,8 @@
 
 #include "data/ElasticityImplicitGravData3DLinear.hh"
 
+#include "pylith/topology/Mesh.hh" // USES Quadrature<Mesh>
+#include "pylith/feassemble/Quadrature.hh" // USES Quadrature
 #include "pylith/feassemble/Quadrature3D.hh" // USES Quadrature3D
 #include "pylith/feassemble/GeometryTet3D.hh" // USES GeometryTet3D
 #include "pylith/materials/ElasticIsotropic3D.hh" // USES ElasticIsotropic3D
@@ -29,10 +31,9 @@
 void
 pylith::feassemble::TestElasticityImplicitGrav3DLinear::setUp(void)
 { // setUp
+  TestElasticityImplicit::setUp();
+
   _data = new ElasticityImplicitGravData3DLinear();
-  _quadrature = new Quadrature3D();
-  // _gravityField = 0;
-  // spatialdata::spatialdb::GravityField* _gravityField;
   _gravityField = new spatialdata::spatialdb::GravityField();
   CPPUNIT_ASSERT(0 != _quadrature);
   CPPUNIT_ASSERT(0 != _gravityField);

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DLinear.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DLinear.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DLinear.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -38,9 +38,10 @@
   // CPPUNIT TEST SUITE /////////////////////////////////////////////////
   CPPUNIT_TEST_SUITE( TestElasticityImplicitGrav3DLinear );
 
-  CPPUNIT_TEST( testUpdateState );
+  CPPUNIT_TEST( testInitialize );
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
+  CPPUNIT_TEST( testUpdateStateVars );
 
   CPPUNIT_TEST_SUITE_END();
 

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DQuadratic.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DQuadratic.cc	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DQuadratic.cc	2009-03-16 02:04:37 UTC (rev 14330)
@@ -16,6 +16,8 @@
 
 #include "data/ElasticityImplicitGravData3DQuadratic.hh"
 
+#include "pylith/topology/Mesh.hh" // USES Quadrature<Mesh>
+#include "pylith/feassemble/Quadrature.hh" // USES Quadrature
 #include "pylith/feassemble/Quadrature3D.hh" // USES Quadrature3D
 #include "pylith/feassemble/GeometryTet3D.hh" // USES GeometryTet3D
 #include "pylith/materials/ElasticIsotropic3D.hh" // USES ElasticIsotropic3D
@@ -29,10 +31,9 @@
 void
 pylith::feassemble::TestElasticityImplicitGrav3DQuadratic::setUp(void)
 { // setUp
+  TestElasticityImplicit::setUp();
+
   _data = new ElasticityImplicitGravData3DQuadratic();
-  _quadrature = new Quadrature3D();
-  // _gravityField = 0;
-  // spatialdata::spatialdb::GravityField* _gravityField;
   _gravityField = new spatialdata::spatialdb::GravityField();
   CPPUNIT_ASSERT(0 != _quadrature);
   CPPUNIT_ASSERT(0 != _gravityField);

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DQuadratic.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DQuadratic.hh	2009-03-16 01:52:41 UTC (rev 14329)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/feassemble/TestElasticityImplicitGrav3DQuadratic.hh	2009-03-16 02:04:37 UTC (rev 14330)
@@ -38,9 +38,10 @@
   // CPPUNIT TEST SUITE /////////////////////////////////////////////////
   CPPUNIT_TEST_SUITE( TestElasticityImplicitGrav3DQuadratic );
 
-  CPPUNIT_TEST( testUpdateState );
+  CPPUNIT_TEST( testInitialize );
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
+  CPPUNIT_TEST( testUpdateStateVars );
 
   CPPUNIT_TEST_SUITE_END();
 



More information about the CIG-COMMITS mailing list