<p><b>dwj07@fsu.edu</b> 2011-10-24 09:33:55 -0600 (Mon, 24 Oct 2011)</p><p><br>
        -- TRUNK COMMIT --<br>
<br>
        Renaming some routines and moduels that were previously overlooked.<br>
<br>
        Making them fit in with the previously discussed naming scheme.<br>
</p><hr noshade><pre><font color="gray">Modified: trunk/mpas/src/core_ocean/mpas_ocn_advection.F
===================================================================
--- trunk/mpas/src/core_ocean/mpas_ocn_advection.F        2011-10-21 21:23:23 UTC (rev 1119)
+++ trunk/mpas/src/core_ocean/mpas_ocn_advection.F        2011-10-24 15:33:55 UTC (rev 1120)
@@ -1,4 +1,4 @@
-module advection
+module ocn_advection
 
    use mpas_grid_types
    use mpas_configure
@@ -8,7 +8,7 @@
    contains
 
 
-   subroutine initialize_advection_rk( grid )
+   subroutine ocn_initialize_advection_rk( grid )
                                       
 !
 ! compute the cell coefficients for the polynomial fit.
@@ -254,7 +254,7 @@
  
          end if
  
-         call poly_fit_2( amatrix, bmatrix, wmatrix, ma, na, 25 )
+         call ocn_poly_fit_2( amatrix, bmatrix, wmatrix, ma, na, 25 )
 
          do i=1,grid % nEdgesOnCell % array (iCell)
             ip1 = i+1
@@ -269,7 +269,7 @@
             zv2 = grid % zVertex % array(grid % verticesOnEdge % array (2,iedge))/a
   
             if ( grid % on_a_sphere ) then
-               call arc_bisect( xv1, yv1, zv1,  &amp;
+               call ocn_arc_bisect( xv1, yv1, zv1,  &amp;
                                 xv2, yv2, zv2,  &amp;
                                 xec, yec, zec   )
   
@@ -381,7 +381,7 @@
 !      end do
 !      stop
 
-   end subroutine initialize_advection_rk
+   end subroutine ocn_initialize_advection_rk
 
 
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
@@ -522,13 +522,13 @@
    
    
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
-   ! SUBROUTINE ARC_BISECT
+   ! SUBROUTine ocn_arc_bisect
    !
    ! Returns the point C=(cx, cy, cz) that bisects the great circle arc from
    !   A=(ax, ay, az) to B=(bx, by, bz). It is assumed that A and B lie on the
    !   surface of a sphere centered at the origin.
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
-   subroutine arc_bisect(ax, ay, az, bx, by, bz, cx, cy, cz)
+   subroutine ocn_arc_bisect(ax, ay, az, bx, by, bz, cx, cy, cz)
    
       implicit none
    
@@ -553,10 +553,10 @@
          cz = r * cz / d
       end if
    
-   end subroutine arc_bisect
+   end subroutine ocn_arc_bisect
 
 
-   subroutine poly_fit_2(a_in,b_out,weights_in,m,n,ne)
+   subroutine ocn_poly_fit_2(a_in,b_out,weights_in,m,n,ne)
 
       implicit none
 
@@ -593,14 +593,14 @@
       ata = matmul(at,a)
 
 !      if (m == n) then
-!         call MIGS(a,n,b,indx)
+!         call ocn_migs(a,n,b,indx)
 !      else
 
-         call MIGS(atha,n,atha_inv,indx)
+         call ocn_migs(atha,n,atha_inv,indx)
 
          b = matmul(atha_inv,ath)
 
-!         call MIGS(ata,n,ata_inv,indx)
+!         call ocn_migs(ata,n,ata_inv,indx)
 !         b = matmul(ata_inv,at)
 !      end if
       b_out(1:n,1:m) = b(1:n,1:m)
@@ -611,7 +611,7 @@
 !
 !     write(6,*) ' '
 
-   end subroutine poly_fit_2
+   end subroutine ocn_poly_fit_2
 
 
 ! Updated 10/24/2001.
@@ -630,7 +630,7 @@
 !                                                                       !
 !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
 !
-SUBROUTine MIGS (A,N,X,INDX)
+SUBROUTine ocn_migs (A,N,X,INDX)
 !
 ! Subroutine to invert matrix A(N,N) with the inverse stored
 ! in X(N,N) in the output.  Copyright (c) Tao Pang 2001.
@@ -652,7 +652,7 @@
     B(I,I) = 1.0
   END DO
 !
-  CALL ELGS (A,N,INDX)
+  call ocn_elgs (A,N,INDX)
 !
   DO I = 1, N-1
     DO J = I+1, N
@@ -672,10 +672,10 @@
       X(J,I) =  X(J,I)/A(INDX(J),J)
     END DO
   END DO
-END SUBROUTine MIGS
+END SUBROUTine ocn_migs
 
 
-SUBROUTINE ELGS (A,N,INDX)
+SUBROUTine ocn_elgs (A,N,INDX)
 !
 ! Subroutine to perform the partial-pivoting Gaussian elimination.
 ! A(N,N) is the original matrix in the input and transformed matrix
@@ -738,11 +738,11 @@
     END DO
   END DO
 !
-END SUBROUTINE ELGS
+END SUBROUTine ocn_elgs
 
 !-------------------------------------------------------------
 
-   subroutine initialize_deformation_weights( grid )
+   subroutine ocn_initialize_deformation_weights( grid )
                                       
 !
 ! compute the cell coefficients for the deformation calculations
@@ -929,6 +929,6 @@
 
       if (debug) write(0,*) ' exiting def weight calc '
 
-   end subroutine initialize_deformation_weights
+   end subroutine ocn_initialize_deformation_weights
 
-end module advection
+end module ocn_advection

Modified: trunk/mpas/src/core_ocean/mpas_ocn_global_diagnostics.F
===================================================================
--- trunk/mpas/src/core_ocean/mpas_ocn_global_diagnostics.F        2011-10-21 21:23:23 UTC (rev 1119)
+++ trunk/mpas/src/core_ocean/mpas_ocn_global_diagnostics.F        2011-10-24 15:33:55 UTC (rev 1120)
@@ -1,4 +1,4 @@
-module global_diagnostics
+module ocn_global_diagnostics
 
    use mpas_grid_types
    use mpas_configure
@@ -11,7 +11,7 @@
 
    contains
 
-   subroutine computeGlobalDiagnostics(dminfo, state, grid, timeIndex, dt)
+   subroutine ocn_compute_global_diagnostics(dminfo, state, grid, timeIndex, dt)
 
       ! Note: this routine assumes that there is only one block per processor. No looping
       ! is preformed over blocks.
@@ -86,88 +86,88 @@
       variableIndex = 0
       ! h
       variableIndex = variableIndex + 1
-      call computeFieldAreaWeightedLocalStats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
+      call ocn_compute_field_area_weighted_local_stats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
         sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), verticalSumMaxes(variableIndex))
 
       ! u
       variableIndex = variableIndex + 1
-      call computeFieldVolumeWeightedLocalStats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), h_edge(:,1:nEdgesSolve), &amp;
+      call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), h_edge(:,1:nEdgesSolve), &amp;
         u(:,1:nEdgesSolve), sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), &amp;
         verticalSumMaxes(variableIndex))
 
       ! v
       variableIndex = variableIndex + 1
-      call computeFieldVolumeWeightedLocalStats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), h_edge(:,1:nEdgesSolve), &amp;
+      call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), h_edge(:,1:nEdgesSolve), &amp;
         v(:,1:nEdgesSolve), sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), &amp;
         verticalSumMaxes(variableIndex))
 
       ! h_edge
       variableIndex = variableIndex + 1
-      call computeFieldAreaWeightedLocalStats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), h_edge(:,1:nEdgesSolve), &amp;
+      call ocn_compute_field_area_weighted_local_stats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), h_edge(:,1:nEdgesSolve), &amp;
         sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), verticalSumMaxes(variableIndex))
 
       ! circulation
       variableIndex = variableIndex + 1
-      call computeFieldLocalStats(dminfo, nVertLevels, nVerticesSolve, circulation(:,1:nVerticesSolve), &amp;
+      call ocn_compute_field_local_stats(dminfo, nVertLevels, nVerticesSolve, circulation(:,1:nVerticesSolve), &amp;
         sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), verticalSumMaxes(variableIndex))
 
       ! vorticity
       variableIndex = variableIndex + 1
-      call computeFieldAreaWeightedLocalStats(dminfo, nVertLevels, nVerticesSolve, areaTriangle(1:nVerticesSolve), &amp;
+      call ocn_compute_field_area_weighted_local_stats(dminfo, nVertLevels, nVerticesSolve, areaTriangle(1:nVerticesSolve), &amp;
         vorticity(:,1:nVerticesSolve), sums(variableIndex), mins(variableIndex), maxes(variableIndex), &amp;
         verticalSumMins(variableIndex), verticalSumMaxes(variableIndex))
 
       ! ke
       variableIndex = variableIndex + 1
-      call computeFieldVolumeWeightedLocalStats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
+      call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
         ke(:,1:nCellsSolve), sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), &amp;
         verticalSumMaxes(variableIndex))
 
       ! pv_edge
       variableIndex = variableIndex + 1
-      call computeFieldVolumeWeightedLocalStats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), h_edge(:,1:nEdgesSolve), &amp;
+      call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), h_edge(:,1:nEdgesSolve), &amp;
         pv_edge(:,1:nEdgesSolve), sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), &amp;
         verticalSumMaxes(variableIndex))
 
       ! pv_vertex
       variableIndex = variableIndex + 1
-      call computeFieldAreaWeightedLocalStats(dminfo, nVertLevels, nVerticesSolve, areaTriangle(1:nVerticesSolve), &amp;
+      call ocn_compute_field_area_weighted_local_stats(dminfo, nVertLevels, nVerticesSolve, areaTriangle(1:nVerticesSolve), &amp;
         pv_vertex(:,1:nVerticesSolve), sums(variableIndex), mins(variableIndex), maxes(variableIndex), &amp;
         verticalSumMins(variableIndex), verticalSumMaxes(variableIndex))
 
       ! pv_cell
       variableIndex = variableIndex + 1
-      call computeFieldVolumeWeightedLocalStats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
+      call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
         pv_cell(:,1:nCellsSolve), sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), &amp;
         verticalSumMaxes(variableIndex))
 
       ! gradPVn
       variableIndex = variableIndex + 1
-      call computeFieldVolumeWeightedLocalStats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), h_edge(:,1:nEdgesSolve), &amp;
+      call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), h_edge(:,1:nEdgesSolve), &amp;
         gradPVn(:,1:nEdgesSolve), sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), &amp;
         verticalSumMaxes(variableIndex))
 
       ! gradPVt
       variableIndex = variableIndex + 1
-      call computeFieldVolumeWeightedLocalStats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), h_edge(:,1:nEdgesSolve), &amp;
+      call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), h_edge(:,1:nEdgesSolve), &amp;
         gradPVt(:,1:nEdgesSolve), sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), &amp;
         verticalSumMaxes(variableIndex))
 
       ! pressure
       variableIndex = variableIndex + 1
-      call computeFieldVolumeWeightedLocalStats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
+      call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
         pressure(:,1:nCellsSolve), sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), &amp;
         verticalSumMaxes(variableIndex))
 
       ! MontPot
       variableIndex = variableIndex + 1
-      call computeFieldVolumeWeightedLocalStats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
+      call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
         MontPot(:,1:nCellsSolve), sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), &amp;
         verticalSumMaxes(variableIndex))
 
       ! wTop vertical velocity
       variableIndex = variableIndex + 1
-      call computeFieldVolumeWeightedLocalStats(dminfo, nVertLevels+1, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
+      call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels+1, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
         wTop(:,1:nCellsSolve), sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), &amp;
         verticalSumMaxes(variableIndex))
 
@@ -176,7 +176,7 @@
       do iTracer=1,num_tracers
         variableIndex = variableIndex + 1
         tracerTemp = Tracers(iTracer,:,1:nCellsSolve)
-        call computeFieldVolumeWeightedLocalStats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
+        call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), h(:,1:nCellsSolve), &amp;
           tracerTemp, sums(variableIndex), mins(variableIndex), maxes(variableIndex), verticalSumMins(variableIndex), &amp;
           verticalSumMaxes(variableIndex))
       enddo
@@ -310,27 +310,27 @@
       if (dminfo % my_proc_id == IO_NODE) then
          fileID = getFreeUnit()
          open(fileID,file='stats_min.txt',ACCESS='append')
-            write (fileID,'(100es24.16)') mins(1:nVariables)
+            write (fileID,'(100es24.14)') mins(1:nVariables)
          close (fileID)
          open(fileID,file='stats_max.txt',ACCESS='append')
-            write (fileID,'(100es24.16)') maxes(1:nVariables)
+            write (fileID,'(100es24.14)') maxes(1:nVariables)
          close (fileID)
          open(fileID,file='stats_sum.txt',ACCESS='append')
-            write (fileID,'(100es24.16)') sums(1:nVariables)
+            write (fileID,'(100es24.14)') sums(1:nVariables)
          close (fileID)
          open(fileID,file='stats_avg.txt',ACCESS='append')
-            write (fileID,'(100es24.16)') averages(1:nVariables)
+            write (fileID,'(100es24.14)') averages(1:nVariables)
          close (fileID)
          open(fileID,file='stats_time.txt',ACCESS='append')
-            write (fileID,'(i5,10x,a,100es24.16)') timeIndex, &amp;
+            write (fileID,'(i5,10x,a,100es24.14)') timeIndex, &amp;
                state % xtime % scalar, dt, &amp;
                CFLNumberGlobal
          close (fileID)
          open(fileID,file='stats_colmin.txt',ACCESS='append')
-            write (fileID,'(100es24.16)') verticalSumMins(1:nVariables)
+            write (fileID,'(100es24.14)') verticalSumMins(1:nVariables)
          close (fileID)
          open(fileID,file='stats_colmax.txt',ACCESS='append')
-            write (fileID,'(100es24.16)') verticalSumMaxes(1:nVariables)
+            write (fileID,'(100es24.14)') verticalSumMaxes(1:nVariables)
          close (fileID)
       end if
 
@@ -343,7 +343,7 @@
       state % CFLNumberGlobal % scalar = CFLNumberGlobal
       deallocate(areaEdge)
 
-   end subroutine computeGlobalDiagnostics
+   end subroutine ocn_compute_global_diagnostics
 
    integer function getFreeUnit()
       implicit none
@@ -363,7 +363,7 @@
       end do
    end function getFreeUnit
 
-   subroutine computeFieldLocalStats(dminfo, nVertLevels, nElements, field, localSum, localMin, localMax, localVertSumMin, &amp;
+   subroutine ocn_compute_field_local_stats(dminfo, nVertLevels, nElements, field, localSum, localMin, localMax, localVertSumMin, &amp;
       localVertSumMax)
 
       implicit none
@@ -380,9 +380,9 @@
       localVertSumMin = minval(sum(field,1))
       localVertSumMax = maxval(sum(field,1))
 
-   end subroutine computeFieldLocalStats
+   end subroutine ocn_compute_field_local_stats
 
-   subroutine computeFieldAreaWeightedLocalStats(dminfo, nVertLevels, nElements, areas, field, localSum, localMin, &amp;
+   subroutine ocn_compute_field_area_weighted_local_stats(dminfo, nVertLevels, nElements, areas, field, localSum, localMin, &amp;
       localMax, localVertSumMin, localVertSumMax)
 
       implicit none
@@ -406,9 +406,9 @@
       localVertSumMin = minval(sum(field,1))
       localVertSumMax = maxval(sum(field,1))
 
-   end subroutine computeFieldAreaWeightedLocalStats
+   end subroutine ocn_compute_field_area_weighted_local_stats
 
-   subroutine computeFieldThicknessWeightedLocalStats(dminfo, nVertLevels, nElements, h, field, &amp;
+   subroutine ocn_compute_field_thickness_weighted_local_stats(dminfo, nVertLevels, nElements, h, field, &amp;
       localSum, localMin, localMax, localVertSumMin, localVertSumMax)
 
       implicit none
@@ -430,9 +430,9 @@
       localVertSumMin = minval(sum(h*field,1))
       localVertSumMax = maxval(sum(h*field,1))
 
-   end subroutine computeFieldThicknessWeightedLocalStats
+   end subroutine ocn_compute_field_thickness_weighted_local_stats
 
-   subroutine computeFieldVolumeWeightedLocalStats(dminfo, nVertLevels, nElements, areas, h, field, &amp;
+   subroutine ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nElements, areas, h, field, &amp;
       localSum, localMin, localMax, localVertSumMin, localVertSumMax)
 
       implicit none
@@ -459,10 +459,10 @@
       localVertSumMin = minval(sum(h*field,1))
       localVertSumMax = maxval(sum(h*field,1))
 
-   end subroutine computeFieldVolumeWeightedLocalStats
+   end subroutine ocn_compute_field_volume_weighted_local_stats
 
 
-   subroutine computeGlobalSum(dminfo, nVertLevels, nElements, field, globalSum)
+   subroutine ocn_compute_global_sum(dminfo, nVertLevels, nElements, field, globalSum)
 
       implicit none
 
@@ -476,9 +476,9 @@
       localSum = sum(field)
       call mpas_dmpar_sum_real(dminfo, localSum, globalSum)
 
-   end subroutine computeGlobalSum
+   end subroutine ocn_compute_global_sum
 
-   subroutine computeAreaWeightedGlobalSum(dminfo, nVertLevels, nElements, areas, field, globalSum)
+   subroutine ocn_compute_area_weighted_global_sum(dminfo, nVertLevels, nElements, areas, field, globalSum)
 
       implicit none
 
@@ -498,9 +498,9 @@
    
       call mpas_dmpar_sum_real(dminfo, localSum, globalSum)
        
-   end subroutine computeAreaWeightedGlobalSum
+   end subroutine ocn_compute_area_weighted_global_sum
 
-   subroutine computeVolumeWeightedGlobalSum(dminfo, nVertLevels, nElements, areas, h, field, globalSum)
+   subroutine ocn_compute_volume_weighted_global_sum(dminfo, nVertLevels, nElements, areas, h, field, globalSum)
 
       implicit none
 
@@ -515,11 +515,11 @@
 
       hTimesField = h*field
 
-      call computeAreaWeightedGlobalSum(dminfo, nVertLevels, nElements, areas, hTimesField, globalSum)
+      call ocn_compute_area_weighted_global_sum(dminfo, nVertLevels, nElements, areas, hTimesField, globalSum)
 
-   end subroutine computeVolumeWeightedGlobalSum
+   end subroutine ocn_compute_volume_weighted_global_sum
 
-   subroutine computeGlobalMin(dminfo, nVertLevels, nElements, field, globalMin)
+   subroutine ocn_compute_global_min(dminfo, nVertLevels, nElements, field, globalMin)
 
       implicit none
 
@@ -533,9 +533,9 @@
       localMin = minval(field)
       call mpas_dmpar_min_real(dminfo, localMin, globalMin)
 
-   end subroutine computeGlobalMin
+   end subroutine ocn_compute_global_min
 
-   subroutine computeGlobalMax(dminfo, nVertLevels, nElements, field, globalMax)
+   subroutine ocn_compute_global_max(dminfo, nVertLevels, nElements, field, globalMax)
 
       implicit none
 
@@ -549,9 +549,9 @@
       localMax = maxval(field)
       call mpas_dmpar_max_real(dminfo, localMax, globalMax)
 
-   end subroutine computeGlobalMax
+   end subroutine ocn_compute_global_max
 
-   subroutine computeGlobalVertSumHorizMin(dminfo, nVertLevels, nElements, field, globalMin)
+   subroutine ocn_compute_global_vert_sum_horiz_min(dminfo, nVertLevels, nElements, field, globalMin)
 
       implicit none
 
@@ -565,9 +565,9 @@
       localMin = minval(sum(field,1))
       call mpas_dmpar_min_real(dminfo, localMin, globalMin)
 
-   end subroutine computeGlobalVertSumHorizMin
+   end subroutine ocn_compute_global_vert_sum_horiz_min
 
-   subroutine computeGlobalVertSumHorizMax(dminfo, nVertLevels, nElements, field, globalMax)
+   subroutine ocn_compute_global_vert_sum_horiz_max(dminfo, nVertLevels, nElements, field, globalMax)
 
       implicit none
 
@@ -581,9 +581,9 @@
       localMax = maxval(sum(field,1))
       call mpas_dmpar_max_real(dminfo, localMax, globalMax)
 
-   end subroutine computeGlobalVertSumHorizMax
+   end subroutine ocn_compute_global_vert_sum_horiz_max
 
-   subroutine computeGlobalVertThicknessWeightedSumHorizMin(dminfo, nVertLevels, nElements, h, field, globalMin)
+   subroutine ocn_compute_global_vert_thickness_weighted_sum_horiz_min(dminfo, nVertLevels, nElements, h, field, globalMin)
 
       implicit none
 
@@ -597,9 +597,9 @@
       localMin = minval(sum(h*field,1))
       call mpas_dmpar_min_real(dminfo, localMin, globalMin)
 
-   end subroutine computeGlobalVertThicknessWeightedSumHorizMin
+   end subroutine ocn_compute_global_vert_thickness_weighted_sum_horiz_min
 
-   subroutine computeGlobalVertThicknessWeightedSumHorizMax(dminfo, nVertLevels, nElements, h, field, globalMax)
+   subroutine ocn_compute_global_vert_thickness_weighted_sum_horiz_max(dminfo, nVertLevels, nElements, h, field, globalMax)
 
       implicit none
 
@@ -613,6 +613,6 @@
       localMax = maxval(sum(h*field,1))
       call mpas_dmpar_max_real(dminfo, localMax, globalMax)
 
-   end subroutine computeGlobalVertThicknessWeightedSumHorizMax
+   end subroutine ocn_compute_global_vert_thickness_weighted_sum_horiz_max
 
-end module global_diagnostics
+end module ocn_global_diagnostics

Modified: trunk/mpas/src/core_ocean/mpas_ocn_mpas_core.F
===================================================================
--- trunk/mpas/src/core_ocean/mpas_ocn_mpas_core.F        2011-10-21 21:23:23 UTC (rev 1119)
+++ trunk/mpas/src/core_ocean/mpas_ocn_mpas_core.F        2011-10-24 15:33:55 UTC (rev 1120)
@@ -3,7 +3,7 @@
    use mpas_framework
    use mpas_timekeeping
    use mpas_dmpar
-   use test_cases
+   use ocn_test_cases
 
    use ocn_time_integration
 
@@ -128,7 +128,7 @@
    ! no initial statistics write.
    
    !   call mpas_timer_start(&quot;global diagnostics&quot;)
-   !   call computeGlobalDiagnostics(domain % dminfo, block % state % time_levs(1) % state, mesh, 0, dt)
+   !   call ocn_compute_global_diagnostics(domain % dminfo, block % state % time_levs(1) % state, mesh, 0, dt)
    !   call mpas_timer_stop(&quot;global diagnostics&quot;)
    !   call mpas_output_state_init(output_obj, domain, &quot;OUTPUT&quot;)
    !   call write_output_frame(output_obj, domain)
@@ -406,7 +406,7 @@
    
       use mpas_grid_types
       use mpas_timer
-      use global_diagnostics
+      use ocn_global_diagnostics
    
       implicit none
    
@@ -429,7 +429,7 @@
               end if
 
           call mpas_timer_start(&quot;global diagnostics&quot;)
-          call computeGlobalDiagnostics(domain % dminfo, &amp;
+          call ocn_compute_global_diagnostics(domain % dminfo, &amp;
              block_ptr % state % time_levs(2) % state, block_ptr % mesh, &amp;
              itimestep, dt)
           call mpas_timer_stop(&quot;global diagnostics&quot;)
@@ -447,7 +447,7 @@
       !   end if
    
       !   call mpas_timer_start(&quot;global diagnostics&quot;)
-      !   call computeGlobalDiagnostics(domain % dminfo, &amp;
+      !   call ocn_compute_global_diagnostics(domain % dminfo, &amp;
       !            block_ptr % state % time_levs(2) % state, block_ptr % mesh, &amp;
       !            timeStamp, dt)
       !   call mpas_timer_stop(&quot;global diagnostics&quot;)

Modified: trunk/mpas/src/core_ocean/mpas_ocn_test_cases.F
===================================================================
--- trunk/mpas/src/core_ocean/mpas_ocn_test_cases.F        2011-10-21 21:23:23 UTC (rev 1119)
+++ trunk/mpas/src/core_ocean/mpas_ocn_test_cases.F        2011-10-24 15:33:55 UTC (rev 1120)
@@ -1,4 +1,4 @@
- module test_cases
+ module ocn_test_cases
 
    use mpas_grid_types
    use mpas_configure
@@ -441,9 +441,9 @@
       ! Initialize height field (actually, fluid thickness field)
       !
       do iCell=1,grid % nCells
-         state % h % array(1,iCell) = (gravity * h0 + a*a*AA(grid%latCell%array(iCell)) + &amp;
-                                                      a*a*BB(grid%latCell%array(iCell)) * cos(R*grid%lonCell%array(iCell)) + &amp;
-                                                      a*a*CC(grid%latCell%array(iCell)) * cos(2.0*R*grid%lonCell%array(iCell)) &amp;
+         state % h % array(1,iCell) = (gravity * h0 + a*a*aa(grid%latCell%array(iCell)) + &amp;
+                                                      a*a*bb(grid%latCell%array(iCell)) * cos(R*grid%lonCell%array(iCell)) + &amp;
+                                                      a*a*cc(grid%latCell%array(iCell)) * cos(2.0*R*grid%lonCell%array(iCell)) &amp;
                                       ) / gravity
       end do
 
@@ -469,7 +469,7 @@
    end function sphere_distance
 
 
-   real function AA(theta)
+   real function aa(theta)
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
    ! A, used in height field computation for Rossby-Haurwitz wave
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
@@ -482,13 +482,13 @@
 
       real (kind=RKIND), intent(in) :: theta
 
-      AA = 0.5 * w * (2.0 * omega + w) * cos(theta)**2.0 + &amp;
+      aa = 0.5 * w * (2.0 * omega + w) * cos(theta)**2.0 + &amp;
           0.25 * K**2.0 * cos(theta)**(2.0*R) * ((R+1.0)*cos(theta)**2.0 + 2.0*R**2.0 - R - 2.0 - 2.0*R**2*cos(theta)**-2.0)
 
-   end function AA
+   end function aa
 
    
-   real function BB(theta)
+   real function bb(theta)
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
    ! B, used in height field computation for Rossby-Haurwitz wave
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
@@ -501,12 +501,12 @@
 
       real (kind=RKIND), intent(in) :: theta
 
-      BB = (2.0*(omega + w)*K / ((R+1.0)*(R+2.0))) * cos(theta)**R * ((R**2.0 + 2.0*R + 2.0) - ((R+1.0)*cos(theta))**2.0)
+      bb = (2.0*(omega + w)*K / ((R+1.0)*(R+2.0))) * cos(theta)**R * ((R**2.0 + 2.0*R + 2.0) - ((R+1.0)*cos(theta))**2.0)
 
-   end function BB
+   end function bb
 
 
-   real function CC(theta)
+   real function cc(theta)
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
    ! C, used in height field computation for Rossby-Haurwitz wave
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
@@ -519,8 +519,8 @@
 
       real (kind=RKIND), intent(in) :: theta
 
-      CC = 0.25 * K**2.0 * cos(theta)**(2.0*R) * ((R+1.0)*cos(theta)**2.0 - R - 2.0)
+      cc = 0.25 * K**2.0 * cos(theta)**(2.0*R) * ((R+1.0)*cos(theta)**2.0 - R - 2.0)
 
-   end function CC
+   end function cc
 
-end module test_cases
+end module ocn_test_cases

</font>
</pre>