[cig-commits] commit: Change uint to unsigned int

Mercurial hg at geodynamics.org
Sat Oct 22 19:24:24 PDT 2011


changeset:   810:34d0c66dfca3
tag:         tip
user:        Walter Landry <wlandry at caltech.edu>
date:        Sat Oct 22 19:22:48 2011 -0700
files:       Apps/StokesMomentumUzawa/tests/LidDrivenStokesAnalytic/LidDrivenStokesAnalytic.cxx Assembly/src/DivergenceMatrixTerm.h Assembly/src/GradientStiffnessMatrixTerm.h Assembly/src/MassMatrixTerm.cxx Discretisation/src/FeVariable.cxx Discretisation/src/FieldTest.cxx Discretisation/src/FieldTest.h Discretisation/src/OperatorFeVariable.cxx Discretisation/tests/FeEquationNumberSuite.cxx Discretisation/tests/FeVariableSuite.cxx SLE/SystemSetup/src/ForceVector.cxx SLE/SystemSetup/src/SROpGenerator.cxx SLE/SystemSetup/src/StiffnessMatrix.cxx SLE/SystemSetup/src/StiffnessMatrixTerm.h SLE/SystemSetup/tests/SolutionVectorSuite.cxx SLE/SystemSetup/tests/StiffnessMatrixSuite.cxx SysTest/AnalyticPlugins/LinearVelocityAnalytic/LinearVelocityAnalytic.cxx
description:
Change uint to unsigned int


diff -r 03f734bd8f58 -r 34d0c66dfca3 Apps/StokesMomentumUzawa/tests/LidDrivenStokesAnalytic/LidDrivenStokesAnalytic.cxx
--- a/Apps/StokesMomentumUzawa/tests/LidDrivenStokesAnalytic/LidDrivenStokesAnalytic.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/Apps/StokesMomentumUzawa/tests/LidDrivenStokesAnalytic/LidDrivenStokesAnalytic.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -123,7 +123,7 @@ void _StgFEM_LidDrivenStokesAnalytic_Ass
 void _StgFEM_LidDrivenStokesAnalytic_AssignFromXML( void* codelet, Stg_ComponentFactory* cf, void* data ) {
 	StgFEM_LidDrivenStokesAnalytic *self = (StgFEM_LidDrivenStokesAnalytic*)codelet;
 	
-	uint waveSpeed;
+	unsigned int waveSpeed;
 
 	_FieldTest_AssignFromXML( self, cf, data );
 
diff -r 03f734bd8f58 -r 34d0c66dfca3 Assembly/src/DivergenceMatrixTerm.h
--- a/Assembly/src/DivergenceMatrixTerm.h	Tue Oct 18 16:40:33 2011 -0700
+++ b/Assembly/src/DivergenceMatrixTerm.h	Sat Oct 22 19:22:48 2011 -0700
@@ -50,7 +50,7 @@
 		__StiffnessMatrixTerm \
 		/* Virtual info */ \
 		/* DivergenceMatrixTerm info */ \
-		uint		max_nElNodes_col; \
+		unsigned int		max_nElNodes_col; \
 		double	*Ni_col; 
 
 	struct DivergenceMatrixTerm { __DivergenceMatrixTerm };
diff -r 03f734bd8f58 -r 34d0c66dfca3 Assembly/src/GradientStiffnessMatrixTerm.h
--- a/Assembly/src/GradientStiffnessMatrixTerm.h	Tue Oct 18 16:40:33 2011 -0700
+++ b/Assembly/src/GradientStiffnessMatrixTerm.h	Sat Oct 22 19:22:48 2011 -0700
@@ -50,7 +50,7 @@
 		__StiffnessMatrixTerm \
 		/* Virtual info */ \
 		/* GradientStiffnessMatrixTerm info */ \
-		uint		max_nElNodes_col;    \
+		unsigned int		max_nElNodes_col;    \
 		double	*Ni_col;
 
 	struct GradientStiffnessMatrixTerm { __GradientStiffnessMatrixTerm };
diff -r 03f734bd8f58 -r 34d0c66dfca3 Assembly/src/MassMatrixTerm.cxx
--- a/Assembly/src/MassMatrixTerm.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/Assembly/src/MassMatrixTerm.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -177,7 +177,7 @@ void _MassMatrixTerm_AssembleElement(
 	Swarm*                              swarm        = self->integrationSwarm;
 	FeVariable*                         variable1    = stiffnessMatrix->rowVariable;
 	Dimension_Index                     dim          = stiffnessMatrix->dim;
-	uint num_node_dofs = self->field->fieldComponentCount;
+	unsigned int num_node_dofs = self->field->fieldComponentCount;
 	IntegrationPoint*                   currIntegrationPoint;
 	double*                             xi;
 	double                              weight;
diff -r 03f734bd8f58 -r 34d0c66dfca3 Discretisation/src/FeVariable.cxx
--- a/Discretisation/src/FeVariable.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/Discretisation/src/FeVariable.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -2244,8 +2244,8 @@ void FeVariable_ReadFromFile( void* feVa
       ver = FeCHECKPOINT_V1;
    else {
       int checkVer;
-      uint ndims;
-      uint res[self->dim];
+      unsigned int ndims;
+      unsigned int res[self->dim];
       Grid**     grid;
       unsigned*  sizes;
 
@@ -2485,7 +2485,7 @@ void FeVariable_InterpolateFromFile( voi
    hid_t									attrib_id, group_id;
    int									res[3];
    int									checkVer;
-   uint									ndims;
+   unsigned int									ndims;
 	double								crdMin[3], crdMax[3];
 	double*								value;
 	unsigned								nDomainVerts;
diff -r 03f734bd8f58 -r 34d0c66dfca3 Discretisation/src/FieldTest.cxx
--- a/Discretisation/src/FieldTest.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/Discretisation/src/FieldTest.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -359,18 +359,18 @@ void _FieldTest_Initialise( void* fieldT
 		while ( !feof( expected_fp ) ) {
 			fscanf( expected_fp, "%lf ", &self->expected[expected_i].time );
 			
-			for( uint dim_i = 0; dim_i < self->context->dim; dim_i++ )
+			for( unsigned int dim_i = 0; dim_i < self->context->dim; dim_i++ )
 				fscanf( expected_fp, "%lf ", &self->expected[expected_i].place[dim_i] );
 
-			for( uint dof_i = 0; dof_i < self->expectedDofs; dof_i++ )
+			for( unsigned int dof_i = 0; dof_i < self->expectedDofs; dof_i++ )
 				fscanf( expected_fp, "%lf ", &self->expected[expected_i].value[dof_i] );
 
 			fscanf( expected_fp, "%lf ", &self->tolerance[expected_i].time );
 			
-			for( uint dim_i = 0; dim_i < self->context->dim; dim_i++ )
+			for( unsigned int dim_i = 0; dim_i < self->context->dim; dim_i++ )
 				fscanf( expected_fp, "%lf ", &self->tolerance[expected_i].place[dim_i] );
 
-			for( uint dof_i = 0; dof_i < self->expectedDofs; dof_i++ )
+			for( unsigned int dof_i = 0; dof_i < self->expectedDofs; dof_i++ )
 				fscanf( expected_fp, "%lf ", &self->tolerance[expected_i].value[dof_i] );
 
 			expected_i++;
@@ -863,12 +863,12 @@ void _FieldTest_DumpToAnalysisFile( Fiel
 	int			numDofs, dof_I;
 	/* double		error; */
 
-	for(uint field_I = 0; field_I < self->fieldCount; field_I++ ) {
+	for(unsigned int field_I = 0; field_I < self->fieldCount; field_I++ ) {
 		/* should be using MT_VOLUME for the reference field mesh, but seems to have a bug */
 		numDofs	   = self->numericFieldList[field_I]->fieldComponentCount;
 
 #if 0
-		uint dim = self->numericFieldList[field_I]->dim;
+		unsigned int dim = self->numericFieldList[field_I]->dim;
 		/* Fancy error measurements of magnitudes and 2ndInvars, no needed
 		 * but I'm leaving it in incase */
 		if( dim == numDofs ) {
@@ -912,9 +912,9 @@ void FieldTest_EvaluatePhysicsTest( void
 		dumpExpectedFilePtr = fopen( dumpExpectedFileName, "a" );
 
 		fprintf( dumpExpectedFilePtr, "%.8e ", self->numeric[context->timeStep].time );
-		for(uint dim_i = 0; dim_i < context->dim; dim_i++ )
+		for(unsigned int dim_i = 0; dim_i < context->dim; dim_i++ )
 			fprintf( dumpExpectedFilePtr, "%.8e ", self->numeric[context->timeStep].place[dim_i] );
-		for(uint dof_i = 0; dof_i < self->expectedDofs; dof_i++ )
+		for(unsigned int dof_i = 0; dof_i < self->expectedDofs; dof_i++ )
 			fprintf( dumpExpectedFilePtr, "%.8e ", self->numeric[context->timeStep].value[dof_i] );
 
 		fprintf( dumpExpectedFilePtr, "\n" );
diff -r 03f734bd8f58 -r 34d0c66dfca3 Discretisation/src/FieldTest.h
--- a/Discretisation/src/FieldTest.h	Tue Oct 18 16:40:33 2011 -0700
+++ b/Discretisation/src/FieldTest.h	Sat Oct 22 19:22:48 2011 -0700
@@ -83,7 +83,7 @@
 		/* constant to add to analytic element integral */ 		\
 		/* normalising by this so you dont get divide by zero issues */ \
 		double					epsilon; \
-		uint                                    testTimestep; /** the timestep to run the test */  \
+		unsigned int                                    testTimestep; /** the timestep to run the test */  \
 		double**				gAnalyticSq; \
 		double**				gErrorSq;		\
 		double**				gError;			\
diff -r 03f734bd8f58 -r 34d0c66dfca3 Discretisation/src/OperatorFeVariable.cxx
--- a/Discretisation/src/OperatorFeVariable.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/Discretisation/src/OperatorFeVariable.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -480,7 +480,7 @@ void _OperatorFeVariable_SyncShadowValue
 	OperatorFeVariable* self            = (OperatorFeVariable*) feVariable;
 
 	assert( self );
-	for(uint v_i = 0; v_i < self->feVariableCount; v_i++ )
+	for(unsigned int v_i = 0; v_i < self->feVariableCount; v_i++ )
           FeVariable_SyncShadowValues( self->feVariableList[v_i] );
 	self->shadowValuesSynchronised = True;
 }
@@ -491,7 +491,7 @@ Bool _OperatorFeVariable_CheckIfValidToI
 	FeVariable*             currFeVar;
 	Bool                    parentIsValid;
 
-	for (uint feVar_I=0; feVar_I < self->feVariableCount; feVar_I++ ) {
+	for (unsigned int feVar_I=0; feVar_I < self->feVariableCount; feVar_I++ ) {
 		currFeVar = self->feVariableList[feVar_I];
 		if( Stg_Class_IsInstance( currFeVar, FeVariable_Type ) ) {
 			if ( False == currFeVar->shadowValuesSynchronised ) {
diff -r 03f734bd8f58 -r 34d0c66dfca3 Discretisation/tests/FeEquationNumberSuite.cxx
--- a/Discretisation/tests/FeEquationNumberSuite.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/Discretisation/tests/FeEquationNumberSuite.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -195,7 +195,7 @@ void FeEquationNumberSuite_TestLocal( Fe
    int curEqNum;
    int nDofs;
    int rank;
-   uint n_i;
+   unsigned int n_i;
    int dof_i;
 
    eqNum = buildEqNum();
diff -r 03f734bd8f58 -r 34d0c66dfca3 Discretisation/tests/FeVariableSuite.cxx
--- a/Discretisation/tests/FeVariableSuite.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/Discretisation/tests/FeVariableSuite.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -108,7 +108,7 @@ FeVariable* BuildFeVariable_AsPosition( 
 	fieldReg = FieldVariable_Register_New();
 	feVar = FeVariable_New( "velocity", NULL, feMesh, NULL, dofs, NULL, NULL, NULL, dim, True, False, False, fieldReg );
 
-	for(uint n_i = 0; n_i < Mesh_GetLocalSize( feMesh, (MeshTopology_Dim)0 ); n_i++ ) {
+	for(unsigned int n_i = 0; n_i < Mesh_GetLocalSize( feMesh, (MeshTopology_Dim)0 ); n_i++ ) {
 		double* pos = Mesh_GetVertex( feMesh, n_i );
 		Variable_SetValue( var, n_i, pos );
 	}
@@ -177,7 +177,7 @@ FeVariable* BuildFeVariable_AsConstant( 
 	fieldReg = FieldVariable_Register_New();
 	feVar = FeVariable_New( "pressure", NULL, feMesh, NULL, dofs, NULL, NULL, NULL, dim, True, False, False, fieldReg );
 
-	for(uint n_i = 0; n_i < Mesh_GetLocalSize( feMesh, (MeshTopology_Dim)0 ); n_i++ ) {
+	for(unsigned int n_i = 0; n_i < Mesh_GetLocalSize( feMesh, (MeshTopology_Dim)0 ); n_i++ ) {
 		Variable_SetValue( var, n_i, constant );
 	}
 
diff -r 03f734bd8f58 -r 34d0c66dfca3 SLE/SystemSetup/src/ForceVector.cxx
--- a/SLE/SystemSetup/src/ForceVector.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/SLE/SystemSetup/src/ForceVector.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -461,7 +461,7 @@ void ForceVector_GlobalAssembly_General(
 
                            dofs = self->feVariable->dofLayout; /* shortcut to the dof layout */
                            curInd = 0; /* need a counter to track where we are in the element force vector */
-                           for(uint ii = 0; ii < nodeCountCurrElement; ii++ ) {
+                           for(unsigned int ii = 0; ii < nodeCountCurrElement; ii++ ) {
                               nDofs = dofs->dofCounts[inc[ii]]; /* number of dofs on this node */
                               for( jj = 0; jj < nDofs; jj++ ) {
                                  if( !FeVariable_IsBC( self->feVariable, inc[ii], jj ) ) {
diff -r 03f734bd8f58 -r 34d0c66dfca3 SLE/SystemSetup/src/SROpGenerator.cxx
--- a/SLE/SystemSetup/src/SROpGenerator.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/SLE/SystemSetup/src/SROpGenerator.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -745,7 +745,7 @@ Mat SROpGenerator_SimpleFinestLevel( SRO
 Mat SROpGenerator_SimpleFinestLevel( SROpGenerator *self ) {
    FeMesh *mesh;
    int nDims, nDofsPerNode;
-   uint sideSizes[2][3];
+   unsigned int sideSizes[2][3];
    int inds[2][3], offsInds[3], nOffs[3];
    int nGlobalNodes[2];
    int nGlobalEqs[2];
@@ -852,7 +852,7 @@ Mat SROpGenerator_SimpleFinestLevel( SRO
    VecDuplicate( vec_d_nnz, &vec_o_nnz );
 
    /* Loop over fine nodes. */
-   for(uint ii = 0; ii < Mesh_GetLocalSize( mesh, (MeshTopology_Dim)0 ); ii++ ) {
+   for(unsigned int ii = 0; ii < Mesh_GetLocalSize( mesh, (MeshTopology_Dim)0 ); ii++ ) {
       nodeInd = Mesh_DomainToGlobal( mesh, (MeshTopology_Dim)0, ii );
       Grid_Lift( vertGrid, nodeInd, (unsigned*)(inds[1]) );
 
@@ -866,7 +866,7 @@ Mat SROpGenerator_SimpleFinestLevel( SRO
       /* 'Multiply' the offsets to build the set of nodes we need to
          interpolate from. */
       Grid_SetSizes( offsGrid, (unsigned*)nOffs );
-      for(uint jj = 0; jj < offsGrid->nPoints; jj++ ) {
+      for(unsigned int jj = 0; jj < offsGrid->nPoints; jj++ ) {
          Grid_Lift( offsGrid, jj, (unsigned*)offsInds );
          for(int kk = 0; kk < nDims; kk++ )
             inds[0][kk] = (inds[1][kk] >> 1) + offsInds[kk];
@@ -895,7 +895,7 @@ Mat SROpGenerator_SimpleFinestLevel( SRO
          }
 
 
-         for(uint jj = 0; jj < offsGrid->nPoints; jj++ ) {
+         for(unsigned int jj = 0; jj < offsGrid->nPoints; jj++ ) {
             indices[jj] = nodes[jj] * nDofsPerNode + kk;
           //  printf( "[%d]: (owner=%d): row=%d : c_index=%d \n", rank, proc_owner, row_idx, indices[jj] );
 	    if( (row_idx>=rranges[proc_owner]) && (row_idx<rranges[proc_owner+1]) ) {          
@@ -959,7 +959,7 @@ Mat SROpGenerator_SimpleFinestLevel( SRO
    }
 
    /* Loop over fine nodes. */
-   for(uint ii = 0; ii < Mesh_GetLocalSize( mesh, (MeshTopology_Dim)0 ); ii++ ) {
+   for(unsigned int ii = 0; ii < Mesh_GetLocalSize( mesh, (MeshTopology_Dim)0 ); ii++ ) {
 //      if( ii%5000 == 0 ) {
 //        PetscPrintf( PETSC_COMM_WORLD, "Done %d of %d \n", ii, Mesh_GetLocalSize( mesh, 0 ) );
 //      }
@@ -976,7 +976,7 @@ Mat SROpGenerator_SimpleFinestLevel( SRO
       /* 'Multiply' the offsets to build the set of nodes we need to
          interpolate from. */
       Grid_SetSizes( offsGrid, (unsigned*)nOffs );
-      for(uint jj = 0; jj < offsGrid->nPoints; jj++ ) {
+      for(unsigned int jj = 0; jj < offsGrid->nPoints; jj++ ) {
          Grid_Lift( offsGrid, jj, (unsigned*)offsInds );
          for(int kk = 0; kk < nDims; kk++ )
             inds[0][kk] = (inds[1][kk] >> 1) + offsInds[kk];
@@ -993,7 +993,7 @@ Mat SROpGenerator_SimpleFinestLevel( SRO
          if( self->fineVar->eqNum->destinationArray[ii][kk] == -1 )
             continue;
 
-         for(uint jj = 0; jj < offsGrid->nPoints; jj++ ) {
+         for(unsigned int jj = 0; jj < offsGrid->nPoints; jj++ ) {
             indices[jj] = nodes[jj] * nDofsPerNode + kk;
             values[jj] = dfrac;
          }
@@ -1048,7 +1048,7 @@ Mat SROpGenerator_SimpleCoarserLevel( SR
 Mat SROpGenerator_SimpleCoarserLevel( SROpGenerator *self, int level ) {
    FeMesh *mesh;
    int nDims, nDofsPerNode, rowDof;
-   uint sideSizes[2][3];
+   unsigned int sideSizes[2][3];
    int inds[2][3], offsInds[3], nOffs[3];
    int nGlobalNodes[2];
    int nGlobalEqs[2];
@@ -1072,7 +1072,7 @@ Mat SROpGenerator_SimpleCoarserLevel( SR
 
    /* Calculate depth fraction. */
    ifrac = 1;
-   for(uint ii = 0; ii < self->nLevels - level - 1; ii++ )
+   for(unsigned int ii = 0; ii < self->nLevels - level - 1; ii++ )
       ifrac *= 2;
 
    /* Calculate level side lengths. */
@@ -1182,7 +1182,7 @@ Mat SROpGenerator_SimpleCoarserLevel( SR
       /* 'Multiply' the offsets to build the set of nodes we need to
          interpolate from. */
       Grid_SetSizes( offsGrid, (unsigned*)(nOffs) );
-      for(uint jj = 0; jj < offsGrid->nPoints; jj++ ) {
+      for(unsigned int jj = 0; jj < offsGrid->nPoints; jj++ ) {
         Grid_Lift( offsGrid, jj, (unsigned*)(offsInds) );
          for(int kk = 0; kk < nDims; kk++ )
             inds[0][kk] = (inds[1][kk] >> 1) + offsInds[kk];
@@ -1215,7 +1215,7 @@ Mat SROpGenerator_SimpleCoarserLevel( SR
       }
 */
 
-      for(uint jj = 0; jj < offsGrid->nPoints; jj++ ) {
+      for(unsigned int jj = 0; jj < offsGrid->nPoints; jj++ ) {
          indices[jj] = nodes[jj] * nDofsPerNode + rowDof;
 //         printf("ridx=%d,cidx=%d : owner:%d rrange [%d-%d] : crange [%d-%d] \n", row_idx, indices[jj], proc_owner, row_ranges[proc_owner],row_ranges[proc_owner+1], col_ranges[proc_owner], col_ranges[proc_owner+1] );
          if( (row_idx>=row_ranges[proc_owner]) && (row_idx<row_ranges[proc_owner+1]) ) {
@@ -1274,7 +1274,7 @@ Mat SROpGenerator_SimpleCoarserLevel( SR
       /* 'Multiply' the offsets to build the set of nodes we need to
          interpolate from. */
       Grid_SetSizes( offsGrid, (unsigned*)(nOffs) );
-      for(uint jj = 0; jj < offsGrid->nPoints; jj++ ) {
+      for(unsigned int jj = 0; jj < offsGrid->nPoints; jj++ ) {
         Grid_Lift( offsGrid, jj, (unsigned*)(offsInds) );
          for(int kk = 0; kk < nDims; kk++ )
             inds[0][kk] = (inds[1][kk] >> 1) + offsInds[kk];
@@ -1286,7 +1286,7 @@ Mat SROpGenerator_SimpleCoarserLevel( SR
       /* Insert this row into the operator matrix. */
       dfrac = 1.0 / (double)offsGrid->nPoints;
       nEntries = offsGrid->nPoints;
-      for(uint jj = 0; jj < offsGrid->nPoints; jj++ ) {
+      for(unsigned int jj = 0; jj < offsGrid->nPoints; jj++ ) {
          indices[jj] = nodes[jj] * nDofsPerNode + rowDof;
          values[jj] = dfrac;
       }
diff -r 03f734bd8f58 -r 34d0c66dfca3 SLE/SystemSetup/src/StiffnessMatrix.cxx
--- a/SLE/SystemSetup/src/StiffnessMatrix.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/SLE/SystemSetup/src/StiffnessMatrix.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -650,7 +650,7 @@ void _StiffnessMatrix_CalcAndUpdateNonZe
 	Node_Index		uniqueRelatedColNodes_AllocCount = 0;
 	Node_Index		uniqueRelatedColNode_I = 0;
 	Dof_Index		currNodeDof_I = 0;
-	uint            	currDofMatrixRow = 0;
+	unsigned int            	currDofMatrixRow = 0;
 	unsigned		nNodeInc, *nodeInc;
 
 	Journal_DPrintfL( self->debug, 3, "In %s - for row local node %d\n", __func__, rowNode_lI );
@@ -702,7 +702,7 @@ void _StiffnessMatrix_CalcAndUpdateNonZe
 
 				for ( currNodeDof_I = 0; currNodeDof_I < self->rowVariable->dofLayout->dofCounts[rowNode_lI]; currNodeDof_I++) {
 					if ( -1 != rowEqNum->destinationArray[rowNode_lI][currNodeDof_I] ) {
-						currDofMatrixRow = *(uint*)STreeMap_Map(
+						currDofMatrixRow = *(unsigned int*)STreeMap_Map(
 							rowEqNum->ownedMap,
 							rowEqNum->destinationArray[rowNode_lI] + currNodeDof_I );
 
@@ -2784,8 +2784,8 @@ void StiffnessMatrix_CalcNonZeros( void*
 	memset( nOffDiagNonZeros, 0, nRowEqs * sizeof(int) );
 	netNonZeros = 0;
 
-	for(uint n_i = 0; n_i < FeMesh_GetNodeLocalSize( rowMesh ); n_i++ ) {
-		for(uint dof_i = 0; dof_i < rowDofs->dofCounts[n_i]; dof_i++ ) {
+	for(unsigned int n_i = 0; n_i < FeMesh_GetNodeLocalSize( rowMesh ); n_i++ ) {
+		for(unsigned int dof_i = 0; dof_i < rowDofs->dofCounts[n_i]; dof_i++ ) {
 			rowEq = rowEqNum->destinationArray[n_i][dof_i];
 
 			if( rowEq == -1 ) continue;
@@ -2804,7 +2804,7 @@ void StiffnessMatrix_CalcNonZeros( void*
 				colNodes = IArray_GetPtr( self->colInc );
 
 				for( n_j = 0; n_j < nColNodes; n_j++ ) {
-					for(uint dof_j = 0; dof_j < colDofs->dofCounts[colNodes[n_j]]; dof_j++ ) {
+					for(unsigned int dof_j = 0; dof_j < colDofs->dofCounts[colNodes[n_j]]; dof_j++ ) {
 						colEq = colEqNum->destinationArray[colNodes[n_j]][dof_j];
 
 						if( colEq == -1 ) continue;
diff -r 03f734bd8f58 -r 34d0c66dfca3 SLE/SystemSetup/src/StiffnessMatrixTerm.h
--- a/SLE/SystemSetup/src/StiffnessMatrixTerm.h	Tue Oct 18 16:40:33 2011 -0700
+++ b/SLE/SystemSetup/src/StiffnessMatrixTerm.h	Sat Oct 22 19:22:48 2011 -0700
@@ -79,7 +79,7 @@
 		/* Data for GNx storage */ \
 	        double                   **GNx; /* store globalDerivative ptr here */ \
 	        double                   *N; /* store array for shape functions here */ \
-		uint                      max_nElNodes;  /* holds the maxNumNodes per element */ 
+		unsigned int                      max_nElNodes;  /* holds the maxNumNodes per element */ 
 	
 	struct StiffnessMatrixTerm { __StiffnessMatrixTerm };
 	
diff -r 03f734bd8f58 -r 34d0c66dfca3 SLE/SystemSetup/tests/SolutionVectorSuite.cxx
--- a/SLE/SystemSetup/tests/SolutionVectorSuite.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/SLE/SystemSetup/tests/SolutionVectorSuite.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -93,7 +93,7 @@ FeVariable* SolutionVectorSuite_buildFeV
    feVar = FeVariable_New( "velocity", NULL, feMesh, NULL, dofs, bcs, NULL, NULL, 2, True, 
 		False, False, fieldReg );
 
-   for(uint n_i=0; n_i<Mesh_GetLocalSize( feMesh, (MeshTopology_Dim)0); n_i++) {
+   for(unsigned int n_i=0; n_i<Mesh_GetLocalSize( feMesh, (MeshTopology_Dim)0); n_i++) {
       /*const double pi=acos(-1.0);*/
       double* pos = Mesh_GetVertex( feMesh, n_i );
 
diff -r 03f734bd8f58 -r 34d0c66dfca3 SLE/SystemSetup/tests/StiffnessMatrixSuite.cxx
--- a/SLE/SystemSetup/tests/StiffnessMatrixSuite.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/SLE/SystemSetup/tests/StiffnessMatrixSuite.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -91,7 +91,7 @@ FeVariable* buildFeVar() {
    feVar = FeVariable_New( "velocity", NULL, feMesh, NULL, dofs, bcs, NULL, NULL, 2, True, 
 		False, False, fieldReg );
 
-   for(uint n_i=0; n_i<Mesh_GetLocalSize( feMesh, (MeshTopology_Dim)0); n_i++) {
+   for(unsigned int n_i=0; n_i<Mesh_GetLocalSize( feMesh, (MeshTopology_Dim)0); n_i++) {
       /*const double pi=acos(-1.0);*/
       double* pos = Mesh_GetVertex( feMesh, n_i );
 
diff -r 03f734bd8f58 -r 34d0c66dfca3 SysTest/AnalyticPlugins/LinearVelocityAnalytic/LinearVelocityAnalytic.cxx
--- a/SysTest/AnalyticPlugins/LinearVelocityAnalytic/LinearVelocityAnalytic.cxx	Tue Oct 18 16:40:33 2011 -0700
+++ b/SysTest/AnalyticPlugins/LinearVelocityAnalytic/LinearVelocityAnalytic.cxx	Sat Oct 22 19:22:48 2011 -0700
@@ -51,7 +51,7 @@ typedef struct {
 	FeVariable* velocityField;
 	double  nodeVelocity[8][3];
 	double  nodeCoords[8][3];
-	uint    cornerNodeCount;
+	unsigned int    cornerNodeCount;
 } LinearVelocityAnalytic;
 
 Index Grid_ProjectIJK( Grid* grid, Index i, Index j, Index k ) {



More information about the CIG-COMMITS mailing list