[cig-commits] r12022 - in short/3D/PyLith/trunk: libsrc/bc libsrc/faults libsrc/feassemble modulesrc/solver unittests/libtests/bc unittests/libtests/faults unittests/libtests/feassemble unittests/pytests/faults

brad at geodynamics.org brad at geodynamics.org
Sat May 24 22:02:47 PDT 2008


Author: brad
Date: 2008-05-24 22:02:46 -0700 (Sat, 24 May 2008)
New Revision: 12022

Modified:
   short/3D/PyLith/trunk/libsrc/bc/AbsorbingDampers.cc
   short/3D/PyLith/trunk/libsrc/bc/DirichletBoundary.cc
   short/3D/PyLith/trunk/libsrc/bc/DirichletPoints.cc
   short/3D/PyLith/trunk/libsrc/bc/Neumann.cc
   short/3D/PyLith/trunk/libsrc/faults/FaultCohesiveKin.cc
   short/3D/PyLith/trunk/libsrc/feassemble/ElasticityExplicit.cc
   short/3D/PyLith/trunk/libsrc/feassemble/ElasticityImplicit.cc
   short/3D/PyLith/trunk/libsrc/feassemble/IntegratorElasticity.cc
   short/3D/PyLith/trunk/libsrc/feassemble/Quadrature.cc
   short/3D/PyLith/trunk/libsrc/feassemble/Quadrature0D.cc
   short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1D.cc
   short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din2D.cc
   short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din3D.cc
   short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2D.cc
   short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2Din3D.cc
   short/3D/PyLith/trunk/libsrc/feassemble/Quadrature3D.cc
   short/3D/PyLith/trunk/modulesrc/solver/solver.pyxe.src
   short/3D/PyLith/trunk/unittests/libtests/bc/TestAbsorbingDampers.cc
   short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletBoundary.cc
   short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletBoundaryMulti.cc
   short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletPoints.cc
   short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletPointsMulti.cc
   short/3D/PyLith/trunk/unittests/libtests/bc/TestNeumann.cc
   short/3D/PyLith/trunk/unittests/libtests/faults/TestBruneSlipFn.hh
   short/3D/PyLith/trunk/unittests/libtests/feassemble/TestElasticityExplicit.cc
   short/3D/PyLith/trunk/unittests/libtests/feassemble/TestElasticityImplicit.cc
   short/3D/PyLith/trunk/unittests/pytests/faults/TestFaultCohesiveKin.py
Log:
Updated name of restrict() to restrictClosure() or restrictSpace() based on updates to PETSc.

Modified: short/3D/PyLith/trunk/libsrc/bc/AbsorbingDampers.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/bc/AbsorbingDampers.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/bc/AbsorbingDampers.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -182,8 +182,8 @@
       dampingConstsLocal[spaceDim-1] = constNormal;
 
       // Compute normal/tangential orientation
-      _boundaryMesh->restrict(coordinates, *c_iter, 
-		     &cellVertices[0], cellVertices.size());
+      _boundaryMesh->restrictClosure(coordinates, *c_iter, 
+				     &cellVertices[0], cellVertices.size());
       memcpy(&quadPtRef[0], &quadPtsRef[iQuad*cellDim], cellDim*sizeof(double));
       cellGeometry.jacobian(&jacobian, &jacobianDet, cellVertices, quadPtRef);
       cellGeometry.orientation(&orientation, jacobian, jacobianDet, 
@@ -265,8 +265,10 @@
     _resetCellVector();
 
     // Restrict input fields to cell
-    _boundaryMesh->restrict(dispTpdt, *c_iter, &dispTpdtCell[0], cellVecSize);
-    _boundaryMesh->restrict(dispTmdt, *c_iter, &dispTmdtCell[0], cellVecSize);
+    _boundaryMesh->restrictClosure(dispTpdt, *c_iter, 
+				   &dispTpdtCell[0], cellVecSize);
+    _boundaryMesh->restrictClosure(dispTmdt, *c_iter, 
+				   &dispTmdtCell[0], cellVecSize);
     assert(numQuadPts*spaceDim == _dampingConsts->getFiberDimension(*c_iter));
     const real_section_type::value_type* dampingConstsCell = 
       _dampingConsts->restrictPoint(*c_iter);

Modified: short/3D/PyLith/trunk/libsrc/bc/DirichletBoundary.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/bc/DirichletBoundary.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/bc/DirichletBoundary.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -279,7 +279,7 @@
        v_iter != verticesEnd;
        ++v_iter) {
     assert(fiberDimension == field->getFiberDimension(*v_iter));
-    mesh->restrict(field, *v_iter, &fieldValues[0], fiberDimension);
+    mesh->restrictClosure(field, *v_iter, &fieldValues[0], fiberDimension);
 
     const real_section_type::value_type* values = 
       _values->restrictPoint(*v_iter);

Modified: short/3D/PyLith/trunk/libsrc/bc/DirichletPoints.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/bc/DirichletPoints.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/bc/DirichletPoints.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -250,7 +250,7 @@
   for (int iPoint=0; iPoint < numPoints; ++iPoint) {
     const Mesh::point_type point = _points[iPoint];
     assert(fiberDimension == field->getFiberDimension(point));
-    mesh->restrict(field, point, &allValues[0], fiberDimension);
+    mesh->restrictClosure(field, point, &allValues[0], fiberDimension);
     for (int iDOF=0; iDOF < numFixedDOF; ++iDOF)
       allValues[_fixedDOF[iDOF]] = _valuesInitial[iPoint*numFixedDOF+iDOF];
     if (t > _tRef)

Modified: short/3D/PyLith/trunk/libsrc/bc/Neumann.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/bc/Neumann.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/bc/Neumann.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -185,8 +185,8 @@
     // std::cout << "c_iter:  " << *c_iter << std::endl;
     _quadrature->computeGeometry(_boundaryMesh, coordinates, *c_iter);
     const double_array& quadPts = _quadrature->quadPts();
-    _boundaryMesh->restrict(coordinates, *c_iter,
-			    &cellVertices[0], cellVertices.size());
+    _boundaryMesh->restrictClosure(coordinates, *c_iter,
+				   &cellVertices[0], cellVertices.size());
     /* Debugging stuff
     std::cout << "cellVertices:  " << std::endl;
     for(int iTest = 0; iTest < numBasis; ++iTest) {
@@ -291,8 +291,8 @@
     _resetCellVector();
 
     // Restrict tractions to cell
-    _boundaryMesh->restrict(_tractions, *c_iter, 
-			    &tractionsCell[0], tractionsCell.size());
+    _boundaryMesh->restrictClosure(_tractions, *c_iter, 
+				   &tractionsCell[0], tractionsCell.size());
 
     // Get cell geometry information that depends on cell
     const double_array& basis = _quadrature->basis();

Modified: short/3D/PyLith/trunk/libsrc/faults/FaultCohesiveKin.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/faults/FaultCohesiveKin.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/faults/FaultCohesiveKin.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -163,22 +163,23 @@
 
     cellResidual = 0.0;
     // Get Lagrange constraint / fault cell pairings.
-    _faultMesh->restrict(_faultVertexCell, c_fault, &cellConstraintCell[0], 
-			 cellConstraintCell.size());
+    _faultMesh->restrictClosure(_faultVertexCell, c_fault,
+				&cellConstraintCell[0], 
+				cellConstraintCell.size());
     
     // Get orientations at fault cell's vertices.
-    _faultMesh->restrict(_orientation, c_fault, &cellOrientation[0], 
-		   cellOrientation.size());
+    _faultMesh->restrictClosure(_orientation, c_fault, &cellOrientation[0], 
+				cellOrientation.size());
     
     // Get pseudo stiffness at fault cell's vertices.
-    _faultMesh->restrict(_pseudoStiffness, c_fault, &cellStiffness[0], 
-			 cellStiffness.size());
+    _faultMesh->restrictClosure(_pseudoStiffness, c_fault, &cellStiffness[0], 
+				cellStiffness.size());
     
     // Get slip at fault cell's vertices.
-    _faultMesh->restrict(_slip, c_fault, &cellSlip[0], cellSlip.size());
+    _faultMesh->restrictClosure(_slip, c_fault, &cellSlip[0], cellSlip.size());
 
     // Get solution at cohesive cell's vertices.
-    mesh->restrict(solution, *c_iter, &cellSoln[0], cellSoln.size());
+    mesh->restrictClosure(solution, *c_iter, &cellSoln[0], cellSoln.size());
     
     for (int iConstraint=0; iConstraint < numConstraintVert; ++iConstraint) {
       // Skip setting values if they are set by another cell
@@ -298,16 +299,17 @@
 
     cellMatrix = 0.0;
     // Get Lagrange constraint / fault cell pairings.
-    _faultMesh->restrict(_faultVertexCell, c_fault, &cellConstraintCell[0], 
-			 cellConstraintCell.size());
+    _faultMesh->restrictClosure(_faultVertexCell, c_fault,
+				&cellConstraintCell[0], 
+				cellConstraintCell.size());
 
     // Get orientations at fault cell's vertices.
-    _faultMesh->restrict(_orientation, c_fault, &cellOrientation[0], 
-			 cellOrientation.size());
+    _faultMesh->restrictClosure(_orientation, c_fault, &cellOrientation[0], 
+				cellOrientation.size());
 
     // Get pseudo stiffness at fault cell's vertices.
-    _faultMesh->restrict(_pseudoStiffness, c_fault, &cellStiffness[0], 
-			 cellStiffness.size());
+    _faultMesh->restrictClosure(_pseudoStiffness, c_fault, &cellStiffness[0], 
+				cellStiffness.size());
     
     for (int iConstraint=0; iConstraint < numConstraintVert; ++iConstraint) {
       // Skip setting values if they are set by another cell
@@ -562,8 +564,8 @@
   for (Mesh::label_sequence::iterator c_iter=cells->begin();
        c_iter != cellsEnd;
        ++c_iter) {
-    _faultMesh->restrict(coordinates, *c_iter, 
-			 &faceVertices[0], faceVertices.size());
+    _faultMesh->restrictClosure(coordinates, *c_iter, 
+				&faceVertices[0], faceVertices.size());
 
     ALE::ISieveTraversal<sieve_type>::orientedClosure(*sieve, *c_iter, ncV);
     const int               coneSize = ncV.getSize();

Modified: short/3D/PyLith/trunk/libsrc/feassemble/ElasticityExplicit.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/ElasticityExplicit.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/feassemble/ElasticityExplicit.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -179,8 +179,8 @@
     // Reset element vector to zero
     _resetCellVector();
 
-    mesh->restrict(dispT, *c_iter, &dispTCell[0], cellVecSize);
-    mesh->restrict(dispTmdt, *c_iter, &dispTmdtCell[0], cellVecSize);
+    mesh->restrictClosure(dispT, *c_iter, &dispTCell[0], cellVecSize);
+    mesh->restrictClosure(dispTmdt, *c_iter, &dispTmdtCell[0], cellVecSize);
 
     // Get cell geometry information that depends on cell
     const double_array& basis = _quadrature->basis();

Modified: short/3D/PyLith/trunk/libsrc/feassemble/ElasticityImplicit.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/ElasticityImplicit.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/feassemble/ElasticityImplicit.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -187,7 +187,7 @@
 
     // Restrict input fields to cell
     PetscLogEventBegin(restrictEvent,0,0,0,0);
-    mesh->restrict(dispTBctpdt, *c_iter, &dispTBctpdtCell[0], cellVecSize);
+    mesh->restrictClosure(dispTBctpdt, *c_iter, &dispTBctpdtCell[0], cellVecSize);
     PetscLogEventEnd(restrictEvent,0,0,0,0);
 
     // Get cell geometry information that depends on cell
@@ -207,7 +207,7 @@
 
     // Compute action for element body forces
     if (!grav.isNull()) {
-      mesh->restrict(grav, *c_iter, &gravCell[0], cellVecSize);
+      mesh->restrictClosure(grav, *c_iter, &gravCell[0], cellVecSize);
       for (int iQuad=0; iQuad < numQuadPts; ++iQuad) {
 	const double wt = quadWts[iQuad] * jacobianDet[iQuad] * density[iQuad];
 	for (int iBasis=0, iQ=iQuad*numBasis*cellDim;
@@ -355,7 +355,7 @@
     _resetCellMatrix();
 
     // Restrict input fields to cell
-    mesh->restrict(dispTBctpdt, *c_iter, &dispTBctpdtCell[0], cellVecSize);
+    mesh->restrictClosure(dispTBctpdt, *c_iter, &dispTBctpdtCell[0], cellVecSize);
 
     // Get cell geometry information that depends on cell
     const double_array& basis = _quadrature->basis();

Modified: short/3D/PyLith/trunk/libsrc/feassemble/IntegratorElasticity.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/IntegratorElasticity.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/feassemble/IntegratorElasticity.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -143,7 +143,7 @@
     _quadrature->retrieveGeometry(mesh, coordinates, *c_iter, c_index);
 
     // Restrict input fields to cell
-    mesh->restrict(disp, *c_iter, &dispCell[0], cellVecSize);
+    mesh->restrictClosure(disp, *c_iter, &dispCell[0], cellVecSize);
 
     // Get cell geometry information that depends on cell
     const double_array& basisDeriv = _quadrature->basisDeriv();
@@ -345,7 +345,7 @@
     _quadrature->retrieveGeometry(mesh, coordinates, *c_iter, c_index);
     
     // Restrict input fields to cell
-    mesh->restrict(disp, *c_iter, &dispCell[0], cellVecSize);
+    mesh->restrictClosure(disp, *c_iter, &dispCell[0], cellVecSize);
     
     // Get cell geometry information that depends on cell
     const double_array& basisDeriv = _quadrature->basisDeriv();

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -332,27 +332,27 @@
 			      const int c)
 { // retrieveGeometry
   const real_section_type::value_type* values =
-    mesh->restrict(_quadPtsPre, cell);
+    mesh->restrictClosure(_quadPtsPre, cell);
   int size = _numQuadPts * _spaceDim;
   assert(size == _quadPtsPre->getFiberDimension(cell));
   memcpy(&_quadPts[0], &values[0], size*sizeof(double));
 
-  values = mesh->restrict(_jacobianPre, cell);
+  values = mesh->restrictClosure(_jacobianPre, cell);
   size = _numQuadPts * _cellDim * _spaceDim;
   assert(size == _jacobianPre->getFiberDimension(cell));
   memcpy(&_jacobian[0], &values[0], size*sizeof(double));
 
-  values = mesh->restrict(_jacobianDetPre, cell);
+  values = mesh->restrictClosure(_jacobianDetPre, cell);
   size = _numQuadPts;
   assert(size == _jacobianDetPre->getFiberDimension(cell));
   memcpy(&_jacobianDet[0], &values[0], size*sizeof(double));
 
-  values = mesh->restrict(_jacobianInvPre, cell);
+  values = mesh->restrictClosure(_jacobianInvPre, cell);
   size = _numQuadPts * _cellDim * _spaceDim;
   assert(size == _jacobianInvPre->getFiberDimension(cell));
   memcpy(&_jacobianInv[0], &values[0], size*sizeof(double));
 
-  values = mesh->restrict(_basisDerivPre, cell);
+  values = mesh->restrictClosure(_basisDerivPre, cell);
   size = _numQuadPts * _numBasis * _spaceDim;
   assert(size == _basisDerivPre->getFiberDimension(cell));
   memcpy(&_basisDeriv[0], &values[0], size*sizeof(double));

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature0D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature0D.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature0D.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -55,7 +55,7 @@
   
   // Get coordinates of cell's vertices
   const real_section_type::value_type* vertCoords = 
-    mesh->restrict(coordinates, cell);
+    mesh->restrictClosure(coordinates, cell);
   assert(1 == coordinates->getFiberDimension(*mesh->depthStratum(0)->begin()));
 
   for (int i=0; i < _spaceDim; ++i)

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1D.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1D.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -57,7 +57,7 @@
   
   // Get coordinates of cell's vertices
   const real_section_type::value_type* vertCoords = 
-    mesh->restrict(coordinates, cell);
+    mesh->restrictClosure(coordinates, cell);
   assert(1 == coordinates->getFiberDimension(*mesh->depthStratum(0)->begin()));
   
   // Loop over quadrature points

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din2D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din2D.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din2D.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -56,7 +56,7 @@
 
   // Get coordinates of cell's vertices
   const real_section_type::value_type* vertCoords = 
-    mesh->restrict(coordinates, cell);
+    mesh->restrictClosure(coordinates, cell);
   assert(2 == coordinates->getFiberDimension(*mesh->depthStratum(0)->begin()));
 
   // Loop over quadrature points

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din3D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din3D.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din3D.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -56,7 +56,7 @@
 
   // Get coordinates of cell's vertices
   const real_section_type::value_type* vertCoords = 
-    mesh->restrict(coordinates, cell);
+    mesh->restrictClosure(coordinates, cell);
   assert(3 == coordinates->getFiberDimension(*mesh->depthStratum(0)->begin()));
 
   // Loop over quadrature points

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2D.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2D.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -56,7 +56,7 @@
 
   // Get coordinates of cell's vertices
   const real_section_type::value_type* vertCoords = 
-    mesh->restrict(coordinates, cell);
+    mesh->restrictClosure(coordinates, cell);
   assert(2 == coordinates->getFiberDimension(*mesh->depthStratum(0)->begin()));
 
   // Loop over quadrature points

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2Din3D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2Din3D.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2Din3D.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -58,7 +58,7 @@
 
   // Get coordinates of cell's vertices
   const real_section_type::value_type* vertCoords = 
-    mesh->restrict(coordinates, cell);
+    mesh->restrictClosure(coordinates, cell);
   assert(3 == coordinates->getFiberDimension(*mesh->depthStratum(0)->begin()));
 
   // Loop over quadrature points

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature3D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature3D.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature3D.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -56,7 +56,7 @@
 
   // Get coordinates of cell's vertices
   const real_section_type::value_type* vertCoords = 
-    mesh->restrict(coordinates, cell);
+    mesh->restrictClosure(coordinates, cell);
   assert(3 == coordinates->getFiberDimension(*mesh->depthStratum(0)->begin()));
 
   // Loop over quadrature points

Modified: short/3D/PyLith/trunk/modulesrc/solver/solver.pyxe.src
===================================================================
--- short/3D/PyLith/trunk/modulesrc/solver/solver.pyxe.src	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/modulesrc/solver/solver.pyxe.src	2008-05-25 05:02:46 UTC (rev 12022)
@@ -283,7 +283,7 @@
       Vec localVec;
 
       err = VecCreateSeqWithArray(PETSC_COMM_SELF, (*fieldIn)->sizeWithBC(),
-                                  (*fieldIn)->restrict(), &localVec);CHKERRQ(err);
+                                  (*fieldIn)->restrictSpace(), &localVec);CHKERRQ(err);
       err = VecScatterBegin(scatter, localVec, vecIn, INSERT_VALUES, SCATTER_FORWARD
                             );CHKERRQ(err);
       err = VecScatterEnd(scatter, localVec, vecIn, INSERT_VALUES, SCATTER_FORWARD
@@ -293,7 +293,7 @@
                             DIFFERENT_NONZERO_PATTERN); CHKERRQ(err);
       err = KSPSolve(*ksp, vecIn, vecOut); CHKERRQ(err);
       err = VecCreateSeqWithArray(PETSC_COMM_SELF, (*fieldOut)->sizeWithBC(),
-                                (*fieldOut)->restrict(), &localVec);CHKERRQ(err);
+                                (*fieldOut)->restrictSpace(), &localVec);CHKERRQ(err);
       err = VecScatterBegin(scatter, vecOut, localVec, INSERT_VALUES, SCATTER_REVERSE
                             ); CHKERRQ(err);
       err = VecScatterEnd(scatter, vecOut, localVec, INSERT_VALUES, SCATTER_REVERSE
@@ -365,7 +365,7 @@
       Vec localVec;
 
       err = VecCreateSeqWithArray(PETSC_COMM_SELF, (*fieldIn)->sizeWithBC(),
-                                  (*fieldIn)->restrict(), &localVec);CHKERRQ(err);
+                                  (*fieldIn)->restrictSpace(), &localVec);CHKERRQ(err);
       err = VecScatterBegin(scatter, localVec, vecIn, INSERT_VALUES, SCATTER_FORWARD
                             );CHKERRQ(err);
       err = VecScatterEnd(scatter, localVec, vecIn, INSERT_VALUES, SCATTER_FORWARD
@@ -375,7 +375,7 @@
                             DIFFERENT_NONZERO_PATTERN); CHKERRQ(err);
       err = KSPSolve(*ksp, vecIn, vecOut); CHKERRQ(err);
       err = VecCreateSeqWithArray(PETSC_COMM_SELF, (*fieldOut)->sizeWithBC(),
-                                (*fieldOut)->restrict(), &localVec);CHKERRQ(err);
+                                (*fieldOut)->restrictSpace(), &localVec);CHKERRQ(err);
       err = VecScatterBegin(scatter, vecOut, localVec, INSERT_VALUES, SCATTER_REVERSE
                             ); CHKERRQ(err);
       err = VecScatterEnd(scatter, vecOut, localVec, INSERT_VALUES, SCATTER_REVERSE

Modified: short/3D/PyLith/trunk/unittests/libtests/bc/TestAbsorbingDampers.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/bc/TestAbsorbingDampers.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/unittests/libtests/bc/TestAbsorbingDampers.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -109,7 +109,7 @@
   const double* valsE = _data->dampingConsts;
 
   const int size = bc._dampingConsts->sizeWithBC();
-  const double* vals = bc._dampingConsts->restrict();
+  const double* vals = bc._dampingConsts->restrictSpace();
 
   //bc._dampingConsts->view("DAMPING CONSTS");
 
@@ -143,7 +143,7 @@
   const int totalNumVertices = mesh->depthStratum(0)->size();
   const int sizeE = _data->spaceDim * totalNumVertices;
 
-  const double* vals = residual->restrict();
+  const double* vals = residual->restrictSpace();
   const int size = residual->sizeWithBC();
   CPPUNIT_ASSERT_EQUAL(sizeE, size);
 

Modified: short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletBoundary.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletBoundary.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletBoundary.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -224,7 +224,7 @@
        ++v_iter) {
     const int fiberDim = field->getFiberDimension(*v_iter);
     const real_section_type::value_type* values = 
-      mesh->restrict(field, *v_iter);
+      mesh->restrictClosure(field, *v_iter);
     for (int i=0; i < fiberDim; ++i)
       CPPUNIT_ASSERT_DOUBLES_EQUAL(0.0, values[i], tolerance);
   } // for
@@ -255,7 +255,7 @@
        ++v_iter) {
     const int fiberDim = field->getFiberDimension(*v_iter);
     const real_section_type::value_type* values = 
-      mesh->restrict(field, *v_iter);
+      mesh->restrictClosure(field, *v_iter);
 
     if (*v_iter != _data->constrainedPoints[iConstraint] + offset) {
       // unconstrained point

Modified: short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletBoundaryMulti.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletBoundaryMulti.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletBoundaryMulti.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -147,7 +147,7 @@
        ++v_iter) {
     const int fiberDim = field->getFiberDimension(*v_iter);
     const real_section_type::value_type* values = 
-      mesh->restrict(field, *v_iter);
+      mesh->restrictClosure(field, *v_iter);
     for (int i=0; i < fiberDim; ++i)
       CPPUNIT_ASSERT_DOUBLES_EQUAL(0.0, values[i], tolerance);
   } // for
@@ -165,7 +165,7 @@
        ++v_iter) {
     const int fiberDim = field->getFiberDimension(*v_iter);
     const real_section_type::value_type* values = 
-      mesh->restrict(field, *v_iter);
+      mesh->restrictClosure(field, *v_iter);
     for (int iDOF=0; iDOF < fiberDim; ++iDOF)
       CPPUNIT_ASSERT_DOUBLES_EQUAL(_data->field[i++], values[iDOF], tolerance);
   } // for

Modified: short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletPoints.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletPoints.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletPoints.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -209,7 +209,7 @@
        ++v_iter) {
     const int fiberDim = field->getFiberDimension(*v_iter);
     const real_section_type::value_type* values = 
-      mesh->restrict(field, *v_iter);
+      mesh->restrictClosure(field, *v_iter);
     for (int i=0; i < fiberDim; ++i)
       CPPUNIT_ASSERT_DOUBLES_EQUAL(0.0, values[i], tolerance);
   } // for
@@ -240,7 +240,7 @@
        ++v_iter) {
     const int fiberDim = field->getFiberDimension(*v_iter);
     const real_section_type::value_type* values = 
-      mesh->restrict(field, *v_iter);
+      mesh->restrictClosure(field, *v_iter);
 
     if (*v_iter != _data->constrainedPoints[iConstraint] + offset) {
       // unconstrained point

Modified: short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletPointsMulti.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletPointsMulti.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/unittests/libtests/bc/TestDirichletPointsMulti.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -147,7 +147,7 @@
        ++v_iter) {
     const int fiberDim = field->getFiberDimension(*v_iter);
     const real_section_type::value_type* values = 
-      mesh->restrict(field, *v_iter);
+      mesh->restrictClosure(field, *v_iter);
     for (int i=0; i < fiberDim; ++i)
       CPPUNIT_ASSERT_DOUBLES_EQUAL(0.0, values[i], tolerance);
   } // for
@@ -165,7 +165,7 @@
        ++v_iter) {
     const int fiberDim = field->getFiberDimension(*v_iter);
     const real_section_type::value_type* values = 
-      mesh->restrict(field, *v_iter);
+      mesh->restrictClosure(field, *v_iter);
     for (int iDOF=0; iDOF < fiberDim; ++iDOF)
       CPPUNIT_ASSERT_DOUBLES_EQUAL(_data->field[i++], values[iDOF], tolerance);
   } // for

Modified: short/3D/PyLith/trunk/unittests/libtests/bc/TestNeumann.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/bc/TestNeumann.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/unittests/libtests/bc/TestNeumann.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -106,7 +106,7 @@
     const int numCorners = boundaryMesh->getNumCellCorners(*c_iter, boundaryDepth);
     CPPUNIT_ASSERT_EQUAL(_data->numCorners, numCorners);
 
-    boundaryMesh->restrict(coordinates, *c_iter, &cellVertices[0],
+    boundaryMesh->restrictClosure(coordinates, *c_iter, &cellVertices[0],
 			   cellVertices.size());
     double vert =0.0;
     double vertE =0.0;
@@ -136,7 +136,7 @@
       c_iter != cells->end();
       ++c_iter) {
 
-    bc._boundaryMesh->restrict(bc._tractions, *c_iter,
+    bc._boundaryMesh->restrictClosure(bc._tractions, *c_iter,
 			       &tractionsCell[0], tractionsCell.size());
 
     // std::cout << "Tractions at quadrature points: " << std::endl;
@@ -180,7 +180,7 @@
   const int totalNumVertices = mesh->depthStratum(0)->size();
   const int sizeE = _data->spaceDim * totalNumVertices;
 
-  const double* vals = residual->restrict();
+  const double* vals = residual->restrictSpace();
   const int size = residual->sizeWithBC();
   CPPUNIT_ASSERT_EQUAL(sizeE, size);
 

Modified: short/3D/PyLith/trunk/unittests/libtests/faults/TestBruneSlipFn.hh
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/faults/TestBruneSlipFn.hh	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/unittests/libtests/faults/TestBruneSlipFn.hh	2008-05-25 05:02:46 UTC (rev 12022)
@@ -97,10 +97,12 @@
    *
    * @param faultMesh Fault mesh.
    * @param slipfn Brune slip function.
+   * @param originTime Origin time for earthquake rupture.
    */
   static
   void _initialize(ALE::Obj<Mesh>* faultMesh,
-		   BruneSlipFn* slipfn);
+		   BruneSlipFn* slipfn,
+		   const double originTime);
 
   /** Test intialize().
    *

Modified: short/3D/PyLith/trunk/unittests/libtests/feassemble/TestElasticityExplicit.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/feassemble/TestElasticityExplicit.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/unittests/libtests/feassemble/TestElasticityExplicit.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -183,7 +183,7 @@
   const double* valsE = _data->valsResidual;
   const int sizeE = _data->spaceDim * _data->numVertices;
 
-  const double* vals = residual->restrict();
+  const double* vals = residual->restrictSpace();
   const int size = residual->sizeWithBC();
   CPPUNIT_ASSERT_EQUAL(sizeE, size);
 

Modified: short/3D/PyLith/trunk/unittests/libtests/feassemble/TestElasticityImplicit.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/feassemble/TestElasticityImplicit.cc	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/unittests/libtests/feassemble/TestElasticityImplicit.cc	2008-05-25 05:02:46 UTC (rev 12022)
@@ -174,7 +174,7 @@
   const double* valsE = _data->valsResidual;
   const int sizeE = _data->spaceDim * _data->numVertices;
 
-  const double* vals = residual->restrict();
+  const double* vals = residual->restrictSpace();
   const int size = residual->sizeWithBC();
   CPPUNIT_ASSERT_EQUAL(sizeE, size);
 

Modified: short/3D/PyLith/trunk/unittests/pytests/faults/TestFaultCohesiveKin.py
===================================================================
--- short/3D/PyLith/trunk/unittests/pytests/faults/TestFaultCohesiveKin.py	2008-05-25 05:01:45 UTC (rev 12021)
+++ short/3D/PyLith/trunk/unittests/pytests/faults/TestFaultCohesiveKin.py	2008-05-25 05:02:46 UTC (rev 12022)
@@ -270,6 +270,7 @@
 
     from pylith.faults.EqKinSrc import EqKinSrc
     eqsrc = EqKinSrc()
+    eqsrc.originTime = 1.23*second
     eqsrc.slipfn = slipfn
 
     ioMatDB = SimpleIOAscii()



More information about the cig-commits mailing list