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

brad at geodynamics.org brad at geodynamics.org
Thu Feb 5 17:27:43 PST 2009


Author: brad
Date: 2009-02-05 17:27:43 -0800 (Thu, 05 Feb 2009)
New Revision: 14024

Added:
   short/3D/PyLith/branches/pylith-swig/pylith/topology/Field.py
Removed:
   short/3D/PyLith/branches/pylith-swig/pylith/topology/MeshField.py
   short/3D/PyLith/branches/pylith-swig/pylith/topology/SubMeshField.py
Modified:
   short/3D/PyLith/branches/pylith-swig/libsrc/Makefile.am
   short/3D/PyLith/branches/pylith-swig/libsrc/feassemble/Quadrature.cc
   short/3D/PyLith/branches/pylith-swig/libsrc/feassemble/Quadrature.hh
   short/3D/PyLith/branches/pylith-swig/libsrc/topology/SubMesh.cc
   short/3D/PyLith/branches/pylith-swig/libsrc/topology/SubMesh.hh
   short/3D/PyLith/branches/pylith-swig/libsrc/topology/SubMesh.icc
   short/3D/PyLith/branches/pylith-swig/libsrc/topology/topologyfwd.hh
   short/3D/PyLith/branches/pylith-swig/modulesrc/topology/topology.i
   short/3D/PyLith/branches/pylith-swig/pylith/topology/SubMesh.py
   short/3D/PyLith/branches/pylith-swig/unittests/libtests/topology/TestSubMesh.cc
Log:
Removed use of template for SubMesh (not needed if using only PyLith Mesh).

Modified: short/3D/PyLith/branches/pylith-swig/libsrc/Makefile.am
===================================================================
--- short/3D/PyLith/branches/pylith-swig/libsrc/Makefile.am	2009-02-06 00:09:22 UTC (rev 14023)
+++ short/3D/PyLith/branches/pylith-swig/libsrc/Makefile.am	2009-02-06 01:27:43 UTC (rev 14024)
@@ -34,6 +34,7 @@
 	meshio/PsetFileAscii.cc \
 	meshio/PsetFileBinary.cc \
 	topology/Mesh.cc \
+	topology/SubMesh.cc \
 	utils/EventLogger.cc
 
 # 	bc/BoundaryCondition.cc \

Modified: short/3D/PyLith/branches/pylith-swig/libsrc/feassemble/Quadrature.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/libsrc/feassemble/Quadrature.cc	2009-02-06 00:09:22 UTC (rev 14023)
+++ short/3D/PyLith/branches/pylith-swig/libsrc/feassemble/Quadrature.cc	2009-02-06 01:27:43 UTC (rev 14024)
@@ -248,7 +248,7 @@
 // Check determinant of Jacobian against minimum allowable value
 void
 pylith::feassemble::Quadrature::_checkJacobianDet(const double det,
-					   const Mesh::point_type& cell) const
+						  const int cell) const
 { // _checkJacobianDet
   if (det < _minJacobian) {
     std::ostringstream msg;
@@ -354,11 +354,8 @@
 
 // ----------------------------------------------------------------------
 void
-pylith::feassemble::Quadrature::retrieveGeometry(
-			      const ALE::Obj<Mesh>& mesh,
-			      const ALE::Obj<real_section_type>& coordinates,
-			      const Mesh::point_type& cell,
-			      const int c)
+pylith::feassemble::Quadrature::retrieveGeometry(const ALE::Obj<SieveMesh>& mesh,
+						 const SieveMesh::point_type& cell)
 { // retrieveGeometry
   _quadPtsPreV->clear();
   mesh->restrictClosure(cell, *_quadPtsPreV);

Modified: short/3D/PyLith/branches/pylith-swig/libsrc/feassemble/Quadrature.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/libsrc/feassemble/Quadrature.hh	2009-02-06 00:09:22 UTC (rev 14023)
+++ short/3D/PyLith/branches/pylith-swig/libsrc/feassemble/Quadrature.hh	2009-02-06 01:27:43 UTC (rev 14024)
@@ -223,14 +223,14 @@
    * @param cell Finite-element cell
    */
   virtual 
-  void computeGeometry(const real_section_type::value_type* vertCoords,
+  void computeGeometry(const double* vertCoords,
                        const int coordDim,
                        const SieveMesh::point_type& cell) = 0;
 
   template<typename mesh_type>
   void computeGeometry(const ALE::Obj<mesh_type>& mesh,
-                       const ALE::Obj<real_section_type>& coordinates,
-                       const SieveMesh::point_type& cell) {
+                       const ALE::Obj<mesh_type::real_section_type>& coordinates,
+                       const mesh_type::point_type& cell) {
     computeGeometry(mesh->restrictClosure(coordinates, cell),
                     coordinates->getFiberDimension(*mesh->depthStratum(0)->begin()),
                     cell);
@@ -271,10 +271,10 @@
   /* Check determinant of Jacobian against minimum allowable value.
    *
    * @param det Value of determinant of Jacobian
-   * @param cell Finite-element cell
+   * @param cell Label of finite-element cell
    */
   void _checkJacobianDet(const double det,
-			 const SieveMesh::point_type& cell) const;
+			 const int cell) const;
 
   /// Set entries in geometry arrays to zero.
   void _resetGeometry(void);

Modified: short/3D/PyLith/branches/pylith-swig/libsrc/topology/SubMesh.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/libsrc/topology/SubMesh.cc	2009-02-06 00:09:22 UTC (rev 14023)
+++ short/3D/PyLith/branches/pylith-swig/libsrc/topology/SubMesh.cc	2009-02-06 01:27:43 UTC (rev 14024)
@@ -12,14 +12,15 @@
 
 #include <portinfo>
 
+#include "SubMesh.hh" // implementation of class methods
+
 #include "spatialdata/geocoords/CoordSys.hh" // USES CoordSys
 
 #include <Selection.hh> // USES ALE::Selection
 
 // ----------------------------------------------------------------------
 // Default constructor
-template<typename mesh_type>
-pylith::topology::SubMesh<mesh_type>::SubMesh(void) :
+pylith::topology::SubMesh::SubMesh(void) :
   _coordsys(0),
   _debug(false)
 { // constructor
@@ -27,9 +28,8 @@
 
 // ----------------------------------------------------------------------
 // Constructor with mesh and label for vertices marking boundary.
-template<typename mesh_type>
-pylith::topology::SubMesh<mesh_type>::SubMesh(const mesh_type& mesh,
-					      const char* label) :
+pylith::topology::SubMesh::SubMesh(const Mesh& mesh,
+				   const char* label) :
   _coordsys(0),
   _debug(false)
 { // constructor
@@ -38,18 +38,16 @@
 
 // ----------------------------------------------------------------------
 // Default destructor
-template<typename mesh_type>
-pylith::topology::SubMesh<mesh_type>::~SubMesh(void)
+pylith::topology::SubMesh::~SubMesh(void)
 { // destructor
   delete _coordsys; _coordsys = 0;
 } // destructor
 
 // ----------------------------------------------------------------------
 // Create Sieve mesh.
-template<typename mesh_type>
 void
-pylith::topology::SubMesh<mesh_type>::createSubMesh(const mesh_type& mesh,
-						    const char* label)
+pylith::topology::SubMesh::createSubMesh(const Mesh& mesh,
+					 const char* label)
 { // createSieveMesh
   _mesh.destroy();
 
@@ -62,18 +60,9 @@
     msg << "Could not find group of points '" << label << "' in mesh.";
     throw std::runtime_error(msg.str());
   } // if
-#if 0
-  // QUESTION FOR MATT
-  // Why doesn't this work?
-  // SieveMesh and SieveSubMesh are typedefs in SubMesh.hh
   _mesh = 
     ALE::Selection<DomainSieveMesh>::submeshV<SieveMesh>(meshSieveMesh,
 							 groupField);
-#else
-  _mesh = 
-    ALE::Selection<ALE::IMesh<> >::submeshV<SieveMesh>(meshSieveMesh,
-						       groupField);
-#endif
   if (_mesh.isNull()) {
     std::ostringstream msg;
     msg << "Could not construct boundary mesh for boundary '"
@@ -84,15 +73,15 @@
 			meshSieveMesh->getRealSection("coordinates"));
 
   // Create the parallel overlap
-  ALE::Obj<typename SieveMesh::send_overlap_type> sendParallelMeshOverlap =
+  ALE::Obj<SieveMesh::send_overlap_type> sendParallelMeshOverlap =
     _mesh->getSendOverlap();
-  ALE::Obj<typename SieveMesh::recv_overlap_type> recvParallelMeshOverlap =
+  ALE::Obj<SieveMesh::recv_overlap_type> recvParallelMeshOverlap =
     _mesh->getRecvOverlap();
-  typename DomainSieveMesh::renumbering_type& renumbering = 
+  DomainSieveMesh::renumbering_type& renumbering = 
     meshSieveMesh->getRenumbering();
   //   Can I figure this out in a nicer way?
-  ALE::SetFromMap<std::map<typename DomainSieveMesh::point_type,
-    typename DomainSieveMesh::point_type> > globalPoints(renumbering);
+  ALE::SetFromMap<std::map<DomainSieveMesh::point_type,
+    DomainSieveMesh::point_type> > globalPoints(renumbering);
 
   ALE::OverlapBuilder<>::constructOverlap(globalPoints, renumbering,
 					  sendParallelMeshOverlap,
@@ -109,9 +98,8 @@
 
 // ----------------------------------------------------------------------
 // Initialize the finite-element mesh.
-template<typename mesh_type>
 void 
-pylith::topology::SubMesh<mesh_type>::initialize(void)
+pylith::topology::SubMesh::initialize(void)
 { // initialize
   if (0 != _coordsys)
     _coordsys->initialize();

Modified: short/3D/PyLith/branches/pylith-swig/libsrc/topology/SubMesh.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/libsrc/topology/SubMesh.hh	2009-02-06 00:09:22 UTC (rev 14023)
+++ short/3D/PyLith/branches/pylith-swig/libsrc/topology/SubMesh.hh	2009-02-06 01:27:43 UTC (rev 14024)
@@ -26,8 +26,9 @@
 #include "topologyfwd.hh" // forward declarations
 #include "spatialdata/geocoords/geocoordsfwd.hh" // forward declarations
 
+#include "Mesh.hh" // USES Mesh
+
 // SubMesh -----------------------------------------------------------------
-template<typename mesh_type>
 class pylith::topology::SubMesh
 { // SubMesh
   friend class TestSubMesh; // unit testing
@@ -37,12 +38,12 @@
 
   // Typedefs for basic types associated with Sieve mesh.
   // SieveMesh, RealSection, and IntSection are used in templated code.
-  typedef typename mesh_type::SieveSubMesh SieveMesh;
-  typedef typename mesh_type::RealSection  RealSection;
-  typedef typename mesh_type::IntSection IntSection;
+  typedef Mesh::SieveSubMesh SieveMesh;
+  typedef Mesh::RealSection  RealSection;
+  typedef Mesh::IntSection IntSection;
 
   // Sieve mesh for higher level domain (mesh, not submesh)
-  typedef typename mesh_type::SieveMesh DomainSieveMesh;
+  typedef Mesh::SieveMesh DomainSieveMesh;
 
 // PUBLIC METHODS ///////////////////////////////////////////////////////
 public :
@@ -55,7 +56,7 @@
    * @param mesh Finite-element mesh over domain.
    * @param label Label for vertices marking boundary.
    */
-  SubMesh(const mesh_type& mesh,
+  SubMesh(const Mesh& mesh,
 	  const char* label);
 
   /// Default destructor
@@ -66,7 +67,7 @@
    * @param mesh Finite-element mesh over domain.
    * @param label Label for vertices marking boundary.
    */
-  void createSubMesh(const mesh_type& mesh,
+  void createSubMesh(const Mesh& mesh,
 		     const char* label); 
 
   /** Get Sieve mesh.
@@ -136,7 +137,6 @@
 }; // SubMesh
 
 #include "SubMesh.icc"
-#include "SubMesh.cc"
 
 #endif // pylith_topology_submesh_hh
 

Modified: short/3D/PyLith/branches/pylith-swig/libsrc/topology/SubMesh.icc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/libsrc/topology/SubMesh.icc	2009-02-06 00:09:22 UTC (rev 14023)
+++ short/3D/PyLith/branches/pylith-swig/libsrc/topology/SubMesh.icc	2009-02-06 01:27:43 UTC (rev 14024)
@@ -15,68 +15,60 @@
 #else
 
 // Get Sieve mesh.
-template<typename mesh_type>
 inline
-const ALE::Obj<typename mesh_type::SieveSubMesh>&
-pylith::topology::SubMesh<mesh_type>::sieveMesh(void) const {
+const ALE::Obj<pylith::topology::Mesh::SieveSubMesh>&
+pylith::topology::SubMesh::sieveMesh(void) const {
   return _mesh;
 }
 
 // Get Sieve mesh.
-template<typename mesh_type>
 inline
-ALE::Obj<typename mesh_type::SieveSubMesh>&
-pylith::topology::SubMesh<mesh_type>::sieveMesh(void) {
+ALE::Obj<pylith::topology::Mesh::SieveSubMesh>&
+pylith::topology::SubMesh::sieveMesh(void) {
   return _mesh;
 }
 
 // Get coordinate system.
-template<typename mesh_type>
 inline
 const spatialdata::geocoords::CoordSys*
-pylith::topology::SubMesh<mesh_type>::coordsys(void) const {
+pylith::topology::SubMesh::coordsys(void) const {
   return _coordsys;
 }
 
 // Set debug flag.
-template<typename mesh_type>
 inline
 void
-pylith::topology::SubMesh<mesh_type>::debug(const bool value) {
+pylith::topology::SubMesh::debug(const bool value) {
   _debug = value;
   if (!_mesh.isNull())
     _mesh->setDebug(value);
 }
 
 // Get debug flag.
-template<typename mesh_type>
 inline
 bool
-pylith::topology::SubMesh<mesh_type>::debug(void) const {
+pylith::topology::SubMesh::debug(void) const {
   return _debug;
 }
 
 // Get dimension of mesh.
-template<typename mesh_type>
 inline
 int
-pylith::topology::SubMesh<mesh_type>::dimension(void) const {
+pylith::topology::SubMesh::dimension(void) const {
   return (!_mesh.isNull()) ? _mesh->getDimension() : 0;
 }
 
 // Get MPI communicator associated with mesh.
-template<typename mesh_type>
 inline
 const MPI_Comm
-pylith::topology::SubMesh<mesh_type>::comm(void) const {
+pylith::topology::SubMesh::comm(void) const {
   return (!_mesh.isNull()) ? _mesh->comm() : 0;
 }
     
 // Print mesh to stdout.
-template<typename mesh_type>
 inline
 void
-pylith::topology::SubMesh<mesh_type>::view(const char* label) {
+pylith::topology::SubMesh::view(const char* label) {
   _mesh->view(label);
 }
 

Modified: short/3D/PyLith/branches/pylith-swig/libsrc/topology/topologyfwd.hh
===================================================================
--- short/3D/PyLith/branches/pylith-swig/libsrc/topology/topologyfwd.hh	2009-02-06 00:09:22 UTC (rev 14023)
+++ short/3D/PyLith/branches/pylith-swig/libsrc/topology/topologyfwd.hh	2009-02-06 01:27:43 UTC (rev 14024)
@@ -25,7 +25,7 @@
   namespace topology {
 
     class Mesh;
-    template<typename mesh_type> class SubMesh;
+    class SubMesh;
     template<typename mesh_type> class Field;
 
 #if 0

Modified: short/3D/PyLith/branches/pylith-swig/modulesrc/topology/topology.i
===================================================================
--- short/3D/PyLith/branches/pylith-swig/modulesrc/topology/topology.i	2009-02-06 00:09:22 UTC (rev 14023)
+++ short/3D/PyLith/branches/pylith-swig/modulesrc/topology/topology.i	2009-02-06 01:27:43 UTC (rev 14024)
@@ -53,7 +53,6 @@
 
 
 // Template instatiation
-%template(MeshSubMesh) pylith::topology::SubMesh<pylith::topology::Mesh>;
 %template(MeshField) pylith::topology::Field<pylith::topology::Mesh>;
 %template(SubMeshField) pylith::topology::Field<pylith::topology::SubMesh<pylith::topology::Mesh> >;
 

Added: short/3D/PyLith/branches/pylith-swig/pylith/topology/Field.py
===================================================================
--- short/3D/PyLith/branches/pylith-swig/pylith/topology/Field.py	                        (rev 0)
+++ short/3D/PyLith/branches/pylith-swig/pylith/topology/Field.py	2009-02-06 01:27:43 UTC (rev 14024)
@@ -0,0 +1,57 @@
+#!/usr/bin/env python
+#
+# ----------------------------------------------------------------------
+#
+#                           Brad T. Aagaard
+#                        U.S. Geological Survey
+#
+# <LicenseText>
+#
+# ----------------------------------------------------------------------
+#
+
+## @file pylith/topology/Field.py
+##
+## @brief Python object for managing a vector field over vertices or
+## cells of a finite-element mesh.
+
+from topology import MeshField as ModuleMeshField
+from topology import SubMeshField as ModuleSubMeshField
+
+# ----------------------------------------------------------------------
+# MeshField class
+class MeshField(ModuleMeshField):
+  """
+  Python object for managing a vector field over vertices or cells of
+  a finite-element mesh.
+  """
+
+  # PUBLIC METHODS /////////////////////////////////////////////////////
+
+  def __init__(self, mesh):
+    """
+    Constructor.
+    """
+    ModuleMeshField.__init__(self, mesh)
+    return
+    
+
+# ----------------------------------------------------------------------
+# SubMeshField class
+class SubMeshField(ModuleSubMeshField):
+  """
+  Python object for managing a vector field over vertices or cells of
+  a lower-dimension finite-element mesh.
+  """
+
+  # PUBLIC METHODS /////////////////////////////////////////////////////
+
+  def __init__(self, mesh):
+    """
+    Constructor.
+    """
+    ModuleSubMeshField.__init__(self, mesh)
+    return
+    
+
+# End of file

Deleted: short/3D/PyLith/branches/pylith-swig/pylith/topology/MeshField.py
===================================================================
--- short/3D/PyLith/branches/pylith-swig/pylith/topology/MeshField.py	2009-02-06 00:09:22 UTC (rev 14023)
+++ short/3D/PyLith/branches/pylith-swig/pylith/topology/MeshField.py	2009-02-06 01:27:43 UTC (rev 14024)
@@ -1,37 +0,0 @@
-#!/usr/bin/env python
-#
-# ----------------------------------------------------------------------
-#
-#                           Brad T. Aagaard
-#                        U.S. Geological Survey
-#
-# <LicenseText>
-#
-# ----------------------------------------------------------------------
-#
-
-## @file pylith/topology/MeshField.py
-##
-## @brief Python object for managing a vector field over vertices or
-## cells of a finite-element mesh.
-
-from topology import MeshField as ModuleField
-
-# MeshField class
-class MeshField(ModuleField):
-  """
-  Python object for managing a vector field over vertices or cells of
-  a finite-element mesh.
-  """
-
-  # PUBLIC METHODS /////////////////////////////////////////////////////
-
-  def __init__(self, mesh):
-    """
-    Constructor.
-    """
-    ModuleField.__init__(self, mesh)
-    return
-    
-
-# End of file

Modified: short/3D/PyLith/branches/pylith-swig/pylith/topology/SubMesh.py
===================================================================
--- short/3D/PyLith/branches/pylith-swig/pylith/topology/SubMesh.py	2009-02-06 00:09:22 UTC (rev 14023)
+++ short/3D/PyLith/branches/pylith-swig/pylith/topology/SubMesh.py	2009-02-06 01:27:43 UTC (rev 14024)
@@ -15,7 +15,7 @@
 ## @brief Python Mesh for lower-dimension finite-element topology
 ## information.
 
-from topology import MeshSubMesh as ModuleSubMesh
+from topology import SubMesh as ModuleSubMesh
 
 # SubMesh class
 class SubMesh(ModuleSubMesh):

Deleted: short/3D/PyLith/branches/pylith-swig/pylith/topology/SubMeshField.py
===================================================================
--- short/3D/PyLith/branches/pylith-swig/pylith/topology/SubMeshField.py	2009-02-06 00:09:22 UTC (rev 14023)
+++ short/3D/PyLith/branches/pylith-swig/pylith/topology/SubMeshField.py	2009-02-06 01:27:43 UTC (rev 14024)
@@ -1,37 +0,0 @@
-#!/usr/bin/env python
-#
-# ----------------------------------------------------------------------
-#
-#                           Brad T. Aagaard
-#                        U.S. Geological Survey
-#
-# <LicenseText>
-#
-# ----------------------------------------------------------------------
-#
-
-## @file pylith/topology/SubMeshField.py
-##
-## @brief Python object for managing a vector field over vertices or
-## cells of a finite-element mesh.
-
-from topology import SubMeshField as ModuleField
-
-# SubMeshField class
-class SubMeshField(ModuleField):
-  """
-  Python object for managing a vector field over vertices or cells of
-  a lower-dimension finite-element mesh.
-  """
-
-  # PUBLIC METHODS /////////////////////////////////////////////////////
-
-  def __init__(self, mesh):
-    """
-    Constructor.
-    """
-    ModuleField.__init__(self, mesh)
-    return
-    
-
-# End of file

Modified: short/3D/PyLith/branches/pylith-swig/unittests/libtests/topology/TestSubMesh.cc
===================================================================
--- short/3D/PyLith/branches/pylith-swig/unittests/libtests/topology/TestSubMesh.cc	2009-02-06 00:09:22 UTC (rev 14023)
+++ short/3D/PyLith/branches/pylith-swig/unittests/libtests/topology/TestSubMesh.cc	2009-02-06 01:27:43 UTC (rev 14024)
@@ -57,7 +57,7 @@
 void
 pylith::topology::TestSubMesh::testConstructor(void)
 { // testConstructor
-  SubMesh<Mesh> mesh;
+  SubMesh mesh;
   CPPUNIT_ASSERT(mesh._mesh.isNull());
   CPPUNIT_ASSERT_EQUAL(0, mesh.dimension());
   CPPUNIT_ASSERT_EQUAL(false, mesh.debug());
@@ -72,7 +72,7 @@
   Mesh mesh2D;
   _buildMesh(&mesh2D);
   
-  SubMesh<Mesh> mesh(mesh2D, _TestSubMesh::label);
+  SubMesh mesh(mesh2D, _TestSubMesh::label);
   CPPUNIT_ASSERT(!mesh._mesh.isNull());
   CPPUNIT_ASSERT_EQUAL(_TestSubMesh::cellDim-1, mesh.dimension());
   CPPUNIT_ASSERT_EQUAL(PETSC_COMM_WORLD, mesh.comm());
@@ -98,7 +98,7 @@
   Mesh mesh2D;
   _buildMesh(&mesh2D);
 
-  SubMesh<Mesh> mesh(mesh2D, _TestSubMesh::label);
+  SubMesh mesh(mesh2D, _TestSubMesh::label);
   
   const ALE::Obj<Mesh::SieveMesh>& sieveMesh = mesh.sieveMesh();
   CPPUNIT_ASSERT(!sieveMesh.isNull());
@@ -113,7 +113,7 @@
   Mesh mesh2D;
   _buildMesh(&mesh2D);
   
-  SubMesh<Mesh> mesh;
+  SubMesh mesh;
   mesh.createSubMesh(mesh2D, _TestSubMesh::label);
   CPPUNIT_ASSERT(!mesh._mesh.isNull());
   CPPUNIT_ASSERT_EQUAL(_TestSubMesh::cellDim-1, mesh.dimension());
@@ -140,7 +140,7 @@
   Mesh mesh2D;
   _buildMesh(&mesh2D);
 
-  SubMesh<Mesh> mesh(mesh2D, _TestSubMesh::label);
+  SubMesh mesh(mesh2D, _TestSubMesh::label);
 
   CPPUNIT_ASSERT_EQUAL(_TestSubMesh::cellDim, mesh.coordsys()->spaceDim());
 } // testCoordsys
@@ -150,7 +150,7 @@
 void
 pylith::topology::TestSubMesh::testDebug(void)
 { // testDebug
-  SubMesh<Mesh> mesh;
+  SubMesh mesh;
   CPPUNIT_ASSERT_EQUAL(false, mesh.debug());
 
   mesh.debug(true);
@@ -162,12 +162,12 @@
 void
 pylith::topology::TestSubMesh::testDimension(void)
 { // testDimension
-  SubMesh<Mesh> mesh;
+  SubMesh mesh;
   CPPUNIT_ASSERT_EQUAL(0, mesh.dimension());
 
   Mesh mesh2D;
   _buildMesh(&mesh2D);
-  SubMesh<Mesh> mesh2(mesh2D, _TestSubMesh::label);
+  SubMesh mesh2(mesh2D, _TestSubMesh::label);
   CPPUNIT_ASSERT_EQUAL(_TestSubMesh::cellDim-1, mesh2.dimension());
 } // testDimension
 
@@ -176,7 +176,7 @@
 void
 pylith::topology::TestSubMesh::testComm(void)
 { // testComm
-  SubMesh<Mesh> mesh;
+  SubMesh mesh;
   CPPUNIT_ASSERT_EQUAL(0, mesh.comm());
 
   Mesh mesh2D;
@@ -193,7 +193,7 @@
 { // testInitialize
   Mesh mesh2D;
   _buildMesh(&mesh2D);
-  SubMesh<Mesh> mesh(mesh2D, _TestSubMesh::label);
+  SubMesh mesh(mesh2D, _TestSubMesh::label);
 
   mesh.initialize();
 } // testInitialize



More information about the CIG-COMMITS mailing list