[cig-commits] r16829 - in short/3D/PyLith/trunk: libsrc/feassemble unittests/libtests/bc/data unittests/libtests/faults/data

brad at geodynamics.org brad at geodynamics.org
Sat May 29 12:57:20 PDT 2010


Author: brad
Date: 2010-05-29 12:57:19 -0700 (Sat, 29 May 2010)
New Revision: 16829

Modified:
   short/3D/PyLith/trunk/libsrc/feassemble/GeometryLine3D.cc
   short/3D/PyLith/trunk/libsrc/feassemble/GeometryQuad2D.cc
   short/3D/PyLith/trunk/libsrc/feassemble/GeometryTet3D.cc
   short/3D/PyLith/trunk/libsrc/feassemble/GeometryTri2D.cc
   short/3D/PyLith/trunk/libsrc/feassemble/GeometryTri3D.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/unittests/libtests/bc/data/AbsorbingDampersDataTet4.cc
   short/3D/PyLith/trunk/unittests/libtests/bc/data/NeumannDataTet4.cc
   short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveDynDataTet4.cc
   short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinDataTet4.cc
   short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinDataTet4e.cc
   short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinDataTet4f.cc
   short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinSrcsDataTet4.cc
Log:
Switched to non-isoparametric quadrature (should be faster). Fixed unrealistic quadrature data for unit tests.

Modified: short/3D/PyLith/trunk/libsrc/feassemble/GeometryLine3D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/GeometryLine3D.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/libsrc/feassemble/GeometryLine3D.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -138,7 +138,7 @@
   assert(0 != det);
   assert(0 != vertices);
   assert(0 != location);
-  assert(2 == dim);
+  assert(3 == dim);
   assert(spaceDim() == dim);
 
   const double x0 = vertices[0];

Modified: short/3D/PyLith/trunk/libsrc/feassemble/GeometryQuad2D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/GeometryQuad2D.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/libsrc/feassemble/GeometryQuad2D.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -194,16 +194,16 @@
     const double p1 = 0.5 * (1.0 + ptsRef[iR++]);
     assert(0 <= p0 && p0 <= 1.0);
     assert(0 <= p1 && p1 <= 1.0);
-    const double j0 = (f_1 + f_01 * p1) / 2.0; 
-    const double j1 = (f_3 + f_01 * p0) / 2.0; 
-    const double j2 = (g_1 + g_01 * p1) / 2.0;
-    const double j3 = (g_3 + g_01 * p0) / 2.0; 
+    const double j00 = (f_1 + f_01 * p1) / 2.0; 
+    const double j01 = (f_3 + f_01 * p0) / 2.0; 
+    const double j10 = (g_1 + g_01 * p1) / 2.0;
+    const double j11 = (g_3 + g_01 * p0) / 2.0; 
 
-    jacobian[iJ++] = j0;
-    jacobian[iJ++] = j1;
-    jacobian[iJ++] = j2;
-    jacobian[iJ++] = j3;
-    det[i] = j0*j3 - j1*j2;
+    jacobian[iJ++] = j00;
+    jacobian[iJ++] = j01;
+    jacobian[iJ++] = j10;
+    jacobian[iJ++] = j11;
+    det[i] = j00*j11 - j01*j10;
   } // for
 
   PetscLogFlops(10 + npts*19);

Modified: short/3D/PyLith/trunk/libsrc/feassemble/GeometryTet3D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/GeometryTet3D.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/libsrc/feassemble/GeometryTet3D.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -225,6 +225,9 @@
     jacobian[iJ++] = j3;
     jacobian[iJ++] = j4;
     jacobian[iJ++] = j5;
+    jacobian[iJ++] = j6;
+    jacobian[iJ++] = j7;
+    jacobian[iJ++] = j8;
     det[i] = jdet;
   } // for
 

Modified: short/3D/PyLith/trunk/libsrc/feassemble/GeometryTri2D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/GeometryTri2D.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/libsrc/feassemble/GeometryTri2D.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -158,19 +158,17 @@
   const double y2 = vertices[5];
 
 
-  const double j1 = (x1 - x0) / 2.0;
-  const double j2 = (x2 - x0) / 2.0;
-  const double j3 = (y1 - y0) / 2.0;
-  const double j4 = (y2 - y0) / 2.0;
-  const double jdet = 
-    jacobian[0]*jacobian[3] - 
-    jacobian[1]*jacobian[2];
+  const double j00 = (x1 - x0) / 2.0;
+  const double j01 = (x2 - x0) / 2.0;
+  const double j10 = (y1 - y0) / 2.0;
+  const double j11 = (y2 - y0) / 2.0;
+  const double jdet = j00*j11 - j10*j01;
 
   for (int i=0, iJ=0; i < npts; ++i) {
-    jacobian[iJ++] = j1;
-    jacobian[iJ++] = j2;
-    jacobian[iJ++] = j3;
-    jacobian[iJ++] = j4;
+    jacobian[iJ++] = j00;
+    jacobian[iJ++] = j01;
+    jacobian[iJ++] = j10;
+    jacobian[iJ++] = j11;
     det[i] = jdet;
   } // for
 

Modified: short/3D/PyLith/trunk/libsrc/feassemble/GeometryTri3D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/GeometryTri3D.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/libsrc/feassemble/GeometryTri3D.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -183,28 +183,28 @@
   const double y2 = vertices[7];
   const double z2 = vertices[8];
 
-  const double j0 = (x1 - x0) / 2.0;
-  const double j1 = (x2 - x0) / 2.0;
+  const double j00 = (x1 - x0) / 2.0;
+  const double j01 = (x2 - x0) / 2.0;
 
-  const double j2 = (y1 - y0) / 2.0;
-  const double j3 = (y2 - y0) / 2.0;
+  const double j10 = (y1 - y0) / 2.0;
+  const double j11 = (y2 - y0) / 2.0;
 
-  const double j4 = (z1 - z0) / 2.0;
-  const double j5 = (z2 - z0) / 2.0;
+  const double j20 = (z1 - z0) / 2.0;
+  const double j21 = (z2 - z0) / 2.0;
 
-  const double jj00 = j0*j0 + j2*j2 + j4*j4;
-  const double jj10 = j0*j1 + j2*j3 + j4*j5;
+  const double jj00 = j00*j00 + j10*j10 + j20*j20;
+  const double jj10 = j00*j01 + j10*j11 + j20*j21;
   const double jj01 = jj10;
-  const double jj11 = j1*j1 + j3*j3 + j5*j5;
+  const double jj11 = j01*j01 + j11*j11 + j21*j21;
   const double jdet = sqrt(jj00*jj11 - jj01*jj10);
 
   for (int i=0, iJ=0; i < npts; ++i) {
-    jacobian[iJ++] = j0;
-    jacobian[iJ++] = j1;
-    jacobian[iJ++] = j2;
-    jacobian[iJ++] = j3;
-    jacobian[iJ++] = j4;
-    jacobian[iJ++] = j5;
+    jacobian[iJ++] = j00;
+    jacobian[iJ++] = j01;
+    jacobian[iJ++] = j10;
+    jacobian[iJ++] = j11;
+    jacobian[iJ++] = j20;
+    jacobian[iJ++] = j21;
     det[i] = jdet;
   } // for
 

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1D.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1D.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -21,7 +21,7 @@
 
 #include <cassert> // USES assert()
 
-#define ISOPARAMETRIC
+//#define ISOPARAMETRIC
 
 // ----------------------------------------------------------------------
 // Constructor
@@ -76,8 +76,8 @@
     for (int iBasis=0; iBasis < numBasis; ++iBasis)
       _quadPts[iQuadPt] += basis[iQ+iBasis]*coordinatesCell[iBasis];
 #else
-    geometry.coordsRefToGlobal(&_quadPts[iQuadPt], &quadPtsRef[iQuadPt],
-			       &coordinatesCell[0], spaceDim);
+    geometry.ptsRefToGlobal(&_quadPts[iQuadPt], &quadPtsRef[iQuadPt],
+			    &coordinatesCell[0], spaceDim, 1);
 #endif
 
 #if defined(ISOPARAMETRIC)
@@ -93,9 +93,8 @@
     _jacobianDet[iQuadPt] = _jacobian[iQuadPt];
 #else
     // Compute Jacobian and determinant of Jacobian at quadrature point
-    assert(0 != _geometry);
-    geometry->jacobian(&_jacobian[iQuadPt], &_jacobianDet[iQuadPt],
-		       &coordinatesCell[0], &quadPtsRef[iQuadPt], spaceDim);
+    geometry.jacobian(&_jacobian[iQuadPt], &_jacobianDet[iQuadPt],
+		      &coordinatesCell[0], &quadPtsRef[iQuadPt], spaceDim, 1);
     _checkJacobianDet(_jacobianDet[iQuadPt], cell);
 #endif
     

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din2D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din2D.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din2D.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -21,7 +21,7 @@
 
 #include <cassert> // USES assert()
 
-#define ISOPARAMETRIC
+//#define ISOPARAMETRIC
 
 // ----------------------------------------------------------------------
 // Constructor
@@ -81,9 +81,9 @@
 	  valueBasis * coordinatesCell[iBasis*spaceDim+iDim];
     } // for
 #else
-    geometry.coordsRefToGlobal(&_quadPts[iQuadPt*spaceDim],
-			       &quadPtsRef[iQuadPt*cellDim],
-			       &coordinatesCell[0], spaceDim);
+    geometry.ptsRefToGlobal(&_quadPts[iQuadPt*spaceDim],
+			    &quadPtsRef[iQuadPt*cellDim],
+			    &coordinatesCell[0], spaceDim, 1);
 #endif
 
 #if defined(ISOPARAMETRIC)
@@ -98,7 +98,7 @@
 	_jacobian[iQuadPt*spaceDim+iDim] += 
 	  deriv * coordinatesCell[iBasis*spaceDim+iDim];
     } // for
-
+    
     // Compute determinant of Jacobian at quadrature point
     // |J| = sqrt(transpose(J) J)
     double det = 0.0;
@@ -110,10 +110,11 @@
     _jacobianDet[iQuadPt] = det;
 #else
     // Compute Jacobian and determinant of Jacobian at quadrature point
-    geometry.jacobian(&_jacobian[iQuadPt*_cellDim*spaceDim],
+    geometry.jacobian(&_jacobian[iQuadPt*cellDim*spaceDim],
 		      &_jacobianDet[iQuadPt],
-		      &coordinatesCell0], &quadPtsRef[iQuadPt*cellDim], spaceDim);
-    _checkJacobianDet(_jacobianDet[iQuadPt], cell);
+		      &coordinatesCell[0], &quadPtsRef[iQuadPt*cellDim],
+		      spaceDim, 1);
+  _checkJacobianDet(_jacobianDet[iQuadPt], cell);
 #endif
 
     // Compute inverse of Jacobian at quadrature point

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din3D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din3D.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature1Din3D.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -21,7 +21,7 @@
 
 #include <cassert> // USES assert()
 
-#define ISOPARAMETRIC
+//#define ISOPARAMETRIC
 
 // ----------------------------------------------------------------------
 // Constructor
@@ -82,9 +82,9 @@
 	  valueBasis * coordinatesCell[iBasis*spaceDim+iDim];
     } // for
 #else
-    geometry.coordsRefToGlobal(&_quadPts[iQuadPt*spaceDim],
-			       &quadPtsRef[iQuadPt*cellDim],
-			       &coordinatesCell[0], spaceDim);
+    geometry.ptsRefToGlobal(&_quadPts[iQuadPt*spaceDim],
+			    &quadPtsRef[iQuadPt*cellDim],
+			    &coordinatesCell[0], spaceDim, 1);
 #endif
     
 #if defined(ISOPARAMETRIC)
@@ -115,7 +115,8 @@
     // Compute Jacobian and determinant of Jacobian at quadrature point
     geometry.jacobian(&_jacobian[iQuadPt*cellDim*spaceDim],
 		      &_jacobianDet[iQuadPt],
-		      &coordinatesCell[0], &quadPtsRef[iQuadPt*cellDim], spaceDim);
+		      &coordinatesCell[0], &quadPtsRef[iQuadPt*cellDim],
+		      spaceDim, 1);
     _checkJacobianDet(_jacobianDet[iQuadPt], cell);
 #endif
 

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2D.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2D.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -21,7 +21,7 @@
 
 #include <cassert> // USES assert()
 
-#define ISOPARAMETRIC
+//#define ISOPARAMETRIC
 
 // ----------------------------------------------------------------------
 // Constructor
@@ -79,9 +79,9 @@
 	  valueBasis * coordinatesCell[iBasis*spaceDim+iDim];
     } // for
 #else
-    geometry.coordsRefToGlobal(&_quadPts[iQuadPt*spaceDim],
-			       &quadPtsRef[iQuadPt*cellDim],
-			       &coordinatesCell[0], spaceDim);
+    geometry.ptsRefToGlobal(&_quadPts[iQuadPt*spaceDim],
+			    &quadPtsRef[iQuadPt*cellDim],
+			    &coordinatesCell[0], spaceDim, 1);
 #endif
 
 #if defined(ISOPARAMETRIC)
@@ -115,10 +115,17 @@
     _jacobianDet[iQuadPt] = det;
 #else
     // Compute Jacobian and determinant of Jacobian at quadrature point
+    const int iJ = iQuadPt*cellDim*spaceDim;
+    const int i00 = iJ + 0*spaceDim + 0;
+    const int i01 = iJ + 0*spaceDim + 1;
+    const int i10 = iJ + 1*spaceDim + 0;
+    const int i11 = iJ + 1*spaceDim + 1;
     geometry.jacobian(&_jacobian[iQuadPt*cellDim*spaceDim],
 		      &_jacobianDet[iQuadPt],
-		      &coordinatesCell[0], &quadPtsRef[iQuadPt*cellDim], spaceDim);
+		      &coordinatesCell[0], &quadPtsRef[iQuadPt*cellDim], 
+		      spaceDim, 1);
     _checkJacobianDet(_jacobianDet[iQuadPt], cell);
+    const double det = _jacobianDet[iQuadPt];
 #endif
 
     // Compute inverse of Jacobian at quadrature point

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2Din3D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2Din3D.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature2Din3D.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -23,7 +23,7 @@
 #include <cassert> // USES assert()
 #include <stdexcept> // USES std::runtime_error()
 
-#define ISOPARAMETRIC
+//#define ISOPARAMETRIC
 
 // ----------------------------------------------------------------------
 // Constructor
@@ -83,9 +83,9 @@
 	  valueBasis * coordinatesCell[iBasis*spaceDim+iDim];
     } // for
 #else
-    geometry.coordsRefToGlobal(&_quadPts[iQuadPt*spaceDim],
-			       &quadPtsRef[iQuadPt*cellDim],
-			       &coordinatesCell[0], spaceDim);
+    geometry.ptsRefToGlobal(&_quadPts[iQuadPt*spaceDim],
+			    &quadPtsRef[iQuadPt*cellDim],
+			    &coordinatesCell[0], spaceDim, 1);
 #endif
 
 #if defined(ISOPARAMETRIC)
@@ -136,9 +136,17 @@
     _jacobianDet[iQuadPt] = det;
 #else
     // Compute Jacobian and determinant of Jacobian at quadrature point
+    const int iJ = iQuadPt*cellDim*spaceDim;
+    const int i00 = iJ + 0*cellDim + 0;
+    const int i01 = iJ + 0*cellDim + 1;
+    const int i10 = iJ + 1*cellDim + 0;
+    const int i11 = iJ + 1*cellDim + 1;
+    const int i20 = iJ + 2*cellDim + 0;
+    const int i21 = iJ + 2*cellDim + 1;
     geometry.jacobian(&_jacobian[iQuadPt*cellDim*spaceDim],
 		      &_jacobianDet[iQuadPt],
-		      &coordinatesCell[0], &quadPtsRef[iQuadPt*cellDim], spaceDim);
+		      &coordinatesCell[0], &quadPtsRef[iQuadPt*cellDim], 
+		      spaceDim, 1);
     _checkJacobianDet(_jacobianDet[iQuadPt], cell);
 #endif
     

Modified: short/3D/PyLith/trunk/libsrc/feassemble/Quadrature3D.cc
===================================================================
--- short/3D/PyLith/trunk/libsrc/feassemble/Quadrature3D.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/libsrc/feassemble/Quadrature3D.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -21,7 +21,7 @@
 
 #include <cassert> // USES assert()
 
-#define ISOPARAMETRIC
+//#define ISOPARAMETRIC
 
 // ----------------------------------------------------------------------
 // Constructor
@@ -80,9 +80,9 @@
 	  valueBasis * coordinatesCell[iBasis*spaceDim+iDim];
     } // for
 #else
-    geometry.coordsRefToGlobal(&quadPts[iQuadPt*spaceDim],
-			       &quadPtsRef[iQuadPt*cellDim],
-			       &coordinatesCell[0], spaceDim);
+    geometry.ptsRefToGlobal(&_quadPts[iQuadPt*spaceDim],
+			    &quadPtsRef[iQuadPt*cellDim],
+			    &coordinatesCell[0], spaceDim, 1);
 #endif
     
 #if defined(ISOPARAMETRIC)
@@ -133,10 +133,22 @@
     _jacobianDet[iQuadPt] = det;
 #else
     // Compute Jacobian and determinant of Jacobian at quadrature point
+    const int iJ = iQuadPt*cellDim*spaceDim;
+    const int i00 = iJ + 0*spaceDim + 0;
+    const int i01 = iJ + 0*spaceDim + 1;
+    const int i02 = iJ + 0*spaceDim + 2;
+    const int i10 = iJ + 1*spaceDim + 0;
+    const int i11 = iJ + 1*spaceDim + 1;
+    const int i12 = iJ + 1*spaceDim + 2;
+    const int i20 = iJ + 2*spaceDim + 0;
+    const int i21 = iJ + 2*spaceDim + 1;
+    const int i22 = iJ + 2*spaceDim + 2;
     geometry.jacobian(&_jacobian[iQuadPt*cellDim*spaceDim],
 		      &_jacobianDet[iQuadPt],
-		      &coordinatesCell[0], &quadPtsRef[iQuadPt*cellDim], spaceDim);
+		      &coordinatesCell[0], &quadPtsRef[iQuadPt*cellDim],
+		      spaceDim, 1);
     _checkJacobianDet(_jacobianDet[iQuadPt], cell);
+    const double det = _jacobianDet[iQuadPt];
 #endif
     
     // Compute inverse of Jacobian at quadrature point

Modified: short/3D/PyLith/trunk/unittests/libtests/bc/data/AbsorbingDampersDataTet4.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/bc/data/AbsorbingDampersDataTet4.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/unittests/libtests/bc/data/AbsorbingDampersDataTet4.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -18,10 +18,10 @@
 const int pylith::bc::AbsorbingDampersDataTet4::_numBasis = 3;
 const int pylith::bc::AbsorbingDampersDataTet4::_numQuadPts = 1;
 const double pylith::bc::AbsorbingDampersDataTet4::_quadPts[] = {
-  0.3333333333333333, 0.3333333333333333
+  -0.3333333333333333, -0.3333333333333333
 };
 const double pylith::bc::AbsorbingDampersDataTet4::_quadWts[] = {
-  0.5,
+  2.0,
 };
 const double pylith::bc::AbsorbingDampersDataTet4::_basis[] = {
   0.3333333333333333,

Modified: short/3D/PyLith/trunk/unittests/libtests/bc/data/NeumannDataTet4.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/bc/data/NeumannDataTet4.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/unittests/libtests/bc/data/NeumannDataTet4.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -36,10 +36,10 @@
 const int pylith::bc::NeumannDataTet4::_numBasis = 3;
 const int pylith::bc::NeumannDataTet4::_numQuadPts = 1;
 const double pylith::bc::NeumannDataTet4::_quadPts[] = {
-  0.3333333333333333, 0.3333333333333333
+  -0.3333333333333333, -0.3333333333333333
 };
 const double pylith::bc::NeumannDataTet4::_quadWts[] = {
-  0.5,
+  2.0,
 };
 const double pylith::bc::NeumannDataTet4::_basis[] = {
   0.3333333333333333,

Modified: short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveDynDataTet4.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveDynDataTet4.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveDynDataTet4.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -42,11 +42,11 @@
 const int pylith::faults::CohesiveDynDataTet4::_numQuadPts = 1;
 
 const double pylith::faults::CohesiveDynDataTet4::_quadPts[] = {
-  3.33333333e-01,  3.33333333e-01,
+  -3.33333333e-01,  -3.33333333e-01,
 };
 
 const double pylith::faults::CohesiveDynDataTet4::_quadWts[] = {
-  5.00000000e-01,
+  2.0,
 };
 
 const double pylith::faults::CohesiveDynDataTet4::_basis[] = {

Modified: short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinDataTet4.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinDataTet4.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinDataTet4.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -41,11 +41,11 @@
 const int pylith::faults::CohesiveKinDataTet4::_numQuadPts = 1;
 
 const double pylith::faults::CohesiveKinDataTet4::_quadPts[] = {
-  3.33333333e-01,  3.33333333e-01,
+  -3.33333333e-01,  -3.33333333e-01,
 };
 
 const double pylith::faults::CohesiveKinDataTet4::_quadWts[] = {
-  5.00000000e-01,
+  2.0,
 };
 
 const double pylith::faults::CohesiveKinDataTet4::_basis[] = {

Modified: short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinDataTet4e.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinDataTet4e.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinDataTet4e.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -41,11 +41,11 @@
 const int pylith::faults::CohesiveKinDataTet4e::_numQuadPts = 1;
 
 const double pylith::faults::CohesiveKinDataTet4e::_quadPts[] = {
-  3.33333333e-01,  3.33333333e-01,
+  -3.33333333e-01,  -3.33333333e-01,
 };
 
 const double pylith::faults::CohesiveKinDataTet4e::_quadWts[] = {
-  5.00000000e-01,
+  2.0,
 };
 
 const double pylith::faults::CohesiveKinDataTet4e::_basis[] = {

Modified: short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinDataTet4f.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinDataTet4f.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinDataTet4f.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -41,11 +41,11 @@
 const int pylith::faults::CohesiveKinDataTet4f::_numQuadPts = 1;
 
 const double pylith::faults::CohesiveKinDataTet4f::_quadPts[] = {
-  3.33333333e-01,  3.33333333e-01,
+  -3.33333333e-01,  -3.33333333e-01,
 };
 
 const double pylith::faults::CohesiveKinDataTet4f::_quadWts[] = {
-  5.00000000e-01,
+  2.0,
 };
 
 const double pylith::faults::CohesiveKinDataTet4f::_basis[] = {

Modified: short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinSrcsDataTet4.cc
===================================================================
--- short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinSrcsDataTet4.cc	2010-05-29 04:50:24 UTC (rev 16828)
+++ short/3D/PyLith/trunk/unittests/libtests/faults/data/CohesiveKinSrcsDataTet4.cc	2010-05-29 19:57:19 UTC (rev 16829)
@@ -41,11 +41,11 @@
 const int pylith::faults::CohesiveKinSrcsDataTet4::_numQuadPts = 1;
 
 const double pylith::faults::CohesiveKinSrcsDataTet4::_quadPts[] = {
-  3.33333333e-01,  3.33333333e-01,
+  -3.33333333e-01,  -3.33333333e-01,
 };
 
 const double pylith::faults::CohesiveKinSrcsDataTet4::_quadWts[] = {
-  5.00000000e-01,
+  2.0,
 };
 
 const double pylith::faults::CohesiveKinSrcsDataTet4::_basis[] = {



More information about the CIG-COMMITS mailing list