[cig-commits] commit: Make all of the Shape stuff use "const Coord" instead of "Coord".

Mercurial hg at geodynamics.org
Sun Oct 16 05:18:46 PDT 2011


changeset:   628:217e3f32b7aa
tag:         tip
user:        Walter Landry <wlandry at caltech.edu>
date:        Sun Oct 16 05:16:40 2011 -0700
files:       Geometry/src/VectorMath.cxx Geometry/src/VectorMath.h Shape/src/BelowCosinePlane.cxx Shape/src/BelowCosinePlane.h Shape/src/BelowPlane.cxx Shape/src/BelowPlane.h Shape/src/Box.cxx Shape/src/Box.h Shape/src/ConvexHull.cxx Shape/src/ConvexHull.h Shape/src/Cylinder.cxx Shape/src/Cylinder.h Shape/src/Everywhere.cxx Shape/src/Everywhere.h Shape/src/Intersection.cxx Shape/src/Intersection.h Shape/src/PolygonShape.cxx Shape/src/PolygonShape.h Shape/src/PythonShape.cxx Shape/src/PythonShape.h Shape/src/ShapeClass.cxx Shape/src/ShapeClass.h Shape/src/Sphere.cxx Shape/src/Sphere.h Shape/src/Superellipsoid.cxx Shape/src/Superellipsoid.h Shape/src/Union.cxx Shape/src/Union.h Utils/src/MeshBoundaryShape.cxx Utils/src/MeshBoundaryShape.h Utils/tests/AllNodesVCSuite.cxx Utils/tests/CompositeVCSuite.cxx Utils/tests/WallVCSuite.cxx
description:
Make all of the Shape stuff use "const Coord" instead of "Coord".


diff -r b1fae62131ad -r 217e3f32b7aa Geometry/src/VectorMath.cxx
--- a/Geometry/src/VectorMath.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Geometry/src/VectorMath.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -51,7 +51,7 @@
 */
 
 /** (Assumes 3D) Define a cross product of 2 vectors */
-void Vec_Cross3D( double* dst, double* a, double* b ) {
+void Vec_Cross3D( double* dst, const double* a, const double* b ) {
 	double	tmp[3];
 
 	tmp[0] = a[1] * b[2] - a[2] * b[1];
@@ -62,33 +62,33 @@ void Vec_Cross3D( double* dst, double* a
 }
 
 /** (Assumes 3D) Divide a vector by a real */
-void Vec_Div2D( double* dst, double* a, double s ) {
+void Vec_Div2D( double* dst, const double* a, const double s ) {
 	double	inv = 1.0 / s;
 
 	Vec_Scale2D( dst, a, inv );
 }
 
-void Vec_Div3D( double* dst, double* a, double s ) {
+void Vec_Div3D( double* dst, const double* a, const double s ) {
 	double	inv = 1.0 / s;
 
 	Vec_Scale3D( dst, a, inv );
 }
 
 /** Calculate the normal of the vector. (ie length = 1 )*/
-void Vec_Norm3D( double* dst, double* a ) {
+void Vec_Norm3D( double* dst, const double* a ) {
 	double	invMag = 1.0 / Vec_Mag3D( a );
 
 	Vec_Scale3D( dst, a, invMag );
 }
 
-void Vec_Norm2D( double* dst, double* a ) {
+void Vec_Norm2D( double* dst, const double* a ) {
 	double	invMag = 1.0 / Vec_Mag2D( a );
 
 	Vec_Scale2D( dst, a, invMag );
 }
 
 /** Swap coordinates according to i,j, k index */
-void Vec_Swizzle( double* dst, double* src, unsigned char iInd, unsigned char jInd, unsigned char kInd ) {
+void Vec_Swizzle( double* dst, const double* src, unsigned char iInd, unsigned char jInd, unsigned char kInd ) {
 	assert( iInd < 3 && jInd < 3 && kInd < 3 );
 	
 	dst[0] = src[iInd];
@@ -103,7 +103,7 @@ which was taken from:
 which was taken from: 
 Eric W. Weisstein et al. "Rodrigues' Rotation Formula." From MathWorld--A Wolfram Web Resource. 
 http://mathworld.wolfram.com/RodriguesRotationFormula.html. */
-void StGermain_RotateVector(double* rotatedVector, double* vector, double* w, double theta) {
+void StGermain_RotateVector(double* rotatedVector, const double* vector, const double* w, const double theta) {
 	double rotationMatrix[3][3]; 	/* Indicies [Column][Row] */
 	double cosTheta = cos(theta);
 	double sinTheta = sin(theta);
@@ -129,7 +129,7 @@ Is a simpler function than StGermain_Rot
 Is a simpler function than StGermain_RotateVector for more specific cases where the vector is to be rotated around one of the axes of the co-ordinate system. The arguments are the same except the the 'axis' argument is of type 'Index' which could be either I_AXIS, J_AXIS or K_AXIS. Vectors have to be the size of 3 doubles.
 See, Eric W. Weisstein. "Rotation Matrix." 
 From MathWorld--A Wolfram Web Resource. http://mathworld.wolfram.com/RotationMatrix.htm */
-void StGermain_RotateCoordinateAxis( double* rotatedVector, double* vector, Index axis, double theta ) {
+void StGermain_RotateCoordinateAxis( double* rotatedVector, const double* vector, Index axis, const double theta ) {
 	
 	/* Rotation around one axis will always leave the component on that axis alone */
 	rotatedVector[axis] = vector[axis];
@@ -159,7 +159,7 @@ destination = vector1 - vector2
 destination = vector1 - vector2
 Destination vector may be the same as either of the other two input vectors 
 Function is optimised for 1-3 dimensions but will work for any dimension */
-void StGermain_VectorSubtraction(double* destination, double* vector1, double* vector2, Index dim) {
+void StGermain_VectorSubtraction(double* destination, const double* vector1, const double* vector2, Index dim) {
 	switch (dim) {
 		case 3: 
 			destination[2] = vector1[2] - vector2[2];
@@ -181,7 +181,7 @@ destination = vector1 + vector2
 destination = vector1 + vector2
 Destination vector may be the same as either of the other two input vectors 
 Function is optimised for 1-3 dimensions but will work for any dimension */
-void StGermain_VectorAddition(double* destination, double* vector1, double* vector2, Index dim) {
+void StGermain_VectorAddition(double* destination, const double* vector1, const double* vector2, Index dim) {
 	switch (dim) {
 		case 3: 
 			destination[2] = vector1[2] + vector2[2];
@@ -203,7 +203,7 @@ void StGermain_VectorAddition(double* de
 |v| = \sqrt{ v . v } 
 This function uses function StGermain_VectorDotProduct to calculate v . v. 
 Vector has to be of size dim doubles */
-double StGermain_VectorMagnitude(double* vector, Index dim) {
+double StGermain_VectorMagnitude(const double* vector, Index dim) {
 	return sqrt(StGermain_VectorDotProduct(vector,vector,dim));
 }
 
@@ -212,7 +212,7 @@ This function uses function StGermain_Ve
 This function uses function StGermain_VectorDotProduct to calculate v . v. 
 Vectors have to be of size dim doubles
 */
-double StGermain_VectorDotProduct(double* vector1, double* vector2, Index dim) {
+double StGermain_VectorDotProduct(const double* vector1, const double* vector2, Index dim) {
 	double dotProduct = 0.0;
 
 	switch (dim) {
@@ -237,7 +237,7 @@ double StGermain_VectorDotProduct(double
 /** See Eric W. Weisstein. "Cross Product." 
 From MathWorld--A Wolfram Web Resource. http://mathworld.wolfram.com/CrossProduct.html 
 Tested against http://www.engplanet.com/redirect.html?3859 */
-void StGermain_VectorCrossProduct(double* destination, double* vector1, double* vector2) {
+void StGermain_VectorCrossProduct(double* destination, const double* vector1, const double* vector2) {
 	destination[0] = vector1[1]*vector2[2] - vector1[2]*vector2[1];
 	destination[1] = vector1[2]*vector2[0] - vector1[0]*vector2[2];
 	destination[2] = vector1[0]*vector2[1] - vector1[1]*vector2[0];
@@ -247,7 +247,7 @@ From MathWorld--A Wolfram Web Resource. 
 From MathWorld--A Wolfram Web Resource. http://mathworld.wolfram.com/CrossProduct.html 
 |a \times b| = |a||b|\sqrt{ 1 - (\hat a . \hat b)^2}
 */
-double StGermain_VectorCrossProductMagnitude( double* vector1, double* vector2, Dimension_Index dim ) {
+double StGermain_VectorCrossProductMagnitude( const double* vector1, const double* vector2, Dimension_Index dim ) {
 	double mag1       = StGermain_VectorMagnitude( vector1, dim );
 	double mag2       = StGermain_VectorMagnitude( vector2, dim );
 	double dotProduct = StGermain_VectorDotProduct( vector1, vector2, dim );
@@ -259,7 +259,7 @@ double StGermain_VectorCrossProductMagni
 /** StGermain_ScalarTripleProduct - Calculates the scalar vector product of three vectors -
  * see Eric W. Weisstein. "Scalar Triple Product." From MathWorld--A Wolfram Web Resource. http://mathworld.wolfram.com/ScalarTripleProduct.html
  * Assumes 3 Dimensions */
-double StGermain_ScalarTripleProduct( double* vectorA, double* vectorB, double* vectorC ) {
+double StGermain_ScalarTripleProduct( const double* vectorA, const double* vectorB, const double* vectorC ) {
 	double crossProduct[3];
 	
 	StGermain_VectorCrossProduct( crossProduct, vectorB, vectorC );
@@ -296,7 +296,7 @@ void StGermain_VectorNormalise(double* v
 \cos{\theta} = \frac{a.b}{|a||b|}
 Uses StGermain_AngleBetweenVectors and StGermain_VectorMagnitude
 Vectors has to be of size dim doubles */
-double StGermain_AngleBetweenVectors( double* vectorA, double* vectorB, Index dim ) {
+double StGermain_AngleBetweenVectors( const double* vectorA, const double* vectorB, Index dim ) {
 	double dotProduct = StGermain_VectorDotProduct(vectorA, vectorB, dim);
 	double magA = StGermain_VectorMagnitude( vectorA, dim );
 	double magB = StGermain_VectorMagnitude( vectorB, dim );
@@ -315,7 +315,7 @@ distance = |a - b|
 distance = |a - b|
 Uses StGermain_VectorSubtraction and StGermain_VectorMagnitude
 Position vectors have to be of size dim doubles */
-double StGermain_DistanceBetweenPoints( double* pos1, double* pos2, Index dim) {
+double StGermain_DistanceBetweenPoints( const double* pos1, const double* pos2, Index dim) {
 	double mag;
 	double *vector;
 	
@@ -333,7 +333,7 @@ double StGermain_DistanceBetweenPoints( 
 /** Given three points which define a plane, StGermain_NormalToPlane will give the unit vector which is normal to that plane
 Uses StGermain_VectorSubtraction, StGermain_VectorCrossProduct and StGermain_VectorNormalise
 Position vectors and normal have to be of size 3 doubles */
-void StGermain_NormalToPlane( double* normal, double* pos0, double* pos1, double* pos2) {
+void StGermain_NormalToPlane( double* normal, const double* pos0, const double* pos1, const double* pos2) {
 	double vector1[3], vector2[3];
 
 	StGermain_VectorSubtraction( vector1, pos1, pos0, 3) ;
@@ -347,7 +347,7 @@ void StGermain_NormalToPlane( double* no
 #define ONE_THIRD 0.3333333333333333333
 /** Calculates the position vector to the centroid of a triangle whose vertices are given by position vectors 
 Position vectors have to be of size dim doubles */
-void StGermain_TriangleCentroid( double* centroid, double* pos0, double* pos1, double* pos2, Index dim) {
+void StGermain_TriangleCentroid( double* centroid, const double* pos0, const double* pos1, const double* pos2, Index dim) {
 
 	switch (dim) {
 		case 3:
@@ -370,7 +370,7 @@ Position vectors have to be of size dim 
 Position vectors have to be of size dim doubles 
 Only works for dim == 2 or dim == 3
 */
-double StGermain_TriangleArea( double* pos0, double* pos1, double* pos2, Index dim ) {
+double StGermain_TriangleArea( const double* pos0, const double* pos1, const double* pos2, Index dim ) {
 	double normal[3];
 	double vector1[3], vector2[3];
 	double area;
@@ -393,7 +393,7 @@ double StGermain_TriangleArea( double* p
  * Area = \frac{1}{2}| p \times q | where p and q are diagonals of a convex polygon
  * This function will not work for dim > 3 and vertices have to be given in a winding direction
 */
-double StGermain_ConvexQuadrilateralArea( double* vertexCoord1, double* vertexCoord2, double* vertexCoord3, double* vertexCoord4, Dimension_Index dim ) {
+double StGermain_ConvexQuadrilateralArea( const double* vertexCoord1, const double* vertexCoord2, const double* vertexCoord3, const double* vertexCoord4, Dimension_Index dim ) {
 	Coord diagonal1;	
 	Coord diagonal2;
 
@@ -408,10 +408,10 @@ double StGermain_ConvexQuadrilateralArea
  * see Eric W. Weisstein et al. "Parallelepiped." From MathWorld--A Wolfram Web Resource. http://mathworld.wolfram.com/Parallelepiped.html
  * Assumes 3 Dimensions */
 double StGermain_ParallelepipedVolume( 
-		double* coordLeftBottomFront, 
-		double* coordRightBottomFront, 
-		double* coordLeftTopFront, 
-		double* coordLeftBottomBack ) {
+		const double* coordLeftBottomFront, 
+		const double* coordRightBottomFront, 
+		const double* coordLeftTopFront, 
+		const double* coordLeftBottomBack ) {
 
 	double vectorA[3], vectorB[3], vectorC[3];
 
@@ -461,7 +461,7 @@ void StGermain_AverageCoord( double* coo
 }
 /** Prints a vector of any non-zero positive length 
 Uses %lf print statement*/
-void StGermain_PrintVector( Stream* stream, double* vector, Index dim ) {
+void StGermain_PrintVector( Stream* stream, const double* vector, Index dim ) {
 	Index d;
 
 	if ( dim <= 0 ) {
diff -r b1fae62131ad -r 217e3f32b7aa Geometry/src/VectorMath.h
--- a/Geometry/src/VectorMath.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Geometry/src/VectorMath.h	Sun Oct 16 05:16:40 2011 -0700
@@ -118,40 +118,40 @@
 	** Functions
 	*/
 
-	void Vec_Cross3D( double* dst, double* a, double* b );
-	void Vec_Div2D( double* dst, double* a, double s );
-	void Vec_Div3D( double* dst, double* a, double s );
-	void Vec_Norm2D( double* dst, double* a );
-	void Vec_Norm3D( double* dst, double* a );
+	void Vec_Cross3D( double* dst, const double* a, const double* b );
+	void Vec_Div2D( double* dst, const double* a, const double s );
+	void Vec_Div3D( double* dst, const double* a, const double s );
+	void Vec_Norm2D( double* dst, const double* a );
+	void Vec_Norm3D( double* dst, const double* a );
 
-	void StGermain_RotateVector(double* rotatedVector, double* vector, double* w, double theta) ;
-	void StGermain_RotateCoordinateAxis( double* rotatedVector, double* vector, Index axis, double theta ) ;
-	void StGermain_VectorSubtraction(double* destination, double* vector1, double* vector2, Index dim) ;
-	void StGermain_VectorAddition(double* destination, double* vector1, double* vector2, Index dim) ;
-	double StGermain_VectorMagnitude(double* vector, Index dim) ;
-	double StGermain_VectorDotProduct(double* vector1, double* vector2, Index dim) ;
-	void StGermain_VectorCrossProduct(double* destination, double* vector1, double* vector2) ;
-	double StGermain_VectorCrossProductMagnitude( double* vector1, double* vector2, Dimension_Index dim ) ;
-	double StGermain_ScalarTripleProduct( double* vectorA, double* vectorB, double* vectorC ) ;
+	void StGermain_RotateVector(double* rotatedVector, const double* vector, const double* w, const double theta) ;
+	void StGermain_RotateCoordinateAxis( double* rotatedVector, const double* vector, Index axis, const double theta ) ;
+	void StGermain_VectorSubtraction(double* destination, const double* vector1, const double* vector2, Index dim) ;
+	void StGermain_VectorAddition(double* destination, const double* vector1, const double* vector2, Index dim) ;
+	double StGermain_VectorMagnitude(const double* vector, Index dim) ;
+	double StGermain_VectorDotProduct(const double* vector1, const double* vector2, Index dim) ;
+	void StGermain_VectorCrossProduct(double* destination, const double* vector1, const double* vector2) ;
+	double StGermain_VectorCrossProductMagnitude( const double* vector1, const double* vector2, Dimension_Index dim ) ;
+	double StGermain_ScalarTripleProduct( const double* vectorA, const double* vectorB, const double* vectorC ) ;
 
 	void StGermain_VectorNormalise(double* vector, Index dim) ;
-	double StGermain_AngleBetweenVectors( double* vectorA, double* vectorB, Index dim ) ;
-	double StGermain_DistanceBetweenPoints( double* pos1, double* pos2, Index dim) ;
-	void StGermain_NormalToPlane( double* normal, double* pos0, double* pos1, double* pos2) ;
+	double StGermain_AngleBetweenVectors( const double* vectorA, const double* vectorB, Index dim ) ;
+	double StGermain_DistanceBetweenPoints( const double* pos1, const double* pos2, Index dim) ;
+	void StGermain_NormalToPlane( double* normal, const double* pos0, const double* pos1, const double* pos2) ;
 
-	void StGermain_TriangleCentroid( double* centroid, double* pos0, double* pos1, double* pos2, Index dim) ;
-	double StGermain_TriangleArea( double* pos0, double* pos1, double* pos2, Index dim ) ;
-	double StGermain_ConvexQuadrilateralArea( double* vertexCoord1, double* vertexCoord2, 
-						  double* vertexCoord3, double* vertexCoord4, 
+	void StGermain_TriangleCentroid( double* centroid, const double* pos0, const double* pos1, const double* pos2, Index dim) ;
+	double StGermain_TriangleArea( const double* pos0, const double* pos1, const double* pos2, Index dim ) ;
+	double StGermain_ConvexQuadrilateralArea( const double* vertexCoord1, const double* vertexCoord2, 
+						  const double* vertexCoord3, const double* vertexCoord4, 
 						  Dimension_Index dim ) ;
-	double StGermain_ParallelepipedVolume( double* coordLeftBottomFront, 
-					       double* coordRightBottomFront, 
-					       double* coordLeftTopFront, 
-					       double* coordLeftBottomBack );
+	double StGermain_ParallelepipedVolume( const double* coordLeftBottomFront, 
+					       const double* coordRightBottomFront, 
+					       const double* coordLeftTopFront, 
+					       const double* coordLeftBottomBack );
 	double StGermain_ParallelepipedVolumeFromCoordList( Coord_List list ) ;
 	
 	void StGermain_AverageCoord( double* coord, double** coordList, Index count, Dimension_Index dim ) ;
-	void StGermain_PrintVector( Stream* stream, double* vector, Index dim ) ;
+	void StGermain_PrintVector( Stream* stream, const double* vector, Index dim ) ;
 
 	/** Print a named vector. Name comes from vector variable in file*/
 	#define StGermain_PrintNamedVector(stream, vector, dim)		\
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/BelowCosinePlane.cxx
--- a/Shape/src/BelowCosinePlane.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/BelowCosinePlane.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -193,7 +193,7 @@ void _BelowCosinePlane_Destroy( void* be
 ** Private Member functions
 */
 
-Bool _BelowCosinePlane_IsCoordInside( void* belowPlane, Coord coord ) {
+Bool _BelowCosinePlane_IsCoordInside( void* belowPlane, const Coord coord ) {
 	BelowCosinePlane*            self       = (BelowCosinePlane*)belowPlane;
 	Coord                        newCoord;
 
@@ -231,7 +231,7 @@ double _BelowCosinePlane_CalculateVolume
 	
 	return volume;
 }
-void _BelowCosinePlane_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec ) {
+void _BelowCosinePlane_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec ) {
 	Stg_Shape* self = (Stg_Shape*)shape;
 	Journal_Firewall( False, Journal_Register( Error_Type, (Name)self->type  ),
 	"Error in function %s: This functions hasn't been implemented.", 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/BelowCosinePlane.h
--- a/Shape/src/BelowCosinePlane.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/BelowCosinePlane.h	Sun Oct 16 05:16:40 2011 -0700
@@ -104,10 +104,10 @@
 	void _BelowCosinePlane_Execute( void* belowPlane, void* data );
 	void _BelowCosinePlane_Destroy( void* belowPlane, void* data ) ;
 	
-	Bool _BelowCosinePlane_IsCoordInside( void* belowPlane, Coord coord ) ;
+	Bool _BelowCosinePlane_IsCoordInside( void* belowPlane, const Coord coord ) ;
 
 	double _BelowCosinePlane_CalculateVolume( void* belowPlane );
-	void _BelowCosinePlane_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec );
+	void _BelowCosinePlane_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec );
 
 
 	/*---------------------------------------------------------------------------------------------------------------------
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/BelowPlane.cxx
--- a/Shape/src/BelowPlane.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/BelowPlane.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -196,7 +196,7 @@ void _BelowPlane_Destroy( void* belowPla
 ** Private Member functions
 */
 
-Bool _BelowPlane_IsCoordInside( void* belowPlane, Coord coord ) {
+Bool _BelowPlane_IsCoordInside( void* belowPlane, const Coord coord ) {
 	BelowPlane*            self       = (BelowPlane*)belowPlane;
 	Coord           newCoord;
 
@@ -223,7 +223,7 @@ double _BelowPlane_CalculateVolume( void
 	return volume;
 }
 
-void _BelowPlane_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec ){
+void _BelowPlane_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec ){
 	Stg_Shape* self = (Stg_Shape*)shape;
 	Journal_Firewall( False, Journal_Register( Error_Type, (Name)self->type  ),
 	"Error in function %s: This functions hasn't been implemented.", 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/BelowPlane.h
--- a/Shape/src/BelowPlane.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/BelowPlane.h	Sun Oct 16 05:16:40 2011 -0700
@@ -90,10 +90,10 @@
 	void _BelowPlane_Execute( void* belowPlane, void* data );
 	void _BelowPlane_Destroy( void* belowPlane, void* data ) ;
 	
-	Bool _BelowPlane_IsCoordInside( void* belowPlane, Coord coord ) ;
+	Bool _BelowPlane_IsCoordInside( void* belowPlane, const Coord coord ) ;
 
 	double _BelowPlane_CalculateVolume( void* belowPlane );
-	void _BelowPlane_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec );
+	void _BelowPlane_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec );
 
 	/*---------------------------------------------------------------------------------------------------------------------
 	** Public member functions
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Box.cxx
--- a/Shape/src/Box.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Box.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -206,7 +206,7 @@ void _Box_Destroy( void* shape, void* da
 ** Private Member functions
 */
 
-Bool _Box_IsCoordInside( void* shape, Coord coord ) {
+Bool _Box_IsCoordInside( void* shape, const Coord coord ) {
 	Box*            self       = (Box*)shape;
 	Coord           newCoord;
 	Dimension_Index dim_I;
@@ -232,7 +232,7 @@ double _Box_CalculateVolume( void* shape
 	return result;
 }
 
-void _Box_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec ) {
+void _Box_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec ) {
 	/* To be implemented */
 	Stg_Shape* self = (Stg_Shape*)shape;
 	Journal_Firewall( False, Journal_Register( Error_Type, (Name)self->type  ),
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Box.h
--- a/Shape/src/Box.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Box.h	Sun Oct 16 05:16:40 2011 -0700
@@ -96,11 +96,11 @@
 	void _Box_Execute( void* box, void* data );
 	void _Box_Destroy( void* box, void* data ) ;
 	
-	Bool _Box_IsCoordInside( void* box, Coord coord ) ;
+	Bool _Box_IsCoordInside( void* box, const Coord coord ) ;
 
 	double _Box_CalculateVolume( void* box );
 
-	void _Box_DistanceFromCenterAxis( void* box, Coord coord, double* disVec );
+	void _Box_DistanceFromCenterAxis( void* box, const Coord coord, double* disVec );
 	/*---------------------------------------------------------------------------------------------------------------------
 	** Public member functions
 	*/
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/ConvexHull.cxx
--- a/Shape/src/ConvexHull.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/ConvexHull.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -277,7 +277,7 @@ void _ConvexHull_Destroy( void* convexHu
 /*---------------------------------------------------------------------------------------------------------------------
 ** Private Member functions
 */
-Bool _ConvexHull_IsCoordInside( void* convexHull, Coord point ) {
+Bool _ConvexHull_IsCoordInside( void* convexHull, const Coord point ) {
 	ConvexHull*     self                 = (ConvexHull*)convexHull;
 	Index           vertex_I;
 	XYZ             tmpVector;
@@ -298,7 +298,7 @@ double _ConvexHull_CalculateVolume( void
 	assert( 0 );
 	return 0.0;
 }
-void _ConvecHull_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec ) {
+void _ConvecHull_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec ) {
 	Stg_Shape* self = (Stg_Shape*)shape;
 	Journal_Firewall( False, Journal_Register( Error_Type, (Name)self->type  ),
 	"Error in function %s: This functions hasn't been implemented.", 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/ConvexHull.h
--- a/Shape/src/ConvexHull.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/ConvexHull.h	Sun Oct 16 05:16:40 2011 -0700
@@ -99,9 +99,9 @@
 	void _ConvexHull_Execute( void* convexHull, void* data );
 	void _ConvexHull_Destroy( void* convexHull, void* data ) ;
 	
-	Bool _ConvexHull_IsCoordInside( void* convexHull, Coord coord ) ;
+	Bool _ConvexHull_IsCoordInside( void* convexHull, const Coord coord ) ;
 	double _ConvexHull_CalculateVolume( void* convexHull );
-	void _ConvecHull_DistanceFromCenterAxis( void* self, Coord coord, double* disVec );
+	void _ConvecHull_DistanceFromCenterAxis( void* self, const Coord coord, double* disVec );
 
 	/*---------------------------------------------------------------------------------------------------------------------
 	** Public member functions
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Cylinder.cxx
--- a/Shape/src/Cylinder.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Cylinder.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -212,7 +212,7 @@ void _Cylinder_Destroy( void* cylinder, 
 ** Private Member functions
 */
 
-Bool _Cylinder_IsCoordInside( void* cylinder, Coord coord ) {
+Bool _Cylinder_IsCoordInside( void* cylinder, const Coord coord ) {
 	Cylinder*       self       = (Cylinder*)cylinder;
 	Coord           newCoord;
 	double          insideOutsideValue;
@@ -246,7 +246,7 @@ Bool _Cylinder_IsCoordInside( void* cyli
 	return True;
 }
 
-void _Cylinder_DistanceFromCenterAxis( void* cylinder, Coord coord, double* disVec ) {
+void _Cylinder_DistanceFromCenterAxis( void* cylinder, const Coord coord, double* disVec ) {
 	Cylinder*       self       = (Cylinder*)cylinder;
 	Coord           newCoord;
 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Cylinder.h
--- a/Shape/src/Cylinder.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Cylinder.h	Sun Oct 16 05:16:40 2011 -0700
@@ -101,8 +101,8 @@
 	void _Cylinder_Execute( void* cylinder, void* data );
 	void _Cylinder_Destroy( void* cylinder, void* data ) ;
 	
-	Bool _Cylinder_IsCoordInside( void* cylinder, Coord coord ) ;
-	void _Cylinder_DistanceFromCenterAxis( void* cylinder, Coord coord, double* disVec );
+	Bool _Cylinder_IsCoordInside( void* cylinder, const Coord coord ) ;
+	void _Cylinder_DistanceFromCenterAxis( void* cylinder, const Coord coord, double* disVec );
 	double _Cylinder_CalculateVolume( void* cylinder );
 
 	/*---------------------------------------------------------------------------------------------------------------------
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Everywhere.cxx
--- a/Shape/src/Everywhere.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Everywhere.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -160,14 +160,14 @@ void _Everywhere_Destroy( void* everywhe
 ** Private Member functions
 */
 
-Bool _Everywhere_IsCoordInside( void* everywhere, Coord coord ) {
+Bool _Everywhere_IsCoordInside( void* everywhere, const Coord coord ) {
 	return True;
 }
 
 double _Everywhere_CalculateVolume( void* everywhere ) {
 	return 1.0;
 }	
-void _Everywhere_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec ){
+void _Everywhere_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec ){
 	Stg_Shape* self = (Stg_Shape*)shape;
 	Journal_Firewall( False, Journal_Register( Error_Type, (Name)self->type  ),
 	"Error in function %s: This functions hasn't been implemented.", 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Everywhere.h
--- a/Shape/src/Everywhere.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Everywhere.h	Sun Oct 16 05:16:40 2011 -0700
@@ -90,9 +90,9 @@
 	void _Everywhere_Execute( void* everywhere, void* data );
 	void _Everywhere_Destroy( void* everywhere, void* data ) ;
 	
-	Bool _Everywhere_IsCoordInside( void* everywhere, Coord coord ) ;
+	Bool _Everywhere_IsCoordInside( void* everywhere, const Coord coord ) ;
 	double _Everywhere_CalculateVolume( void* everywhere );
-	void _Everywhere_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec );
+	void _Everywhere_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec );
 
 	/*---------------------------------------------------------------------------------------------------------------------
 	** Public member functions
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Intersection.cxx
--- a/Shape/src/Intersection.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Intersection.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -253,7 +253,7 @@ void _Intersection_Destroy( void* inters
 /*---------------------------------------------------------------------------------------------------------------------
 ** Private Member functions
 */
-Bool _Intersection_IsCoordInside( void* intersection, Coord coord ) {
+Bool _Intersection_IsCoordInside( void* intersection, const Coord coord ) {
 	Intersection*   self           = (Intersection*)intersection;
 	Index           shapeCount     = self->shapeCount;
 	Index           shape_I;
@@ -276,7 +276,7 @@ double _Intersection_CalculateVolume( vo
 	assert( 0 /* not impossible as long as you have other shapes with volum */ );
 	return 0.0;
 }
-void _Intersection_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec ){
+void _Intersection_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec ){
 	Stg_Shape* self = (Stg_Shape*)shape;
 	Journal_Firewall( False, Journal_Register( Error_Type, (Name)self->type  ),
 	"Error in function %s: This functions hasn't been implemented.", 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Intersection.h
--- a/Shape/src/Intersection.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Intersection.h	Sun Oct 16 05:16:40 2011 -0700
@@ -100,9 +100,9 @@
 	void _Intersection_Execute( void* intersection, void* data );
 	void _Intersection_Destroy( void* intersection, void* data ) ;
 	
-	Bool _Intersection_IsCoordInside( void* intersection, Coord coord ) ;
+	Bool _Intersection_IsCoordInside( void* intersection, const Coord coord ) ;
 	double _Intersection_CalculateVolume( void* intersection );
-	void _Intersection_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec );
+	void _Intersection_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec );
 	/*---------------------------------------------------------------------------------------------------------------------
 	** Public member functions
 	*/
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/PolygonShape.cxx
--- a/Shape/src/PolygonShape.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/PolygonShape.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -266,7 +266,7 @@ void _PolygonShape_Destroy( void* polygo
  * Algorithm works by summing the angles between the test coordinate and each pair of vertices that make up an edge 
  * in the polygon. An inside point will give an angle of 2pi and and outside point will give an angle of 0 */
 
-Bool _PolygonShape_IsCoordInside( void* polygon, Coord coord ) {
+Bool _PolygonShape_IsCoordInside( void* polygon, const Coord coord ) {
 	PolygonShape*        self                = (PolygonShape*) polygon;
 	Index           vertexCount         = self->vertexCount;
 	Coord_List      vertexList          = self->vertexList;
@@ -326,7 +326,7 @@ double _PolygonShape_CalculateVolume( vo
 	return 0.0;
 }
 
-void _PolygonShape_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec ){
+void _PolygonShape_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec ){
 	Stg_Shape* self = (Stg_Shape*)shape;
 	Journal_Firewall( False, Journal_Register( Error_Type, (Name)self->type  ),
 	"Error in function %s: This functions hasn't been implemented.", 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/PolygonShape.h
--- a/Shape/src/PolygonShape.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/PolygonShape.h	Sun Oct 16 05:16:40 2011 -0700
@@ -104,9 +104,9 @@
 	void _PolygonShape_Execute( void* polygon, void* data );
 	void _PolygonShape_Destroy( void* polygon, void* data ) ;
 	
-	Bool _PolygonShape_IsCoordInside( void* polygon, Coord coord ) ;
+	Bool _PolygonShape_IsCoordInside( void* polygon, const Coord coord ) ;
 	double _PolygonShape_CalculateVolume( void* polygon );
-	void _PolygonShape_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec );
+	void _PolygonShape_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec );
 
 	/*---------------------------------------------------------------------------------------------------------------------
 	** Public member functions
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/PythonShape.cxx
--- a/Shape/src/PythonShape.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/PythonShape.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -214,7 +214,7 @@ void _PythonShape_Destroy( void* pythonS
 ** Private Member functions
 */
 
-Bool _PythonShape_IsCoordInside( void* pythonShape, Coord coord ) {
+Bool _PythonShape_IsCoordInside( void* pythonShape, const Coord coord ) {
 	PythonShape*          self                   = (PythonShape*)pythonShape;
 	Coord                 newCoord;
 	PyObject*             xCoord;
@@ -251,7 +251,7 @@ double _PythonShape_CalculateVolume( voi
 	assert( 0 );
 	return 0.0;
 }
-void _PythonShape_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec ){
+void _PythonShape_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec ){
 	Stg_Shape* self = (Stg_Shape*)shape;
 	Journal_Firewall( False, Journal_Register( Error_Type, (Name)self->type  ),
 	"Error in function %s: This functions hasn't been implemented.", 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/PythonShape.h
--- a/Shape/src/PythonShape.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/PythonShape.h	Sun Oct 16 05:16:40 2011 -0700
@@ -106,9 +106,9 @@
 	void _PythonShape_Execute( void* pythonShape, void* data );
 	void _PythonShape_Destroy( void* pythonShape, void* data ) ;
 	
-	Bool _PythonShape_IsCoordInside( void* pythonShape, Coord coord ) ;
+	Bool _PythonShape_IsCoordInside( void* pythonShape, const Coord coord ) ;
 	double _PythonShape_CalculateVolume( void* pythonShape );
-	void _PythonShape_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec );
+	void _PythonShape_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec );
 
 	/*---------------------------------------------------------------------------------------------------------------------
 	** Public member functions
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/ShapeClass.cxx
--- a/Shape/src/ShapeClass.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/ShapeClass.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -198,7 +198,7 @@ void _Stg_Shape_Destroy( void* shape, vo
 /*--------------------------------------------------------------------------------------------------------------------------
 ** Virtual Functions
 */
-Bool Stg_Shape_IsCoordInside( void* shape, Coord coord ) {
+Bool Stg_Shape_IsCoordInside( void* shape, const Coord coord ) {
 	Stg_Shape* self              = (Stg_Shape*)shape;
 
 	/* XOR the output */
@@ -234,7 +234,7 @@ void Stg_Shape_DistanceFromCenterAxis( v
 /*--------------------------------------------------------------------------------------------------------------------------
 ** Public Functions
 */
-void Stg_Shape_TransformCoord( void* shape, Coord coord, Coord transformedCoord ) {
+void Stg_Shape_TransformCoord( void* shape, const Coord coord, Coord transformedCoord ) {
 	Stg_Shape* self              = (Stg_Shape*)shape;
 	Coord      rotatedCoord;
 
@@ -263,7 +263,8 @@ void Stg_Shape_TransformCoord( void* sha
 
 }
 
-void Stg_Shape_TranslateCoord( void* shape, Coord coord, Coord translatedCoord ) {
+void Stg_Shape_TranslateCoord( void* shape, const Coord coord,
+                               Coord translatedCoord ) {
 	Stg_Shape* self              = (Stg_Shape*)shape;
 
    self->dim == 2 ? 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/ShapeClass.h
--- a/Shape/src/ShapeClass.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/ShapeClass.h	Sun Oct 16 05:16:40 2011 -0700
@@ -39,9 +39,9 @@
 #ifndef __StgDomain_Shape_ShapeClass_h__
 #define __StgDomain_Shape_ShapeClass_h__
 
-	typedef Bool (Stg_Shape_IsCoordInsideFunction) ( void* shape, Coord coord );
+	typedef Bool (Stg_Shape_IsCoordInsideFunction) ( void* shape, const Coord coord );
 
-	typedef void (Stg_Shape_DistanceFromCenterAxisFunction) ( void* shape, Coord coord, double* disVec );
+	typedef void (Stg_Shape_DistanceFromCenterAxisFunction) ( void* shape, const Coord coord, double* disVec );
 
 	typedef double (Stg_Shape_CalculateVolumeFunction) ( void* shape );
 
@@ -114,7 +114,7 @@ Stg_Shape* _Stg_Shape_New(  STG_SHAPE_DE
 	/*---------------------------------------------------------------------------------------------------------------------
 	** Virtual Function Implementation 
 	*/
-	Bool Stg_Shape_IsCoordInside( void* shape, Coord coord ) ;
+	Bool Stg_Shape_IsCoordInside( void* shape, const Coord coord ) ;
 
 	double Stg_Shape_CalculateVolume( void* shape );
 	void Stg_Shape_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec );
@@ -122,8 +122,8 @@ Stg_Shape* _Stg_Shape_New(  STG_SHAPE_DE
 	/*---------------------------------------------------------------------------------------------------------------------
 	** Public member functions
 	*/
-	void Stg_Shape_TransformCoord( void* shape, Coord coord, Coord transformedCoord ) ;
-	void Stg_Shape_TranslateCoord( void* shape, Coord coord, Coord translatedCoord ) ;
+	void Stg_Shape_TransformCoord( void* shape, const Coord coord, Coord transformedCoord ) ;
+	void Stg_Shape_TranslateCoord( void* shape, const Coord coord, Coord translatedCoord ) ;
 	
 #endif 
 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Sphere.cxx
--- a/Shape/src/Sphere.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Sphere.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -186,7 +186,7 @@ void _Sphere_Destroy( void* sphere, void
 ** Private Member functions
 */
 
-Bool _Sphere_IsCoordInside( void* sphere, Coord coord ) {
+Bool _Sphere_IsCoordInside( void* sphere, const Coord coord ) {
 	Sphere*         self              = (Sphere*)sphere;
 	Coord           newCoord;
 	double          insideOutsideValue;
@@ -208,7 +208,7 @@ Bool _Sphere_IsCoordInside( void* sphere
 	
 }
 
-void _Sphere_DistanceFromCenterAxis( void* sphere, Coord coord, double* disVec ) {
+void _Sphere_DistanceFromCenterAxis( void* sphere, const Coord coord, double* disVec ) {
 	Sphere*         self              = (Sphere*)sphere;
 	Coord           newCoord;
 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Sphere.h
--- a/Shape/src/Sphere.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Sphere.h	Sun Oct 16 05:16:40 2011 -0700
@@ -97,8 +97,8 @@
 	void _Sphere_Execute( void* sphere, void* data );
 	void _Sphere_Destroy( void* sphere, void* data ) ;
 	
-	Bool _Sphere_IsCoordInside( void* sphere, Coord coord ) ;
-	void _Sphere_DistanceFromCenterAxis( void* sphere, Coord coord, double* disVec );
+	Bool _Sphere_IsCoordInside( void* sphere, const Coord coord ) ;
+	void _Sphere_DistanceFromCenterAxis( void* sphere, const Coord coord, double* disVec );
 	double _Sphere_CalculateVolume( void* sphere );
 
 	/*---------------------------------------------------------------------------------------------------------------------
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Superellipsoid.cxx
--- a/Shape/src/Superellipsoid.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Superellipsoid.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -197,7 +197,7 @@ void _Superellipsoid_Destroy( void* supe
 ** Private Member functions
 */
 
-Bool _Superellipsoid_IsCoordInside( void* superellipsoid, Coord coord ) {
+Bool _Superellipsoid_IsCoordInside( void* superellipsoid, const Coord coord ) {
 	Superellipsoid* self              = (Superellipsoid*)superellipsoid;
 	Coord           newCoord;
 	double          insideOutsideValue;
@@ -228,7 +228,7 @@ double _Superellipsoid_CalculateVolume( 
 	return 0.0;
 }
 
-void _Superellipsoid_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec ){
+void _Superellipsoid_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec ){
 	Stg_Shape* self = (Stg_Shape*)shape;
 	Journal_Firewall( False, Journal_Register( Error_Type, (Name)self->type  ),
 	"Error in function %s: This functions hasn't been implemented.", 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Superellipsoid.h
--- a/Shape/src/Superellipsoid.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Superellipsoid.h	Sun Oct 16 05:16:40 2011 -0700
@@ -100,9 +100,9 @@
 	void _Superellipsoid_Execute( void* superellipsoid, void* data );
 	void _Superellipsoid_Destroy( void* superellipsoid, void* data ) ;
 	
-	Bool _Superellipsoid_IsCoordInside( void* superellipsoid, Coord coord ) ;
+	Bool _Superellipsoid_IsCoordInside( void* superellipsoid, const Coord coord ) ;
 	double _Superellipsoid_CalculateVolume( void* superellipsoid );
-	void _Superellipsoid_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec );
+	void _Superellipsoid_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec );
 
 	/*---------------------------------------------------------------------------------------------------------------------
 	** Public member functions
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Union.cxx
--- a/Shape/src/Union.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Union.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -244,7 +244,7 @@ void _Union_Destroy( void* combination, 
 /*---------------------------------------------------------------------------------------------------------------------
 ** Private Member functions
 */
-Bool _Union_IsCoordInside( void* combination, Coord coord ) {
+Bool _Union_IsCoordInside( void* combination, const Coord coord ) {
 	Union*    self           = (Union*)combination;
 	Index           shapeCount     = self->shapeCount;
 	Index           shape_I;
@@ -269,7 +269,7 @@ double _Union_CalculateVolume( void* com
 	return 0.0;
 }
 
-void _Union_DistanceFromCenterAxis( void* shape, Coord coord, double* disVec ) {
+void _Union_DistanceFromCenterAxis( void* shape, const Coord coord, double* disVec ) {
 	Stg_Shape* self = (Stg_Shape*)shape;
 	Journal_Firewall( False, Journal_Register( Error_Type, (Name)self->type  ),
 	"Error in function %s: This functions hasn't been implemented.", 
diff -r b1fae62131ad -r 217e3f32b7aa Shape/src/Union.h
--- a/Shape/src/Union.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Shape/src/Union.h	Sun Oct 16 05:16:40 2011 -0700
@@ -100,9 +100,9 @@
 	void _Union_Execute( void* combination, void* data );
 	void _Union_Destroy( void* combination, void* data ) ;
 	
-	Bool _Union_IsCoordInside( void* combination, Coord coord ) ;
+	Bool _Union_IsCoordInside( void* combination, const Coord coord ) ;
 	double _Union_CalculateVolume( void* combination );
-	void _Union_DistanceFromCenterAxis( void* sphere, Coord coord, double* disVec );
+	void _Union_DistanceFromCenterAxis( void* sphere, const Coord coord, double* disVec );
 
 	/*---------------------------------------------------------------------------------------------------------------------
 	** Public member functions
diff -r b1fae62131ad -r 217e3f32b7aa Utils/src/MeshBoundaryShape.cxx
--- a/Utils/src/MeshBoundaryShape.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Utils/src/MeshBoundaryShape.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -117,14 +117,13 @@ void _MeshBoundaryShape_AssignFromXML( v
    /* Read in the walls to have friction applied. */
    wallList = _Stg_ComponentFactory_GetDictionaryValue( cf, self->name, "walls", NULL );
    if( wallList ) {
-      int nWalls, curWall;
+      int nWalls;
       char* name;
 
       /* List exists, use it. Extract the number of walls specified. */
       nWalls = Dictionary_Entry_Value_GetCount( wallList );
 
       /* Read in each wall's name. */
-      curWall = 0;
       for( ii = 0; ii < nWalls; ii++ ) {
 
          /* Rip out the name from the list. */
@@ -188,7 +187,7 @@ void _MeshBoundaryShape_Initialise( void
    Stg_Component_Initialise( self->gen, data, False );
 }
 
-Bool _MeshBoundaryShape_IsCoordInside( void* _self, Coord coord ) {
+Bool _MeshBoundaryShape_IsCoordInside( void* _self, const Coord coord ) {
    MeshBoundaryShape* self = (MeshBoundaryShape*)_self;
    Coord newCoord;
 #if 0
@@ -246,7 +245,7 @@ double _MeshBoundaryShape_CalculateVolum
    return 0.0;
 }
 
-void _MeshBoundaryShape_DistanceFromCenterAxis( void* _self, Coord coord, double* disVec ) {
+void _MeshBoundaryShape_DistanceFromCenterAxis( void* _self, const Coord coord, double* disVec ) {
    abort();
 }
 
diff -r b1fae62131ad -r 217e3f32b7aa Utils/src/MeshBoundaryShape.h
--- a/Utils/src/MeshBoundaryShape.h	Sun Oct 16 05:15:16 2011 -0700
+++ b/Utils/src/MeshBoundaryShape.h	Sun Oct 16 05:16:40 2011 -0700
@@ -79,9 +79,9 @@ void _MeshBoundaryShape_Build( void* _se
 void _MeshBoundaryShape_Build( void* _self, void* data );
 void _MeshBoundaryShape_Initialise( void* _self, void* data );
 
-Bool _MeshBoundaryShape_IsCoordInside( void* _self, Coord coord ) ;
+Bool _MeshBoundaryShape_IsCoordInside( void* _self, const Coord coord ) ;
 double _MeshBoundaryShape_CalculateVolume( void* _self );
-void _MeshBoundaryShape_DistanceFromCenterAxis( void* _self, Coord coord, double* disVec );
+void _MeshBoundaryShape_DistanceFromCenterAxis( void* _self, const Coord coord, double* disVec );
 
 #endif
 
diff -r b1fae62131ad -r 217e3f32b7aa Utils/tests/AllNodesVCSuite.cxx
--- a/Utils/tests/AllNodesVCSuite.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Utils/tests/AllNodesVCSuite.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -50,7 +50,7 @@ typedef struct {
 	int		nProcs;
 } AllNodesVCSuiteData;
 
-void AllNodesVCSuite_quadratic(Index index, Variable_Index var_I, void* context, void* result) {
+void AllNodesVCSuite_quadratic(const double *coord, void* context, void* result) {
 	*(double *)result = 20.0;
 }
 
diff -r b1fae62131ad -r 217e3f32b7aa Utils/tests/CompositeVCSuite.cxx
--- a/Utils/tests/CompositeVCSuite.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Utils/tests/CompositeVCSuite.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -50,11 +50,11 @@ typedef struct {
 	int		nProcs;
 } CompositeVCSuiteData;
 
-void CompositeVCSuite_quadratic(Index index, Variable_Index var_I, void* context, void* result) {
+void CompositeVCSuite_quadratic(const double *coord, void* context, void* result) {
    *(double *)result = 20.0;
 }
 
-void CompositeVCSuite_exponential(Index index, Variable_Index var_I, void* context, void* result) {
+void CompositeVCSuite_exponential(const double *coord, void* context, void* result) {
    *(double *)result = 30.0;
 }
 
diff -r b1fae62131ad -r 217e3f32b7aa Utils/tests/WallVCSuite.cxx
--- a/Utils/tests/WallVCSuite.cxx	Sun Oct 16 05:15:16 2011 -0700
+++ b/Utils/tests/WallVCSuite.cxx	Sun Oct 16 05:16:40 2011 -0700
@@ -50,11 +50,11 @@ typedef struct {
 	int		nProcs;
 } WallVCSuiteData;
 
-void WallVCSuite_quadratic(Index index, Variable_Index var_I, void* context, void* result) {
+void WallVCSuite_quadratic(const double *coord, void* context, void* result) {
 	*(double *)result = 20.0;
 }
 
-void WallVCSuite_exponential(Index index, Variable_Index var_I, void* context, void* result) {
+void WallVCSuite_exponential(const double *coord, void* context, void* result) {
 	*(double *)result = 30.0;
 }
 
@@ -98,11 +98,12 @@ void WallVCSuite_TestWallVC( WallVCSuite
 	int									procToWatch;
 	double								minCrds[3] = {0.0, 0.0, 0.0};
 	double								maxCrds[3] = {1.0, 1.0, 1.0};
-	char*									vcKey[] = {"WallVC_Front", "WallVC_Back", "WallVC_Left", "WallVC_Right",
-														"WallVC_Top", "WallVC_Bottom"};
-	char*   								vcKeyName[] = {"WallVC_FrontName", "WallVC_BackName", "WallVC_LeftName", "WallVC_RightName",
-														"WallVC_TopName", "WallVC_BottomName"};
-	char*									varName[] = {"x", "y", "z", "vx", "vy", "vz", "temp"};
+	const char* vcKey[] = {"WallVC_Front", "WallVC_Back", "WallVC_Left",
+                               "WallVC_Right", "WallVC_Top", "WallVC_Bottom"};
+	const char* vcKeyName[] = {"WallVC_FrontName", "WallVC_BackName",
+                                   "WallVC_LeftName", "WallVC_RightName",
+                                   "WallVC_TopName", "WallVC_BottomName"};
+	const char* varName[] = {"x", "y", "z", "vx", "vy", "vz", "temp"};
 	char									input_file[PCU_PATH_MAX];
 	char									expected_file[PCU_PATH_MAX];
 	Mesh*									mesh;



More information about the CIG-COMMITS mailing list