[cig-commits] r16713 - in long/3D/SNAC/trunk/Snac/plugins: . dikeInjection

echoi at geodynamics.org echoi at geodynamics.org
Sat May 15 08:58:03 PDT 2010


Author: echoi
Date: 2010-05-15 08:58:03 -0700 (Sat, 15 May 2010)
New Revision: 16713

Added:
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Constitutive.c
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Constitutive.h
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/ConstructExtensions.c
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/ConstructExtensions.h
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Context.c
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Context.h
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/DikeInjection.h
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Make.mm
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Makefile.def
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Register.c
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Register.h
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/makefile
   long/3D/SNAC/trunk/Snac/plugins/dikeInjection/types.h
Log:
checking in "dikeInjection" plugin.



Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Constitutive.c
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Constitutive.c	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Constitutive.c	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,147 @@
+/*~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+**
+** Copyright (C), 2003,
+**	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+**	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+**	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+**
+** Authors:
+**	Stevan M. Quenette, Senior Software Engineer, VPAC. (steve at vpac.org)
+**	Stevan M. Quenette, Visitor in Geophysics, Caltech.
+**	Luc Lavier, Research Scientist, The University of Texas. (luc at utig.ug.utexas.edu)
+**	Luc Lavier, Research Scientist, Caltech.
+**
+** This program is free software; you can redistribute it and/or modify it
+** under the terms of the GNU General Public License as published by the
+** Free Software Foundation; either version 2, or (at your option) any
+** later version.
+**
+** This program is distributed in the hope that it will be useful,
+** but WITHOUT ANY WARRANTY; without even the implied warranty of
+** MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+** GNU General Public License for more details.
+**
+** You should have received a copy of the GNU General Public License
+** along with this program; if not, write to the Free Software
+** Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+**
+** $Id: Constitutive.c 3274 2007-03-27 20:25:29Z EunseoChoi $
+**
+**~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~*/
+
+#include <mpi.h>
+#include <StGermain/StGermain.h>
+#include <StGermain/FD/FD.h>
+#include "Snac/Snac.h"
+#include "Snac/ViscoPlastic/ViscoPlastic.h"
+#include "types.h"
+#include "Context.h"
+#include "Constitutive.h"
+#include "Register.h"
+#include <math.h>
+#include <string.h>
+#include <assert.h>
+
+#ifndef PI
+#ifndef M_PIl
+#ifndef M_PI
+#define PI 3.14159265358979323846
+#else
+#define PI M_PI
+#endif
+#else
+#define PI M_PIl
+#endif
+#endif
+
+//#define DEBUG
+
+void SnacDikeInjection_Constitutive( void* _context, Element_LocalIndex element_lI ) {
+
+	Snac_Context			*context = (Snac_Context*)_context;
+	SnacDikeInjection_Context*	contextExt = ExtensionManager_Get(
+												context->extensionMgr,
+												context,
+												SnacDikeInjection_ContextHandle );
+	Snac_Element			*element = Snac_Element_At( context, element_lI );
+	SnacViscoPlastic_Element* viscoplasticElement = ExtensionManager_Get( context->mesh->elementExtensionMgr, element, SnacViscoPlastic_ElementHandle );
+	const Snac_Material		*material = &context->materialProperty[element->material_I];
+	
+	/* make local copies. */
+	double startX = contextExt->startX;
+	double endX = contextExt->endX;
+	double startZ = contextExt->startZ;
+	double endZ = contextExt->endZ;
+	double dX = endX-startX;
+	double dZ = endZ-startZ;
+	double elem_dX = 0.0;
+	double epsilon_xx = 0.0;
+	Tetrahedra_Index	tetra_I;
+
+	/* Some convenience stuffs. */
+	MeshLayout*			meshLayout = (MeshLayout*)context->meshLayout;
+	HexaMD*				decomp = (HexaMD*)meshLayout->decomp;
+	IJK				ijk;
+	Element_GlobalIndex		element_gI = _MeshDecomp_Element_LocalToGlobal1D( decomp, element_lI );
+	RegularMeshUtils_Element_1DTo3D( decomp, element_gI, &ijk[0], &ijk[1], &ijk[2] );
+	
+	elem_dX = 0.25*( 
+					(Snac_Element_NodeCoord( context, element_lI, 1)[0]-Snac_Element_NodeCoord( context, element_lI, 0)[0]) + 
+					(Snac_Element_NodeCoord( context, element_lI, 2)[0]-Snac_Element_NodeCoord( context, element_lI, 3)[0]) + 
+					(Snac_Element_NodeCoord( context, element_lI, 5)[0]-Snac_Element_NodeCoord( context, element_lI, 4)[0]) + 
+					(Snac_Element_NodeCoord( context, element_lI, 6)[0]-Snac_Element_NodeCoord( context, element_lI, 7)[0]) 
+					 );
+	fprintf(stderr,"elem_dX=%e dikeWidth=%e\n",elem_dX,contextExt->dikeWidth);
+	epsilon_xx = (contextExt->injectionRate*context->dt)/elem_dX;
+	/*	epsilon_xx = (contextExt->injectionRate*context->dt)/contextExt->dikeWidth; */
+	
+	for( tetra_I = 0; tetra_I < Tetrahedra_Count; tetra_I++ ) {
+		Coord baryCenter;
+		double distance = 0.0;
+		double numer = 0.0;
+		double denom = 1.0;
+		Node_LocalIndex node_lI;
+		unsigned int dim;
+
+		/*
+		  First decide whther this tet is a part of the dike.
+		*/
+
+		/* compute barycenter. */
+		for( dim=0; dim < 3; dim++ ) 
+			baryCenter[dim] = 0.0;
+		for(node_lI=0; node_lI<4; node_lI++) {
+			Coord* tetNodeCoord = Snac_Element_NodeCoord( context, element_lI, TetraToNode[tetra_I][node_lI] );
+			for( dim=0; dim < 3; dim++ ) 
+				baryCenter[dim] += 0.25 * (*tetNodeCoord)[dim];
+		}
+
+		/* The following is the general formula for distance from a line to a point. */
+		numer = fabs( dX*(startZ-baryCenter[2])-(startX-baryCenter[0])*dZ );
+		denom = sqrt( dX*dX + dZ*dZ );
+		assert( denom > 0.0 );
+		distance = numer/denom;
+
+		/* 
+		   If part of the dike, adjust stresses. 
+
+		   Note that although parameters can define a ridge with an arbitrary orientation,
+		   the following stress mods assume ridges are parallel with z-axis.
+		   One can implement tensor rotation when necessary.
+		 */
+		if( (distance <= contextExt->dikeWidth) && (baryCenter[1] >= contextExt->dikeDepth) ) {
+			StressTensor*		stress = &element->tetra[tetra_I].stress;
+
+/* 			fprintf(stderr,"el=%d (%d %d %d) tet=%d (%e %e %e) distance=%e startX=%e width=%e\n", */
+/* 					element_lI,ijk[0],ijk[1],ijk[2],tetra_I, */
+/* 					baryCenter[0], baryCenter[1], baryCenter[2], */
+/* 					distance,startX,contextExt->dikeWidth); */
+			(*stress)[0][0] -= (material->lambda + 2.0f * material->mu) * epsilon_xx;
+			(*stress)[1][1] -= material->lambda * epsilon_xx;
+			(*stress)[2][2] -= material->lambda * epsilon_xx;
+			
+			/* Also assuming viscoplastic rheology is used. */
+			viscoplasticElement->plasticStrain[tetra_I] = 0.0;
+		}
+	}
+}

Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Constitutive.h
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Constitutive.h	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Constitutive.h	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,48 @@
+/*~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+**
+** Copyright (C), 2003, 
+**	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+**	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+**	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+**
+** Authors:
+**	Stevan M. Quenette, Senior Software Engineer, VPAC. (steve at vpac.org)
+**	Stevan M. Quenette, Visitor in Geophysics, Caltech.
+**	Luc Lavier, Research Scientist, The University of Texas. (luc at utig.ug.utexas.edu)
+**	Luc Lavier, Research Scientist, Caltech.
+**
+** This program is free software; you can redistribute it and/or modify it
+** under the terms of the GNU General Public License as published by the
+** Free Software Foundation; either version 2, or (at your option) any
+** later version.
+** 
+** This program is distributed in the hope that it will be useful,
+** but WITHOUT ANY WARRANTY; without even the implied warranty of
+** MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+** GNU General Public License for more details.
+** 
+** You should have received a copy of the GNU General Public License
+** along with this program; if not, write to the Free Software
+** Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+**
+*/
+/** \file
+** Role:
+**	Calculates the plastic properties for a given element. 
+**
+** Assumptions:
+**	None as yet.
+**
+** Comments:
+**	None as yet.
+**
+** $Id: Constitutive.h 3274 2007-03-27 20:25:29Z EunseoChoi $
+**
+**~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~*/
+
+#ifndef __SnacDikeInjection_h__
+#define __SnacDikeInjection_h__
+	
+	void SnacDikeInjection_Constitutive( void* context, Element_LocalIndex element_lI );
+	
+#endif /* __SnacDikeInjection_h__ */

Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/ConstructExtensions.c
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/ConstructExtensions.c	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/ConstructExtensions.c	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,76 @@
+/*~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+**
+** Copyright (C), 2003,
+**	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+**	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+**	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+**
+** Authors:
+**           Colin Stark, Doherty Research Scientist, Lamont-Doherty Earth Observatory (cstark at ldeo.columbia.edu)
+**
+** This program is free software; you can redistribute it and/or modify it
+** under the terms of the GNU General Public License as published by the
+** Free Software Foundation; either version 2, or (at your option) any
+** later version.
+**
+** This program is distributed in the hope that it will be useful,
+** but WITHOUT ANY WARRANTY; without even the implied warranty of
+** MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+** GNU General Public License for more details.
+**
+** You should have received a copy of the GNU General Public License
+** along with this program; if not, write to the Free Software
+** Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+**
+** $Id: ConstructExtensions.c $
+**
+**~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~*/
+
+#include <mpi.h>
+#include <StGermain/StGermain.h>
+#include <StGermain/FD/FD.h>
+#include "Snac/Snac.h"
+#include "types.h"
+#include "Context.h"
+#include "Constitutive.h"
+#include "Register.h"
+#include "ConstructExtensions.h"
+#include <assert.h>
+#include <limits.h>
+
+//#define DEBUG
+
+void _SnacDikeInjection_ConstructExtensions( void* _context, void* data ) {
+	Snac_Context*				context = (Snac_Context*)_context;
+	SnacDikeInjection_Context*			contextExt = ExtensionManager_Get(
+																		  context->extensionMgr,
+																		  context,
+																		  SnacDikeInjection_ContextHandle );
+#ifdef DEBUG
+	printf( "In %s()\n", __func__ );
+#endif
+	
+	/* DikeInjection variables */
+	contextExt->startX = Dictionary_Entry_Value_AsDouble(
+			Dictionary_GetDefault( context->dictionary, "startX", 
+								   Dictionary_Entry_Value_FromDouble( 0.0f ) ) );
+	contextExt->startZ = Dictionary_Entry_Value_AsDouble(
+			Dictionary_GetDefault( context->dictionary, "startZ", 
+								   Dictionary_Entry_Value_FromDouble( 0.0f ) ) );
+	contextExt->endX = Dictionary_Entry_Value_AsDouble(
+			Dictionary_GetDefault( context->dictionary, "endX", 
+								   Dictionary_Entry_Value_FromDouble( 0.0f ) ) );
+	contextExt->endZ = Dictionary_Entry_Value_AsDouble(
+			Dictionary_GetDefault( context->dictionary, "endZ", 
+								   Dictionary_Entry_Value_FromDouble( 1.0e+04 ) ) );
+	contextExt->dikeDepth = Dictionary_Entry_Value_AsDouble(
+			Dictionary_GetDefault( context->dictionary, "dikeDepth", 
+								   Dictionary_Entry_Value_FromDouble( 1.0e+04 ) ) );
+	contextExt->dikeWidth = Dictionary_Entry_Value_AsDouble(
+			Dictionary_GetDefault( context->dictionary, "dikeWidth", 
+								   Dictionary_Entry_Value_FromDouble( 1.8e+03 ) ) ); /* 1.8 * dx looks appropriate. */
+	contextExt->injectionRate = Dictionary_Entry_Value_AsDouble(
+			Dictionary_GetDefault( context->dictionary, "injectionRate", 
+								   Dictionary_Entry_Value_FromDouble( 4.8e+03 ) ) ); /* a fraction of applied plate vel. */
+
+}

Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/ConstructExtensions.h
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/ConstructExtensions.h	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/ConstructExtensions.h	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,48 @@
+/*~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+**
+** Copyright (C), 2003, 
+**	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+**	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+**	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+**
+** Authors:
+**	Stevan M. Quenette, Senior Software Engineer, VPAC. (steve at vpac.org)
+**	Stevan M. Quenette, Visitor in Geophysics, Caltech.
+**	Luc Lavier, Research Scientist, The University of Texas. (luc at utig.ug.utexas.edu)
+**	Luc Lavier, Research Scientist, Caltech.
+**  Mods by:
+**           Colin Stark, Doherty Research Scientist, Lamont-Doherty Earth Observatory (cstark at ldeo.columbia.edu)
+**
+**
+** This program is free software; you can redistribute it and/or modify it
+** under the terms of the GNU General Public License as published by the
+** Free Software Foundation; either version 2, or (at your option) any
+** later version.
+** 
+** This program is distributed in the hope that it will be useful,
+** but WITHOUT ANY WARRANTY; without even the implied warranty of
+** MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+** GNU General Public License for more details.
+** 
+** You should have received a copy of the GNU General Public License
+** along with this program; if not, write to the Free Software
+** Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+**
+*/
+/** \file
+** Role:
+**
+** Assumptions:
+**
+** Comments:
+**
+** $Id: ConstructExtensions.h  $
+**
+**~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~*/
+
+#ifndef __SnacDikeInjection_ConstructExtensions_h__
+#define __SnacDikeInjection_ConstructExtensions_h__
+	
+	void _SnacDikeInjection_ConstructExtensions( void* _context, void* data );
+	
+#endif /* __SnacDikeInjection_ConstructExtensions_h__ */

Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Context.c
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Context.c	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Context.c	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,41 @@
+/*~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+**
+** Copyright (C), 2003, 
+**	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+**	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+**	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+**
+** Authors:
+**           Colin Stark, Doherty Research Scientist, Lamont-Doherty Earth Observatory (cstark at ldeo.columbia.edu)
+**
+** This program is free software; you can redistribute it and/or modify it
+** under the terms of the GNU General Public License as published by the
+** Free Software Foundation; either version 2, or (at your option) any
+** later version.
+** 
+** This program is distributed in the hope that it will be useful,
+** but WITHOUT ANY WARRANTY; without even the implied warranty of
+** MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+** GNU General Public License for more details.
+** 
+** You should have received a copy of the GNU General Public License
+** along with this program; if not, write to the Free Software
+** Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+**
+** $Id: Context.c $
+**
+**~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~*/
+
+#include <mpi.h>
+#include <StGermain/StGermain.h>
+#include <StGermain/FD/FD.h>
+#include "Snac/Snac.h"
+#include "types.h"
+#include "Context.h"
+#include <stdio.h>
+
+void SnacHillSlope_Context_Print( void* _context, Stream* stream ) {
+	
+	Journal_Printf( stream, "SnacHillSlope_Context:\n" );
+	
+}

Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Context.h
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Context.h	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Context.h	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,62 @@
+/*~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+**
+** Copyright (C), 2003, 
+**	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+**	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+**	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+**
+** Authors:
+**	Stevan M. Quenette, Senior Software Engineer, VPAC. (steve at vpac.org)
+**	Stevan M. Quenette, Visitor in Geophysics, Caltech.
+**	Luc Lavier, Research Scientist, The University of Texas. (luc at utig.ug.utexas.edu)
+**	Luc Lavier, Research Scientist, Caltech.
+**
+**  Mods by:
+**           Colin Stark, Doherty Research Scientist, Lamont-Doherty Earth Observatory (cstark at ldeo.columbia.edu)
+**
+** This program is free software; you can redistribute it and/or modify it
+** under the terms of the GNU General Public License as published by the
+** Free Software Foundation; either version 2, or (at your option) any
+** later version.
+** 
+** This program is distributed in the hope that it will be useful,
+** but WITHOUT ANY WARRANTY; without even the implied warranty of
+** MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+** GNU General Public License for more details.
+** 
+** You should have received a copy of the GNU General Public License
+** along with this program; if not, write to the Free Software
+** Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+**
+*/
+/** \file
+** Role:
+**
+** Assumptions:
+**
+** Comments:
+**
+** $Id: Context.h $
+**
+**~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~*/
+
+#ifndef __SnacDikeInjection_Context_h__
+#define __SnacDikeInjection_Context_h__
+	
+	/* Context Information */
+	struct _SnacDikeInjection_Context {
+		double startX;
+		double startZ;
+		double endX;
+		double endZ;
+		double dikeDepth;
+		double dikeWidth;
+		double injectionRate;
+	};
+	
+	/* Print the contents of the context extension */
+	void SnacDikeInjection_Context_Print( void* _context, Stream* stream );
+	
+#endif /* __SnacDikeInjection_Context_h__ */
+
+

Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/DikeInjection.h
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/DikeInjection.h	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/DikeInjection.h	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,50 @@
+/*~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+**
+** Copyright (C), 2003, 
+**	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+**	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+**	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+**
+** Authors:
+**	Stevan M. Quenette, Senior Software Engineer, VPAC. (steve at vpac.org)
+**	Stevan M. Quenette, Visitor in Geophysics, Caltech.
+**	Luc Lavier, Research Scientist, The University of Texas. (luc at utig.ug.utexas.edu)
+**	Luc Lavier, Research Scientist, Caltech.
+**
+** This program is free software; you can redistribute it and/or modify it
+** under the terms of the GNU General Public License as published by the
+** Free Software Foundation; either version 2, or (at your option) any
+** later version.
+** 
+** This program is distributed in the hope that it will be useful,
+** but WITHOUT ANY WARRANTY; without even the implied warranty of
+** MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+** GNU General Public License for more details.
+** 
+** You should have received a copy of the GNU General Public License
+** along with this program; if not, write to the Free Software
+** Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+**
+*/
+/** \file
+** Role:
+**
+** Assumptions:
+**	Only one can be registered at the time (limitation).
+**
+** Comments:
+**
+** $Id: Plastic.h 2202 2004-10-19 08:43:09Z SteveQuenette $
+**
+**~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~*/
+
+#ifndef __SnacDikeInjection_h__
+#define __SnacDikeInjection_h__
+	
+#include "Constitutive.h"
+#include "ConstructExtensions.h"
+#include "Context.h"
+#include "Register.h" 
+#include "types.h"
+
+#endif /* __SnacDikeInjection_h__ */

Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Make.mm
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Make.mm	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Make.mm	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,67 @@
+##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+##
+## Copyright (C), 2003, 
+##	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+##	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+##	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+##
+## Authors:
+##	Stevan M. Quenette, Senior Software Engineer, VPAC. (steve at vpac.org)
+##	Stevan M. Quenette, Visitor in Geophysics, Caltech.
+##	Luc Lavier, Research Scientist, The University of Texas. (luc at utig.ug.utexas.edu)
+##	Luc Lavier, Research Scientist, Caltech.
+##
+## This program is free software; you can redistribute it and/or modify it
+## under the terms of the GNU General Public License as published by the
+## Free Software Foundation; either version 2, or (at your option) any
+## later version.
+## 
+## This program is distributed in the hope that it will be useful,
+## but WITHOUT ANY WARRANTY; without even the implied warranty of
+## MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+## GNU General Public License for more details.
+## 
+## You should have received a copy of the GNU General Public License
+## along with this program; if not, write to the Free Software
+## Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+##
+## $Id: Make.mm 2921 2005-05-10 06:44:06Z EunseoChoi $
+##
+##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+
+include Makefile.def
+
+PROJECT = Snac
+PACKAGE = ${def_mod}module
+
+PROJ_LIB = $(BLD_LIBDIR)/$(PACKAGE).a
+PROJ_DLL = $(BLD_LIBDIR)/$(PACKAGE).$(EXT_SO)
+PROJ_TMPDIR = $(BLD_TMPDIR)/$(PROJECT)/$(PACKAGE)
+PROJ_CLEAN += $(PROJ_LIB) $(PROJ_DLL)
+PROJ_INCDIR = $(BLD_INCDIR)/${def_inc}
+
+PROJ_SRCS = ${def_srcs}
+PROJ_CC_FLAGS += -I$(BLD_INCDIR)/$(PROJECT) -I$(BLD_INCDIR)/Snac -I$(BLD_INCDIR)/StGermain -I$(STGERMAIN_INCDIR)/ -I$(STGERMAIN_INCDIR)/StGermain `xml2-config --cflags` -DCURR_MODULE_NAME=\"${def_mod}\"
+PROJ_LIBRARIES = -L$(BLD_LIBDIR) -L$(STGERMAIN_LIBDIR)/ -lSnac -lStGermain `xml2-config --libs` $(MPI_LIBPATH) $(MPI_LIBS)
+LCCFLAGS = 
+
+# I keep file lists to build a monolith .so from a set of .a's
+PROJ_OBJS_IN_TMP = ${addprefix $(PROJECT)/$(PACKAGE)/, ${addsuffix .o, ${basename $(PROJ_SRCS)}}}
+PROJ_OBJLIST = $(BLD_TMPDIR)/$(PROJECT).$(PACKAGE).objlist
+
+all: $(PROJ_LIB) DLL createObjList export
+
+DLL: product_dirs $(PROJ_OBJS)
+	$(CC) -o $(PROJ_DLL) $(PROJ_OBJS) $(COMPILER_LCC_SOFLAGS) $(LCCFLAGS) $(PROJ_LIBRARIES) $(EXTERNAL_LIBPATH) $(EXTERNAL_LIBS)
+
+
+
+createObjList:: 
+	@echo ${PROJ_OBJS_IN_TMP} | cat > ${PROJ_OBJLIST}
+
+#export:: export-headers
+export:: export-headers export-libraries
+EXPORT_HEADERS = ${def_hdrs}
+EXPORT_LIBS = $(PROJ_LIB) $(PROJ_DLL)
+
+check::

Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Makefile.def
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Makefile.def	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Makefile.def	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,49 @@
+##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+##
+## Copyright (C), 2003, 
+##	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+##	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+##	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+##
+## Authors:
+##	Stevan M. Quenette, Senior Software Engineer, VPAC. (steve at vpac.org)
+##	Stevan M. Quenette, Visitor in Geophysics, Caltech.
+##	Luc Lavier, Research Scientist, The University of Texas. (luc at utig.ug.utexas.edu)
+##	Luc Lavier, Research Scientist, Caltech.
+##	Luc Lavier, Caltech.
+##
+## This program is free software; you can redistribute it and/or modify it
+## under the terms of the GNU General Public License as published by the
+## Free Software Foundation; either version 2, or (at your option) any
+## later version.
+## 
+## This program is distributed in the hope that it will be useful,
+## but WITHOUT ANY WARRANTY; without even the implied warranty of
+## MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+## GNU General Public License for more details.
+## 
+## You should have received a copy of the GNU General Public License
+## along with this program; if not, write to the Free Software
+## Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+##
+## $Id: Makefile.def 2713 2005-03-01 19:14:08Z EunseoChoi $
+##
+##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+ 
+def_mod = SnacDikeInjection
+def_inc = Snac/DikeInjection
+
+def_srcs = \
+	Constitutive.c \
+	ConstructExtensions.c \
+	Context.c \
+	Register.c
+
+def_hdrs = \
+	Constitutive.h \
+	ConstructExtensions.h \
+	Context.h \
+	DikeInjection.h \
+	Register.h \
+	types.h
+

Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Register.c
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Register.c	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Register.c	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,97 @@
+/*~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+**
+** Copyright (C), 2003, 
+**	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+**	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+**	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+**
+** Authors:
+**	Stevan M. Quenette, Senior Software Engineer, VPAC. (steve at vpac.org)
+**	Stevan M. Quenette, Visitor in Geophysics, Caltech.
+**	Luc Lavier, Research Scientist, The University of Texas. (luc at utig.ug.utexas.edu)
+**	Luc Lavier, Research Scientist, Caltech.
+**
+** This program is free software; you can redistribute it and/or modify it
+** under the terms of the GNU General Public License as published by the
+** Free Software Foundation; either version 2, or (at your option) any
+** later version.
+** 
+** This program is distributed in the hope that it will be useful,
+** but WITHOUT ANY WARRANTY; without even the implied warranty of
+** MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+** GNU General Public License for more details.
+** 
+** You should have received a copy of the GNU General Public License
+** along with this program; if not, write to the Free Software
+** Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+**
+** $Id: Register.c 3243 2006-10-12 09:04:00Z SteveQuenette $
+**
+**~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~*/
+
+#include <mpi.h>
+#include <StGermain/StGermain.h>
+#include <StGermain/FD/FD.h>
+#include "Snac/Snac.h"
+#include "types.h"
+#include "Constitutive.h"
+#include "ConstructExtensions.h"
+#include "Context.h"
+#include "Register.h"
+#include <stdio.h>
+
+/* Textual name of this class */
+const Type SnacDikeInjection_Type = "SnacDikeInjection";
+
+ExtensionInfo_Index SnacDikeInjection_ContextHandle = -1;
+
+Index _SnacDikeInjection_Register( PluginsManager* pluginsMgr ) {
+	return PluginsManager_Submit( pluginsMgr, 
+				      SnacDikeInjection_Type, 
+				      "0", 
+				      _SnacDikeInjection_DefaultNew );
+}
+
+
+void* _SnacDikeInjection_DefaultNew( Name name ) {
+	return _Codelet_New( sizeof(Codelet), 
+						 SnacDikeInjection_Type, 
+						 _Codelet_Delete, 
+						 _Codelet_Print, 
+						 _Codelet_Copy, 
+						 _SnacDikeInjection_DefaultNew, 
+						 _SnacDikeInjection_Construct, 
+						 _Codelet_Build, 
+						 _Codelet_Initialise, 
+						 _Codelet_Execute, 
+						 _Codelet_Destroy, 
+						 name );
+}
+
+
+void _SnacDikeInjection_Construct( void* component, Stg_ComponentFactory* cf, void* data ) {
+	Snac_Context*	context;
+
+	/* Retrieve context. */
+	context = (Snac_Context*)Stg_ComponentFactory_ConstructByName( cf, "context", Snac_Context, True, data ); 
+
+	#ifdef DEBUG
+	printf( "In: _SnacDikeInjection_Register( void*, void* )\n" );
+	#endif
+
+	/* Add extensions to nodes, elements and the context */
+	SnacDikeInjection_ContextHandle = ExtensionManager_Add(
+		context->extensionMgr,
+		SnacDikeInjection_Type,
+		sizeof(SnacDikeInjection_Context) );
+
+	/* Add extensions to the entry points */
+	EntryPoint_Append( 
+		Context_GetEntryPoint( context,	Snac_EP_Constitutive ),
+		SnacDikeInjection_Type, 
+		SnacDikeInjection_Constitutive, 
+		SnacDikeInjection_Type );
+
+	/* Construct. */
+	_SnacDikeInjection_ConstructExtensions( context, data );
+}

Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Register.h
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Register.h	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/Register.h	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,55 @@
+/*~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+**
+** Copyright (C), 2003, 
+**	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+**	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+**	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+**
+** Authors:
+**	Stevan M. Quenette, Senior Software Engineer, VPAC. (steve at vpac.org)
+**	Stevan M. Quenette, Visitor in Geophysics, Caltech.
+**	Luc Lavier, Research Scientist, The University of Texas. (luc at utig.ug.utexas.edu)
+**	Luc Lavier, Research Scientist, Caltech.
+**
+** This program is free software; you can redistribute it and/or modify it
+** under the terms of the GNU General Public License as published by the
+** Free Software Foundation; either version 2, or (at your option) any
+** later version.
+** 
+** This program is distributed in the hope that it will be useful,
+** but WITHOUT ANY WARRANTY; without even the implied warranty of
+** MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+** GNU General Public License for more details.
+** 
+** You should have received a copy of the GNU General Public License
+** along with this program; if not, write to the Free Software
+** Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+**
+*/
+/** \file
+** Role:
+**
+** Assumptions:
+**	Only one can be registered at the time (limitation).
+**
+** Comments:
+**
+** $Id: Register.h 3243 2006-10-12 09:04:00Z SteveQuenette $
+**
+**~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~*/
+
+#ifndef __SnacDikeInjection_Register_h__
+#define __SnacDikeInjection_Register_h__
+	
+	/* Textual name of this class */
+	extern const Type SnacDikeInjection_Type;
+	
+	extern ExtensionInfo_Index SnacDikeInjection_ContextHandle;
+	
+	Index _SnacDikeInjection_Register( PluginsManager* pluginsMgr );
+
+	void* _SnacDikeInjection_DefaultNew( Name name );
+
+	void _SnacDikeInjection_Construct( void* component, Stg_ComponentFactory* cf, void* data );
+	
+#endif /* __SnacDikeInjection_Register_h__ */

Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/makefile
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/makefile	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/makefile	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,53 @@
+##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+##
+## Copyright (C), 2003, 
+##	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+##	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+##	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+##
+## Authors:
+##	Stevan M. Quenette, Senior Software Engineer, VPAC. (steve at vpac.org)
+##	Stevan M. Quenette, Visitor in Geophysics, Caltech.
+##	Luc Lavier, Research Scientist, The University of Texas. (luc at utig.ug.utexas.edu)
+##	Luc Lavier, Research Scientist, Caltech.
+##
+## This program is free software; you can redistribute it and/or modify it
+## under the terms of the GNU General Public License as published by the
+## Free Software Foundation; either version 2, or (at your option) any
+## later version.
+## 
+## This program is distributed in the hope that it will be useful,
+## but WITHOUT ANY WARRANTY; without even the implied warranty of
+## MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+## GNU General Public License for more details.
+## 
+## You should have received a copy of the GNU General Public License
+## along with this program; if not, write to the Free Software
+## Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+##
+## $Id: makefile 3049 2005-06-22 07:46:15Z AlanLo $
+##
+##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+
+# obtain defaults for required variables according to system and project location, and then run the build.
+ifndef PROJ_ROOT
+	PROJ_ROOT=../..
+endif
+include ${PROJ_ROOT}/Makefile.system
+
+include Makefile.def
+
+mod = ${def_mod}
+includes = ${def_inc}
+
+SRCS = ${def_srcs}
+
+HDRS = ${def_hdrs}
+
+PROJ_LIBS = ${def_libs}
+EXTERNAL_LIBS = -L${STGERMAIN_LIBDIR}  -lSnac -lStGermain 
+EXTERNAL_INCLUDES = -I${STGERMAIN_INCDIR}/StGermain -I${STGERMAIN_INCDIR} 
+
+packages = MPI XML MATH
+
+include ${PROJ_ROOT}/Makefile.vmake

Added: long/3D/SNAC/trunk/Snac/plugins/dikeInjection/types.h
===================================================================
--- long/3D/SNAC/trunk/Snac/plugins/dikeInjection/types.h	                        (rev 0)
+++ long/3D/SNAC/trunk/Snac/plugins/dikeInjection/types.h	2010-05-15 15:58:03 UTC (rev 16713)
@@ -0,0 +1,49 @@
+/*~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+**
+** Copyright (C), 2003, 
+**	Steve Quenette, 110 Victoria Street, Melbourne, Victoria, 3053, Australia.
+**	Californian Institute of Technology, 1200 East California Boulevard, Pasadena, California, 91125, USA.
+**	University of Texas, 1 University Station, Austin, Texas, 78712, USA.
+**
+** Authors:
+**	Stevan M. Quenette, Senior Software Engineer, VPAC. (steve at vpac.org)
+**	Stevan M. Quenette, Visitor in Geophysics, Caltech.
+**	Luc Lavier, Research Scientist, The University of Texas. (luc at utig.ug.utexas.edu)
+**	Luc Lavier, Research Scientist, Caltech.
+**
+** This program is free software; you can redistribute it and/or modify it
+** under the terms of the GNU General Public License as published by the
+** Free Software Foundation; either version 2, or (at your option) any
+** later version.
+** 
+** This program is distributed in the hope that it will be useful,
+** but WITHOUT ANY WARRANTY; without even the implied warranty of
+** MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
+** GNU General Public License for more details.
+** 
+** You should have received a copy of the GNU General Public License
+** along with this program; if not, write to the Free Software
+** Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
+**
+*/
+/** \file
+** Role:
+**	Plastic types.
+**
+** Assumptions:
+**	None as yet.
+**
+** Comments:
+**	None as yet.
+**
+** $Id: types.h 1677 2004-07-20 10:30:34Z SteveQuenette $
+**
+**~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~*/
+
+#ifndef __SnacDikeInjection_types_h__
+#define __SnacDikeInjection_types_h__
+	
+	/* Plastic */
+	typedef struct _SnacDikeInjection_Context	SnacDikeInjection_Context;
+	
+#endif /* __SnacDikeInjection_types_h__ */



More information about the CIG-COMMITS mailing list