[cig-commits] r18967 - in short/3D/PyLith/branches/v1.6-revisedfault: libsrc/pylith/faults unittests/libtests/faults unittests/libtests/faults/data

brad at geodynamics.org brad at geodynamics.org
Fri Sep 23 12:40:25 PDT 2011


Author: brad
Date: 2011-09-23 12:40:25 -0700 (Fri, 23 Sep 2011)
New Revision: 18967

Modified:
   short/3D/PyLith/branches/v1.6-revisedfault/libsrc/pylith/faults/FaultCohesiveKin.cc
   short/3D/PyLith/branches/v1.6-revisedfault/libsrc/pylith/faults/FaultCohesiveLagrange.cc
   short/3D/PyLith/branches/v1.6-revisedfault/libsrc/pylith/faults/FaultCohesiveLagrange.hh
   short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKin.cc
   short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKin.hh
   short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinHex8.hh
   short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinLine2.hh
   short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinQuad4.hh
   short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinQuad4e.hh
   short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTet4.hh
   short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTet4e.hh
   short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTet4f.hh
   short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTri3.hh
   short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTri3d.hh
   short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/data/CohesiveKinDataTri3d.cc
Log:
Transform slip to global coordinate system after computing slip from earthquake sources rather than inside integration routines. Removed TestFaultCohesiveKin::testUpdateStateVars() since updateStateVars() is empty.

Modified: short/3D/PyLith/branches/v1.6-revisedfault/libsrc/pylith/faults/FaultCohesiveKin.cc
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/libsrc/pylith/faults/FaultCohesiveKin.cc	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/libsrc/pylith/faults/FaultCohesiveKin.cc	2011-09-23 19:40:25 UTC (rev 18967)
@@ -140,6 +140,10 @@
       src->slip(&slip, t);
   } // for
 
+  // Transform slip from local (fault) coordinate system to global
+  // coordinate system
+  _slipFaultToGlobal();
+
   _logger->eventEnd(setupEvent);
 
   FaultCohesiveLagrange::integrateResidual(residual, t, fields);

Modified: short/3D/PyLith/branches/v1.6-revisedfault/libsrc/pylith/faults/FaultCohesiveLagrange.cc
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/libsrc/pylith/faults/FaultCohesiveLagrange.cc	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/libsrc/pylith/faults/FaultCohesiveLagrange.cc	2011-09-23 19:40:25 UTC (rev 18967)
@@ -218,7 +218,6 @@
   const int numBasis = _quadrature->numBasis();
   const int spaceDim = _quadrature->spaceDim();
   const int cellDim = _quadrature->cellDim();
-  const int orientationSize = spaceDim * spaceDim;
   assert(cellDim == spaceDim-1);
 
   // Get cohesive cell information
@@ -272,20 +271,11 @@
 				coordinatesCell.size(), &coordinatesCell[0]);
 
   double_array slipCell(numBasis*spaceDim);
-  double_array slipGlobalCell(numBasis*spaceDim);
   topology::Field<topology::SubMesh>& slip = _fields->get("slip");
   const ALE::Obj<RealSection>& slipSection = slip.section();
   assert(!slipSection.isNull());
   RestrictVisitor slipVisitor(*slipSection, slipCell.size(), &slipCell[0]);
 
-  double_array orientationCell(numBasis*orientationSize);
-  const ALE::Obj<RealSection>& orientationSection =
-      _fields->get("orientation").section();
-  assert(!orientationSection.isNull());
-  RestrictVisitor orientationVisitor(*orientationSection, 
-				     orientationCell.size(), 
-				     &orientationCell[0]);
-
   _logger->eventEnd(setupEvent);
 #if !defined(DETAILED_EVENT_LOGGING)
   _logger->eventBegin(computeEvent);
@@ -319,8 +309,6 @@
     dispTIncrVisitor.clear();
     sieveMesh->restrictClosure(*c_iter, dispTIncrVisitor);
 
-    orientationVisitor.clear();
-    faultSieveMesh->restrictClosure(*f_iter, orientationVisitor);
     slipVisitor.clear();
     faultSieveMesh->restrictClosure(*f_iter, slipVisitor);
 
@@ -338,18 +326,6 @@
     // solution increment.
     dispTpdtCell = dispTCell + dispTIncrCell;
 
-    // Compute slip in global coordinate system
-    slipGlobalCell = 0.0;
-    for (int iBasis=0; iBasis < numBasis; ++iBasis) {
-      const int iB = iBasis*spaceDim;
-      for (int iDim = 0; iDim < spaceDim; ++iDim) {
-	for (int kDim = 0; kDim < spaceDim; ++kDim) {
-	  slipGlobalCell[iB+iDim] += slipCell[iB+kDim] *
-	    orientationCell[iB*spaceDim + kDim*spaceDim + iDim];
-	} // for
-      } // for
-    } // for
-
     residualCell = 0.0;
 
     // Compute action for positive side of fault and Lagrange constraints
@@ -395,7 +371,7 @@
 	    // Lagrange constraint
 	    residualCell[iBL + iDim] += valIJ * 
 	      (dispTpdtCell[jBP + iDim] - dispTpdtCell[jBN + iDim] -
-	       slipGlobalCell[jBasis*spaceDim+iDim]);
+	       slipCell[jBasis*spaceDim+iDim]);
 
 #if 1
 	    std::cout << "iBasis: " << iBasis
@@ -403,7 +379,7 @@
 		      << ", iDim: " << iDim
 		      << ", valIJ: " << valIJ
 		      << ", jacobianDet: " << jacobianDet[iQuad]
-		      << ", slip: " << slipGlobalCell[jBasis*spaceDim+iDim]
+		      << ", slip: " << slipCell[jBasis*spaceDim+iDim]
 		      << ", dispP: " << dispTpdtCell[jBP + iDim]
 		      << ", dispN: " << dispTpdtCell[jBN + iDim]
 		      << ", dispL: " << dispTpdtCell[jBL + iDim]
@@ -1354,14 +1330,8 @@
 
   // Get cell information and setup storage for cell data
   const int spaceDim = _quadrature->spaceDim();
-  const int orientationSize = spaceDim * spaceDim;
 
   // Get section information
-  double_array orientationVertex(orientationSize);
-  const ALE::Obj<RealSection>& orientationSection =
-      _fields->get("orientation").section();
-  assert(!orientationSection.isNull());
-
   double_array slipVertex(spaceDim);
   const ALE::Obj<RealSection>& slipSection = _fields->get("slip").section();
   assert(!slipSection.isNull());
@@ -1440,10 +1410,6 @@
     _logger->eventBegin(restrictEvent);
 #endif
 
-    // Get orientations at fault cell's vertices.
-    orientationSection->restrictPoint(v_fault, &orientationVertex[0],
-				      orientationVertex.size());
-
     // Get slip at fault cell's vertices.
     slipSection->restrictPoint(v_fault, &slipVertex[0], slipVertex.size());
 
@@ -1470,6 +1436,7 @@
     _logger->eventBegin(computeEvent);
 #endif
 
+#if 0
     CALL_MEMBER_FN(*this, 
 		   adjustSolnLumpedFn)(&lagrangeTIncrVertex, 
 				       &dispTIncrVertexN, &dispTIncrVertexP,
@@ -1477,6 +1444,7 @@
 				       dispTVertexN, dispTVertexP,
 				       residualVertexN, residualVertexP,
 				       jacobianVertexN, jacobianVertexP);
+#endif
 
 #if defined(DETAILED_EVENT_LOGGING)
     _logger->eventEnd(computeEvent);
@@ -2045,6 +2013,60 @@
 } // _calcTractionsChange
 
 // ----------------------------------------------------------------------
+// Transform slip field from local (fault) coordinate system to
+// global coordinate system.
+void
+pylith::faults::FaultCohesiveLagrange::_slipFaultToGlobal(void)
+{ // _slipFaultToGlobal
+  assert(0 != _faultMesh);
+  assert(0 != _fields);
+
+  // Fiber dimension of tractions matches spatial dimension.
+  const int spaceDim = _quadrature->spaceDim();
+  double_array slipGlobalVertex(spaceDim);
+
+  // Get sections.
+  const ALE::Obj<RealSection>& slipSection =
+    _fields->get("slip").section();
+  assert(!slipSection.isNull());
+
+  slipSection->view("SLIP (FAULT)");
+
+  const ALE::Obj<RealSection>& orientationSection =
+    _fields->get("orientation").section();
+  assert(!orientationSection.isNull());
+
+  const int numVertices = _cohesiveVertices.size();
+  for (int iVertex=0; iVertex < numVertices; ++iVertex) {
+    const int v_fault = _cohesiveVertices[iVertex].fault;
+
+    assert(spaceDim == slipSection->getFiberDimension(v_fault));
+    const double* slipFaultVertex = slipSection->restrictPoint(v_fault);
+    assert(slipFaultVertex);
+
+    assert(spaceDim*spaceDim == orientationSection->getFiberDimension(v_fault));
+    const double* orientationVertex = orientationSection->restrictPoint(v_fault);
+    assert(orientationVertex);
+
+    slipGlobalVertex = 0.0;
+    for (int i=0; i < spaceDim; ++i)
+      for (int j=0; j < spaceDim; ++j)
+	slipGlobalVertex[i] += 
+	  orientationVertex[j*spaceDim+i] * slipFaultVertex[j];
+
+    assert(slipGlobalVertex.size() == 
+	   slipSection->getFiberDimension(v_fault));
+    slipSection->updatePoint(v_fault, &slipGlobalVertex[0]);
+  } // for
+  
+  PetscLogFlops(numVertices * (2*spaceDim*spaceDim) );
+
+#if 1 // DEBUGGING
+  slipSection->view("SLIP (GLOBAL)");
+#endif
+} // _slipFaultToGlobal
+
+// ----------------------------------------------------------------------
 // Allocate buffer for vector field.
 void
 pylith::faults::FaultCohesiveLagrange::_allocateBufferVectorField(void)

Modified: short/3D/PyLith/branches/v1.6-revisedfault/libsrc/pylith/faults/FaultCohesiveLagrange.hh
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/libsrc/pylith/faults/FaultCohesiveLagrange.hh	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/libsrc/pylith/faults/FaultCohesiveLagrange.hh	2011-09-23 19:40:25 UTC (rev 18967)
@@ -234,6 +234,11 @@
   void _calcTractionsChange(topology::Field<topology::SubMesh>* tractions,
           const topology::Field<topology::Mesh>& solution);
 
+  /** Transform slip field from local (fault) coordinate system to
+   * global coordinate system.
+   */
+  void _slipFaultToGlobal(void);
+
   /// Allocate buffer for vector field.
   void _allocateBufferVectorField(void);
 

Modified: short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKin.cc
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKin.cc	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKin.cc	2011-09-23 19:40:25 UTC (rev 18967)
@@ -612,113 +612,6 @@
 } // testAdjustSolnLumped
 
 // ----------------------------------------------------------------------
-// Test updateStateVars().
-void
-pylith::faults::TestFaultCohesiveKin::testUpdateStateVars(void)
-{ // testUpdateStateVars
-  CPPUNIT_ASSERT(_data);
-  CPPUNIT_ASSERT(_data->fieldT);
-  CPPUNIT_ASSERT(_data->verticesLagrange);
-
-  topology::Mesh mesh;
-  FaultCohesiveKin fault;
-  topology::SolutionFields fields(mesh);
-  _initialize(&mesh, &fault, &fields);
-
-  const int spaceDim = _data->spaceDim;
-  const ALE::Obj<RealSection>& dispSection = fields.get("disp(t)").section();
-  CPPUNIT_ASSERT(!dispSection.isNull());
-  { // setup disp
-    dispSection->zero();
-    
-    const ALE::Obj<SieveMesh>& sieveMesh = mesh.sieveMesh();
-    CPPUNIT_ASSERT(!sieveMesh.isNull());
-    const ALE::Obj<SieveMesh::label_sequence>& vertices = sieveMesh->depthStratum(0);
-    CPPUNIT_ASSERT(!vertices.isNull());
-    const SieveMesh::label_sequence::iterator verticesBegin = vertices->begin();
-    const SieveMesh::label_sequence::iterator verticesEnd = vertices->end();
-    int iVertex = 0;
-    for (SieveMesh::label_sequence::iterator v_iter=verticesBegin;
-	 v_iter != verticesEnd;
-	 ++v_iter, ++iVertex)
-      dispSection->updatePoint(*v_iter, &_data->fieldT[iVertex*spaceDim]);
-  } // setup disp
-  topology::Field<topology::Mesh>& residual = fields.get("residual");
-
-  const double t = 2.134;
-  const double dt = 0.01;
-  fault.useSolnIncr(false);
-  fault.timeStep(dt);
-  fault.integrateResidual(residual, t, &fields);
-  fault.updateStateVars(t, &fields);
-
-  CPPUNIT_ASSERT(0 != fault._faultMesh);
-  const ALE::Obj<SieveSubMesh>& faultSieveMesh = fault._faultMesh->sieveMesh();
-  CPPUNIT_ASSERT(!faultSieveMesh.isNull());
-  const ALE::Obj<SieveSubMesh::label_sequence>& vertices = 
-    faultSieveMesh->depthStratum(0);
-  CPPUNIT_ASSERT(!vertices.isNull());
-  const SieveSubMesh::label_sequence::iterator verticesBegin = vertices->begin();
-  const SieveSubMesh::label_sequence::iterator verticesEnd = vertices->end();
-  SieveSubMesh::renumbering_type& renumbering = faultSieveMesh->getRenumbering();
-
-  // Compute expected slip using eqsrcs
-  topology::Field<topology::SubMesh> slipE(*fault._faultMesh);
-  slipE.newSection(topology::FieldBase::VERTICES_FIELD, spaceDim);
-  slipE.allocate();
-  const ALE::Obj<RealSection> slipESection = slipE.section();
-  CPPUNIT_ASSERT(!slipESection.isNull());
-
-  const ALE::Obj<RealSection> slipSection =
-    fault._fields->get("slip").section();
-  CPPUNIT_ASSERT(!slipSection.isNull());
-
-  const FaultCohesiveKin::srcs_type::const_iterator srcsEnd = fault._eqSrcs.end();
-  for (FaultCohesiveKin::srcs_type::iterator s_iter=fault._eqSrcs.begin(); 
-       s_iter != srcsEnd; 
-       ++s_iter) {
-    EqKinSrc* src = s_iter->second;
-    CPPUNIT_ASSERT(0 != src);
-    if (t >= src->originTime())
-      src->slip(&slipE, t);
-  } // for
-
-  int iVertex = 0;
-  const double tolerance = 1.0e-06;
-  for (SieveSubMesh::label_sequence::iterator v_iter=verticesBegin;
-       v_iter != verticesEnd;
-       ++v_iter, ++iVertex) {
-    const SieveSubMesh::point_type meshVertex = _data->verticesLagrange[iVertex];
-    bool found = false;
-    for(SieveSubMesh::renumbering_type::const_iterator r_iter = renumbering.begin();
-	r_iter != renumbering.end();
-	++r_iter) {
-      if (r_iter->second == *v_iter) {
-        found = true;
-        break;
-      } // if
-    } // for
-    CPPUNIT_ASSERT(found);
-
-    // Check _slip
-    int fiberDim = slipSection->getFiberDimension(*v_iter);
-    CPPUNIT_ASSERT_EQUAL(spaceDim, fiberDim);
-    const double* slipV = slipSection->restrictPoint(*v_iter);
-    CPPUNIT_ASSERT(0 != slipV);
-
-    const double* slipE = slipESection->restrictPoint(*v_iter);
-    CPPUNIT_ASSERT(0 != slipE);
-
-    for (int iDim=0; iDim < spaceDim; ++iDim) {
-      if (slipE[iDim] > 1.0) 
-	CPPUNIT_ASSERT_DOUBLES_EQUAL(1.0, slipV[iDim]/slipE[iDim], tolerance);
-      else
-	CPPUNIT_ASSERT_DOUBLES_EQUAL(slipE[iDim], slipV[iDim], tolerance);
-    } // for
-  } // for
-} // testUpdateStateVars
-
-// ----------------------------------------------------------------------
 // Test calcTractionsChange().
 void
 pylith::faults::TestFaultCohesiveKin::testCalcTractionsChange(void)

Modified: short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKin.hh
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKin.hh	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKin.hh	2011-09-23 19:40:25 UTC (rev 18967)
@@ -107,9 +107,6 @@
   /// Test adjustSolnLumped().
   void testAdjustSolnLumped(void);
 
-  /// Test updateStateVars().
-  void testUpdateStateVars(void);
-
   /// Test _calcTractionsChange().
   void testCalcTractionsChange(void);
 

Modified: short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinHex8.hh
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinHex8.hh	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinHex8.hh	2011-09-23 19:40:25 UTC (rev 18967)
@@ -48,7 +48,6 @@
   CPPUNIT_TEST( testIntegrateJacobian );
   CPPUNIT_TEST( testIntegrateJacobianLumped );
   CPPUNIT_TEST( testAdjustSolnLumped );
-  CPPUNIT_TEST( testUpdateStateVars );
   CPPUNIT_TEST( testCalcTractionsChange );
   CPPUNIT_TEST( testSplitField );
 

Modified: short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinLine2.hh
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinLine2.hh	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinLine2.hh	2011-09-23 19:40:25 UTC (rev 18967)
@@ -48,7 +48,6 @@
   CPPUNIT_TEST( testIntegrateJacobian );
   CPPUNIT_TEST( testIntegrateJacobianLumped );
   CPPUNIT_TEST( testAdjustSolnLumped );
-  CPPUNIT_TEST( testUpdateStateVars );
   CPPUNIT_TEST( testCalcTractionsChange );
   CPPUNIT_TEST( testSplitField );
 

Modified: short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinQuad4.hh
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinQuad4.hh	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinQuad4.hh	2011-09-23 19:40:25 UTC (rev 18967)
@@ -48,7 +48,6 @@
   CPPUNIT_TEST( testIntegrateJacobian );
   CPPUNIT_TEST( testIntegrateJacobianLumped );
   CPPUNIT_TEST( testAdjustSolnLumped );
-  CPPUNIT_TEST( testUpdateStateVars );
   CPPUNIT_TEST( testCalcTractionsChange );
   CPPUNIT_TEST( testSplitField );
 

Modified: short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinQuad4e.hh
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinQuad4e.hh	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinQuad4e.hh	2011-09-23 19:40:25 UTC (rev 18967)
@@ -47,7 +47,6 @@
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
   CPPUNIT_TEST( testIntegrateJacobianLumped );
-  CPPUNIT_TEST( testUpdateStateVars );
   CPPUNIT_TEST( testCalcTractionsChange );
   CPPUNIT_TEST( testSplitField );
 

Modified: short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTet4.hh
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTet4.hh	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTet4.hh	2011-09-23 19:40:25 UTC (rev 18967)
@@ -48,7 +48,6 @@
   CPPUNIT_TEST( testIntegrateJacobian );
   CPPUNIT_TEST( testIntegrateJacobianLumped );
   CPPUNIT_TEST( testAdjustSolnLumped );
-  CPPUNIT_TEST( testUpdateStateVars );
   CPPUNIT_TEST( testCalcTractionsChange );
   CPPUNIT_TEST( testSplitField );
 

Modified: short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTet4e.hh
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTet4e.hh	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTet4e.hh	2011-09-23 19:40:25 UTC (rev 18967)
@@ -47,7 +47,6 @@
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
   CPPUNIT_TEST( testIntegrateJacobianLumped );
-  CPPUNIT_TEST( testUpdateStateVars );
   CPPUNIT_TEST( testCalcTractionsChange );
   CPPUNIT_TEST( testSplitField );
 

Modified: short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTet4f.hh
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTet4f.hh	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTet4f.hh	2011-09-23 19:40:25 UTC (rev 18967)
@@ -47,7 +47,6 @@
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
   CPPUNIT_TEST( testIntegrateJacobianLumped );
-  CPPUNIT_TEST( testUpdateStateVars );
   CPPUNIT_TEST( testCalcTractionsChange );
   CPPUNIT_TEST( testSplitField );
 

Modified: short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTri3.hh
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTri3.hh	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTri3.hh	2011-09-23 19:40:25 UTC (rev 18967)
@@ -48,7 +48,6 @@
   CPPUNIT_TEST( testIntegrateJacobian );
   CPPUNIT_TEST( testIntegrateJacobianLumped );
   CPPUNIT_TEST( testAdjustSolnLumped );
-  CPPUNIT_TEST( testUpdateStateVars );
   CPPUNIT_TEST( testCalcTractionsChange );
   CPPUNIT_TEST( testSplitField );
 

Modified: short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTri3d.hh
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTri3d.hh	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/TestFaultCohesiveKinTri3d.hh	2011-09-23 19:40:25 UTC (rev 18967)
@@ -47,7 +47,6 @@
   CPPUNIT_TEST( testIntegrateResidual );
   CPPUNIT_TEST( testIntegrateJacobian );
   CPPUNIT_TEST( testIntegrateJacobianLumped );
-  CPPUNIT_TEST( testUpdateStateVars );
   CPPUNIT_TEST( testCalcTractionsChange );
   CPPUNIT_TEST( testSplitField );
 

Modified: short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/data/CohesiveKinDataTri3d.cc
===================================================================
--- short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/data/CohesiveKinDataTri3d.cc	2011-09-23 17:57:19 UTC (rev 18966)
+++ short/3D/PyLith/branches/v1.6-revisedfault/unittests/libtests/faults/data/CohesiveKinDataTri3d.cc	2011-09-23 19:40:25 UTC (rev 18967)
@@ -196,14 +196,14 @@
 
 const double pylith::faults::CohesiveKinDataTri3d::_residual[] = {
   0.0,  0.0,
- -1.4142135623730949, -11.030865786510143, // 5
- -8.0,  -6.0, // 6
+ -0.5*(6.8+6.0 + 6.8+7.2), -0.5*(8.8+8.0 + 8.8+9.2), // 5
+ -0.5*(6.8+6.0), -0.5*(8.8+8.0), // 6
   0.0,  0.0,
- +7.2,  -9.2, // 8
+ -0.5*(6.8+7.2), -0.5*(8.8+9.2), // 8
   0.0,  0.0,
- +1.4142135623730949, +11.030865786510143, // 10
- +8.0, +6.0, // 11
- -7.2, +9.2, // 12
+ +0.5*(6.8+6.0 + 6.8+7.2), -0.5*(8.8+8.0 + 8.8+9.2), // 10
+ +0.5*(6.8+6.0), -0.5*(8.8+8.0), // 6
+ +0.5*(6.8+7.2), -0.5*(8.8+9.2), // 8
   0.0+1.89546413727, +0.70710678118654757+0.08241148423, // 13
   0.6+1.77538035254, 0.6+0.14794836271, // 14
  -0.6+1.59887481971,  0.6+0.19186497837, // 15
@@ -258,7 +258,7 @@
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- -0.70710678118654757, +0.70710678118654757, // 13
+ +2.0, 0.0, // 13
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0, // 5y
@@ -270,7 +270,7 @@
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- +0.70710678118654757, +0.70710678118654757, // 13
+  0.0,+2.0, // 13
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0, // 6x
@@ -283,7 +283,7 @@
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
-  0.0,+1.0, // 14
+ +1.0, 0.0, // 14
   0.0, 0.0,
   0.0, 0.0, // 6y
   0.0, 0.0,
@@ -295,7 +295,7 @@
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- +1.0, 0.0, // 14
+  0.0,+1.0, // 14
   0.0, 0.0,
   0.0, 0.0, // 7x
   0.0, 0.0,
@@ -332,7 +332,7 @@
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- -1.0, 0.0, // 15
+ +1.0, 0.0, // 15
   0.0, 0.0, // 8y
   0.0, 0.0,
   0.0, 0.0,
@@ -378,7 +378,7 @@
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- +0.70710678118654757, -0.70710678118654757, // 13
+ -2.0, 0.0, // 13
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0, // 10y
@@ -390,7 +390,7 @@
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- -0.70710678118654757, -0.70710678118654757, // 13
+  0.0,-2.0, // 13
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0, // 11x
@@ -403,7 +403,7 @@
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
-  0.0,-1.0, // 14
+ -1.0, 0.0, // 14
   0.0, 0.0,
   0.0, 0.0, // 11y
   0.0, 0.0,
@@ -415,7 +415,7 @@
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- -1.0, 0.0, // 14
+  0.0,-1.0, // 14
   0.0, 0.0,
   0.0, 0.0, // 12x
   0.0, 0.0,
@@ -428,7 +428,7 @@
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- +1.0, 0.0, // 15
+ -1.0, 0.0, // 15
   0.0, 0.0, // 12y
   0.0, 0.0,
   0.0, 0.0,
@@ -442,24 +442,24 @@
   0.0, 0.0,
   0.0,-1.0, // 15
   0.0, 0.0, // 13x
- -0.70710678118654757, +0.70710678118654757, // 5
+ +2.0, 0.0, // 5
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- +0.70710678118654757, -0.70710678118654757, // 10
+ -2.0, 0.0, // 10
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0, // 13y
- +0.70710678118654757, +0.70710678118654757, // 5
+  0.0,+2.0, // 5
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- -0.70710678118654757, -0.70710678118654757, // 10
+  0.0,-2.0, // 10
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
@@ -467,24 +467,24 @@
   0.0, 0.0,
   0.0, 0.0, // 14x
   0.0, 0.0,
-  0.0,+1.0, // 6
+ +1.0, 0.0, // 6
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
-  0.0,-1.0, // 11
+ -1.0, 0.0, // 11
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0, // 14y
   0.0, 0.0,
- +1.0, 0.0, // 6
+  0.0,+1.0, // 6
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- -1.0, 0.0, // 11
+  0.0,-1.0, // 11
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
@@ -493,11 +493,11 @@
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- -1.0, 0.0, // 8
+ +1.0, 0.0, // 8
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,
- +1.0, 0.0, // 12
+ -1.0, 0.0, // 12
   0.0, 0.0,
   0.0, 0.0,
   0.0, 0.0,



More information about the CIG-COMMITS mailing list