<p><b>dwj07@fsu.edu</b> 2013-04-01 14:37:07 -0600 (Mon, 01 Apr 2013)</p><p><br>
        -- BRANCH COMMIT --<br>
        <br>
        Changing variable names:<br>
        rho -&gt; density<br>
        rhoDisplaced -&gt; displacedDensity<br>
</p><hr noshade><pre><font color="gray">Modified: branches/ocean_projects/variable_name_change/namelist.input.ocean
===================================================================
--- branches/ocean_projects/variable_name_change/namelist.input.ocean        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/namelist.input.ocean        2013-04-01 20:37:07 UTC (rev 2692)
@@ -113,7 +113,7 @@
 /
 &amp;pressure_gradient
         config_pressure_gradient_type = 'pressure_and_zmid'
-        config_rho0 = 1014.65
+        config_density0 = 1014.65
 /
 &amp;eos
         config_eos_type = 'jm'
@@ -123,7 +123,7 @@
         config_eos_linear_beta = 7.64e-1
         config_eos_linear_Tref = 19.0
         config_eos_linear_Sref = 35.0
-        config_eos_linear_rhoref = 1025.022
+        config_eos_linear_densityref = 1025.022
 /
 &amp;split_explicit_ts
         config_n_ts_iter = 2

Modified: branches/ocean_projects/variable_name_change/src/core_ocean/Registry.xml
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/Registry.xml        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/Registry.xml        2013-04-01 20:37:07 UTC (rev 2692)
@@ -393,7 +393,7 @@
                             description=&quot;Form of pressure gradient terms in momentum equation. For most applications, the gradient of pressure and layer mid-depth are appropriate.  For isopycnal coordinates, one may use the gradient of the Montgomery potential.&quot;
                             possible_values=&quot;'pressure_and_zmid' or 'MontgomeryPotential'&quot;
                 /&gt;
-                &lt;nml_option name=&quot;config_rho0&quot; type=&quot;real&quot; default_value=&quot;1014.65&quot; units=&quot;kg m^{-3}&quot;
+                &lt;nml_option name=&quot;config_density0&quot; type=&quot;real&quot; default_value=&quot;1014.65&quot; units=&quot;kg m^{-3}&quot;
                             description=&quot;Density used as a coefficient of the pressure gradient terms, $\rho_0$.  This is a constant due to the Boussinesq approximation.&quot;
                             possible_values=&quot;any positive real, but typically 1000-1035&quot;
                 /&gt;
@@ -421,7 +421,7 @@
                             description=&quot;&quot;
                             possible_values=&quot;&quot;
                 /&gt;
-                &lt;nml_option name=&quot;config_eos_linear_rhoref&quot; type=&quot;real&quot; default_value=&quot;1025.022&quot; units=&quot;&quot;
+                &lt;nml_option name=&quot;config_eos_linear_densityref&quot; type=&quot;real&quot; default_value=&quot;1025.022&quot; units=&quot;&quot;
                             description=&quot;&quot;
                             possible_values=&quot;&quot;
                 /&gt;
@@ -579,7 +579,7 @@
                 &lt;var name=&quot;layerThickness&quot; type=&quot;real&quot; dimensions=&quot;nVertLevels nCells Time&quot; streams=&quot;iro&quot; units=&quot;m&quot;
                      description=&quot;layer thickness&quot;
                 /&gt;
-                &lt;var name=&quot;rho&quot; type=&quot;real&quot; dimensions=&quot;nVertLevels nCells Time&quot; streams=&quot;iro&quot; units=&quot;kg m^{-3}&quot;
+                &lt;var name=&quot;density&quot; type=&quot;real&quot; dimensions=&quot;nVertLevels nCells Time&quot; streams=&quot;iro&quot; units=&quot;kg m^{-3}&quot;
                      description=&quot;density&quot;
                 /&gt;
                 &lt;var name=&quot;uBtr&quot; type=&quot;real&quot; dimensions=&quot;nEdges Time&quot; streams=&quot;r&quot; units=&quot;m s^{-1}&quot;
@@ -714,7 +714,7 @@
                 &lt;var name=&quot;vertVelocityTop&quot; type=&quot;real&quot; dimensions=&quot;nVertLevelsP1 nCells Time&quot; units=&quot;m s^{-1}&quot;
                      description=&quot;vertical velocity defined at center (horizonally) and top (vertically) of cell&quot;
                 /&gt;
-                &lt;var name=&quot;rhoDisplaced&quot; type=&quot;real&quot; dimensions=&quot;nVertLevels nCells Time&quot; units=&quot;kg m^{-3}&quot;
+                &lt;var name=&quot;displacedDensity&quot; type=&quot;real&quot; dimensions=&quot;nVertLevels nCells Time&quot; units=&quot;kg m^{-3}&quot;
                      description=&quot;potential density displaced to the mid-depth of top layer&quot;
                 /&gt;
                 &lt;var name=&quot;BruntVaisalaFreqTop&quot; type=&quot;real&quot; dimensions=&quot;nVertLevels nCells Time&quot; streams=&quot;o&quot; units=&quot;s^{-2}&quot;

Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_diagnostics.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_diagnostics.F        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_diagnostics.F        2013-04-01 20:37:07 UTC (rev 2692)
@@ -102,7 +102,7 @@
         weightsOnEdge, kiteAreasOnVertex, layerThicknessEdge, layerThickness, u, v, pressure,&amp;
         circulation, vorticity, ke, ke_edge, MontPot, wTop, zMid, &amp;
         Vor_edge, Vor_vertex, Vor_cell, gradVor_n, gradVor_t, divergence, &amp;
-        rho, rhoDisplaced, temperature, salinity, kev, kevc, uBolusGM, uTransport, &amp;
+        density, displacedDensity, temperature, salinity, kev, kevc, uBolusGM, uTransport, &amp;
         vertVelocityTop, BruntVaisalaFreqTop
       real (kind=RKIND), dimension(:,:,:), pointer :: tracers, deriv_two
       character :: c1*6
@@ -125,8 +125,8 @@
       Vor_cell    =&gt; s % Vor_cell % array
       gradVor_n   =&gt; s % gradVor_n % array
       gradVor_t   =&gt; s % gradVor_t % array
-      rho         =&gt; s % rho % array
-      rhoDisplaced=&gt; s % rhoDisplaced % array
+      density         =&gt; s % density % array
+      displacedDensity=&gt; s % displacedDensity % array
       MontPot     =&gt; s % MontPot % array
       pressure    =&gt; s % pressure % array
       zMid        =&gt; s % zMid % array
@@ -374,17 +374,17 @@
          call mpas_timer_start(&quot;equation of state&quot;, .false., diagEOSTimer)
 
          ! compute in-place density
-         call ocn_equation_of_state_rho(s, grid, 0, 'relative', err)
+         call ocn_equation_of_state_density(s, grid, 0, 'relative', err)
 
-         ! compute rhoDisplaced, the potential density referenced to the top layer
-         call ocn_equation_of_state_rho(s, grid, 1, 'relative', err)
+         ! compute displacedDensity, the potential density referenced to the top layer
+         call ocn_equation_of_state_density(s, grid, 1, 'relative', err)
 
          call mpas_timer_stop(&quot;equation of state&quot;, diagEOSTimer)
       endif
 
       !
       ! Pressure
-      ! This section must be after computing rho
+      ! This section must be after computing density
       !
       if (config_pressure_gradient_type.eq.'MontgomeryPotential') then
 
@@ -403,11 +403,11 @@
               * (bottomDepth(iCell) + sum(layerThickness(1:nVertLevels,iCell)))
 
            do k=2,nVertLevels
-              pTop(k) = pTop(k-1) + rho(k-1,iCell)*gravity* layerThickness(k-1,iCell)
+              pTop(k) = pTop(k-1) + density(k-1,iCell)*gravity* layerThickness(k-1,iCell)
 
-              ! from delta M = p delta / rho
+              ! from delta M = p delta / density
               MontPot(k,iCell) = MontPot(k-1,iCell) &amp;
-                 + pTop(k)*(1.0/rho(k,iCell) - 1.0/rho(k-1,iCell)) 
+                 + pTop(k)*(1.0/density(k,iCell) - 1.0/density(k-1,iCell)) 
            end do
 
         end do
@@ -419,17 +419,17 @@
            ! Pressure for generalized coordinates.
            ! Pressure at top surface may be due to atmospheric pressure
            ! or an ice-shelf depression. 
-           pressure(1,iCell) = seaSurfacePressure(iCell) + rho(1,iCell)*gravity &amp;
+           pressure(1,iCell) = seaSurfacePressure(iCell) + density(1,iCell)*gravity &amp;
               * 0.5*layerThickness(1,iCell)
 
            do k=2,maxLevelCell(iCell)
               pressure(k,iCell) = pressure(k-1,iCell)  &amp;
-                + 0.5*gravity*(  rho(k-1,iCell)*layerThickness(k-1,iCell) &amp;
-                               + rho(k  ,iCell)*layerThickness(k  ,iCell))
+                + 0.5*gravity*(  density(k-1,iCell)*layerThickness(k-1,iCell) &amp;
+                               + density(k  ,iCell)*layerThickness(k  ,iCell))
            end do
 
            ! Compute zMid, the z-coordinate of the middle of the layer.
-           ! This is used for the rho g grad z momentum term.
+           ! This is used for the density g grad z momentum term.
            ! Note the negative sign, since bottomDepth is positive
            ! and z-coordinates are negative below the surface.
            k = maxLevelCell(iCell)
@@ -448,11 +448,11 @@
       !
       ! Brunt-Vaisala frequency
       !
-      coef = -gravity/config_rho0
+      coef = -gravity/config_density0
       do iCell=1,nCells
          BruntVaisalaFreqTop(1,iCell) = 0.0
          do k=2,maxLevelCell(iCell)
-            BruntVaisalaFreqTop(k,iCell) = coef * (rhoDisplaced(k-1,iCell) - rhoDisplaced(k,iCell)) &amp; 
+            BruntVaisalaFreqTop(k,iCell) = coef * (displacedDensity(k-1,iCell) - displacedDensity(k,iCell)) &amp; 
               / (zMid(k-1,iCell) - zMid(k,iCell))
           end do
       end do
@@ -532,7 +532,7 @@
       !-----------------------------------------------------------------
 
       integer :: iEdge, iCell, iVertex, k, cell1, cell2, vertex1, vertex2, eoe, i, j, cov
-      real (kind=RKIND) :: flux, vorticity_abs, layerThicknessVertex, workpv, rho0Inv, hSum, invAreaCell
+      real (kind=RKIND) :: flux, vorticity_abs, layerThicknessVertex, workpv, density0Inv, hSum, invAreaCell
 
       integer :: nCells, nEdges, nVertices, nVertLevels, vertexDegree
 

Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_equation_of_state.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_equation_of_state.F        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_equation_of_state.F        2013-04-01 20:37:07 UTC (rev 2692)
@@ -36,7 +36,7 @@
    !
    !--------------------------------------------------------------------
 
-   public :: ocn_equation_of_state_rho, &amp;
+   public :: ocn_equation_of_state_density, &amp;
              ocn_equation_of_state_init
 
    !--------------------------------------------------------------------
@@ -66,7 +66,7 @@
 !
 !-----------------------------------------------------------------------
 
-   subroutine ocn_equation_of_state_rho(s, grid, k_displaced, displacement_type, err)!{{{
+   subroutine ocn_equation_of_state_density(s, grid, k_displaced, displacement_type, err)!{{{
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
    !  This module contains routines necessary for computing the density
    !  from model temperature and salinity using an equation of state.
@@ -75,11 +75,11 @@
    !        s - state: tracers
    !        k_displaced 
    !
-   !  If k_displaced==0, state % rho is returned with no displacement 
+   !  If k_displaced==0, state % density is returned with no displacement 
    !
-   !  If k_displaced~=0,the state % rhoDisplaced is returned, and is for
+   !  If k_displaced~=0,the state % displacedDensity is returned, and is for
    !  a parcel adiabatically displaced from its original level to level 
-   !  k_displaced.  When using the linear EOS, state % rhoDisplaced is 
+   !  k_displaced.  When using the linear EOS, state % displacedDensity is 
    !  still filled, but depth (i.e. pressure) does not modify the output.
    !
    ! Output: s - state: computed density
@@ -93,7 +93,7 @@
       character(len=*), intent(in) :: displacement_type
 
       integer, dimension(:), pointer :: maxLevelCell
-      real (kind=RKIND), dimension(:,:), pointer :: rho
+      real (kind=RKIND), dimension(:,:), pointer :: density
       real (kind=RKIND), dimension(:,:,:), pointer :: tracers
       integer :: nCells, iCell, k, indexT, indexS
       type (dm_info) :: dminfo
@@ -106,24 +106,24 @@
       indexT = s % index_temperature
       indexS = s % index_salinity
 
-      !  Choose to fill the array rho or rhoDisplaced
+      !  Choose to fill the array density or displacedDensity
       if (k_displaced == 0) then
-         rho =&gt; s % rho % array
+         density =&gt; s % density % array
       else
-         rho =&gt; s % rhoDisplaced % array
+         density =&gt; s % displacedDensity % array
       endif
 
       if (linearEos) then
 
-         call ocn_equation_of_state_linear_rho(grid, indexT, indexS, tracers, rho, err)
+         call ocn_equation_of_state_linear_density(grid, indexT, indexS, tracers, density, err)
 
       elseif (jmEos) then
 
-         call ocn_equation_of_state_jm_rho(grid, k_displaced, displacement_type, indexT, indexS, tracers, rho, err)
+         call ocn_equation_of_state_jm_density(grid, k_displaced, displacement_type, indexT, indexS, tracers, density, err)
 
       endif
 
-   end subroutine ocn_equation_of_state_rho!}}}
+   end subroutine ocn_equation_of_state_density!}}}
 
 !***********************************************************************
 !

Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_equation_of_state_jm.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_equation_of_state_jm.F        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_equation_of_state_jm.F        2013-04-01 20:37:07 UTC (rev 2692)
@@ -34,7 +34,7 @@
    !
    !--------------------------------------------------------------------
 
-   public :: ocn_equation_of_state_jm_rho, &amp;
+   public :: ocn_equation_of_state_jm_density, &amp;
              ocn_equation_of_state_jm_init
 
    !--------------------------------------------------------------------
@@ -49,7 +49,7 @@
 
 !***********************************************************************
 !
-!  routine ocn_equation_of_state_jm_rho
+!  routine ocn_equation_of_state_jm_density
 !
 !&gt; \brief   Calls JM equation of state
 !&gt; \author  Doug Jacobsen
@@ -60,7 +60,7 @@
 !
 !-----------------------------------------------------------------------
 
-   subroutine ocn_equation_of_state_jm_rho(grid, k_displaced, displacement_type, indexT, indexS, tracers, rho, err)!{{{
+   subroutine ocn_equation_of_state_jm_density(grid, k_displaced, displacement_type, indexT, indexS, tracers, density, err)!{{{
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
    !  This module contains routines necessary for computing the density
    !  from model temperature and salinity using an equation of state.
@@ -98,7 +98,7 @@
       real (kind=RKIND), dimension(:), pointer :: &amp;
         refBottomDepth, pRefEOS
       real (kind=RKIND), dimension(:,:), intent(inout) :: &amp;
-        rho
+        density
       real (kind=RKIND), dimension(:,:,:), intent(in) :: tracers
 
       integer, dimension(:), pointer :: maxLevelCell
@@ -106,7 +106,7 @@
       real (kind=RKIND) :: &amp;
          TQ,SQ,             &amp;! adjusted T,S
          BULK_MOD,          &amp;! Bulk modulus
-         RHO_S,             &amp;! density at the surface
+         density_S,             &amp;! density at the surface
          DRDT0,             &amp;! d(density)/d(temperature), for surface
          DRDS0,             &amp;! d(density)/d(salinity   ), for surface
          DKDT,              &amp;! d(bulk modulus)/d(pot. temp.)
@@ -280,7 +280,7 @@
                    (uns1t2 + uns1t3*TQ + uns1t4*T2)*T2
             WORK2 = SQR*(unsqt0 + unsqt1*TQ + unsqt2*T2)
 
-            RHO_S = unt1*TQ + (unt2 + unt3*TQ + (unt4 + unt5*TQ)*T2)*T2 &amp;
+            density_S = unt1*TQ + (unt2 + unt3*TQ + (unt4 + unt5*TQ)*T2)*T2 &amp;
                             + (uns2t0*SQ + WORK1 + WORK2)*SQ
 
             !***
@@ -304,13 +304,13 @@
   
             DENOMK = 1.0/(BULK_MOD - p(k))
    
-            rho(k,iCell) = (unt0 + RHO_S)*BULK_MOD*DENOMK
+            density(k,iCell) = (unt0 + density_S)*BULK_MOD*DENOMK
 
          end do
       end do
 
       deallocate(pRefEOS,p,p2)
-   end subroutine ocn_equation_of_state_jm_rho!}}}
+   end subroutine ocn_equation_of_state_jm_density!}}}
 
 !***********************************************************************
 !

Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_equation_of_state_linear.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_equation_of_state_linear.F        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_equation_of_state_linear.F        2013-04-01 20:37:07 UTC (rev 2692)
@@ -33,7 +33,7 @@
    !
    !--------------------------------------------------------------------
 
-   public :: ocn_equation_of_state_linear_rho, &amp;
+   public :: ocn_equation_of_state_linear_density, &amp;
              ocn_equation_of_state_linear_init
 
    !--------------------------------------------------------------------
@@ -48,7 +48,7 @@
 
 !***********************************************************************
 !
-!  routine ocn_equation_of_state_linear_rho
+!  routine ocn_equation_of_state_linear_density
 !
 !&gt; \brief   Calls equation of state
 !&gt; \author  Doug Jacobsen
@@ -59,7 +59,7 @@
 !
 !-----------------------------------------------------------------------
 
-   subroutine ocn_equation_of_state_linear_rho(grid, indexT, indexS, tracers, rho, err)!{{{
+   subroutine ocn_equation_of_state_linear_density(grid, indexT, indexS, tracers, density, err)!{{{
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
    !  This module contains routines necessary for computing the density
    !  from model temperature and salinity using an equation of state.
@@ -67,8 +67,8 @@
    ! Input: grid - grid metadata
    !        s - state: tracers
    !        k_displaced 
-   !  If k_displaced&lt;=0, state % rho is returned with no displaced
-   !  If k_displaced&gt;0,the state % rhoDisplaced is returned, and is for
+   !  If k_displaced&lt;=0, state % density is returned with no displaced
+   !  If k_displaced&gt;0,the state % densityDisplaced is returned, and is for
    !  a parcel adiabatically displaced from its original level to level 
    !  k_displaced.  This does not effect the linear EOS.
    !
@@ -77,7 +77,7 @@
       implicit none
 
       type (mesh_type), intent(in) :: grid
-      real (kind=RKIND), dimension(:,:), intent(inout) :: rho
+      real (kind=RKIND), dimension(:,:), intent(inout) :: density
       real (kind=RKIND), dimension(:,:,:), intent(in) :: tracers
       integer, intent(in) :: indexT, indexS
       integer, intent(out) :: err
@@ -94,13 +94,13 @@
       do iCell=1,nCells
          do k=1,maxLevelCell(iCell)
             ! Linear equation of state
-            rho(k,iCell) =  config_eos_linear_rhoref &amp;
+            density(k,iCell) =  config_eos_linear_densityref &amp;
                   - config_eos_linear_alpha * (tracers(indexT,k,iCell)-config_eos_linear_Tref) &amp;
                   + config_eos_linear_beta  * (tracers(indexS,k,iCell)-config_eos_linear_Sref)
          end do
       end do
 
-   end subroutine ocn_equation_of_state_linear_rho!}}}
+   end subroutine ocn_equation_of_state_linear_density!}}}
 
 !***********************************************************************
 !

Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_global_diagnostics.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_global_diagnostics.F        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_global_diagnostics.F        2013-04-01 20:37:07 UTC (rev 2692)
@@ -47,7 +47,7 @@
       real (kind=RKIND) :: volumeCellGlobal, volumeEdgeGlobal, CFLNumberGlobal, localCFL, localSum, areaCellGlobal, areaEdgeGlobal, areaTriangleGlobal
       real (kind=RKIND), dimension(:), pointer ::  areaCell, dcEdge, dvEdge, areaTriangle, areaEdge
       real (kind=RKIND), dimension(:,:), pointer :: layerThickness, u, v, layerThicknessEdge, vorticity, ke, Vor_edge, Vor_vertex, &amp;
-         Vor_cell, gradVor_n, gradVor_t, pressure, MontPot, wTop, rho, tracerTemp
+         Vor_cell, gradVor_n, gradVor_t, pressure, MontPot, wTop, density, tracerTemp
       real (kind=RKIND), dimension(:,:,:), pointer :: tracers
       
       real (kind=RKIND), dimension(kMaxVariables) :: sums, mins, maxes, averages, verticalSumMins, verticalSumMaxes, reductions
@@ -87,7 +87,7 @@
 
          layerThickness =&gt; state % layerThickness % array
          u =&gt; state % u % array
-         rho =&gt; state % rho % array
+         density =&gt; state % density % array
          tracers =&gt; state % tracers % array
          v =&gt; state % v % array
          wTop =&gt; state % wTop % array

Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tendency.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tendency.F        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tendency.F        2013-04-01 20:37:07 UTC (rev 2692)
@@ -155,7 +155,7 @@
       type (mesh_type), intent(in) :: grid !&lt; Input: Grid information
 
       real (kind=RKIND), dimension(:,:), pointer :: &amp;
-        layerThicknessEdge, h, u, rho, zMid, pressure, &amp;
+        layerThicknessEdge, h, u, density, zMid, pressure, &amp;
         tend_u, circulation, vorticity, viscosity, ke, ke_edge, Vor_edge, &amp;
         MontPot, wTop, divergence, vertViscTopOfEdge
 
@@ -166,7 +166,7 @@
       call mpas_timer_start(&quot;ocn_tend_u&quot;)
 
       u           =&gt; s % u % array
-      rho         =&gt; s % rho % array
+      density         =&gt; s % density % array
       wTop        =&gt; s % wTop % array
       zMid        =&gt; s % zMid % array
       layerThicknessEdge      =&gt; s % layerThicknessEdge % array
@@ -211,9 +211,9 @@
       !
       call mpas_timer_start(&quot;pressure grad&quot;, .false., velPgradTimer)
       if (config_pressure_gradient_type.eq.'MontgomeryPotential') then
-          call ocn_vel_pressure_grad_tend(grid, MontPot,  zMid, rho, tend_u, err)
+          call ocn_vel_pressure_grad_tend(grid, MontPot,  zMid, density, tend_u, err)
       else
-          call ocn_vel_pressure_grad_tend(grid, pressure, zMid, rho, tend_u, err)
+          call ocn_vel_pressure_grad_tend(grid, pressure, zMid, density, tend_u, err)
       end if
       call mpas_timer_stop(&quot;pressure grad&quot;, velPgradTimer)
 

Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_integration_rk4.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_integration_rk4.F        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_integration_rk4.F        2013-04-01 20:37:07 UTC (rev 2692)
@@ -268,7 +268,7 @@
 
         ! Call ocean diagnostic solve in preparation for vertical mixing.  Note 
         ! it is called again after vertical mixing, because u and tracers change.
-        ! For Richardson vertical mixing, only rho, layerThicknessEdge, and ke_edge need to 
+        ! For Richardson vertical mixing, only density, layerThicknessEdge, and ke_edge need to 
         ! be computed.  For kpp, more variables may be needed.  Either way, this
         ! could be made more efficient by only computing what is needed for the
         ! implicit vmix routine that follows. 

Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_integration_split.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_integration_split.F        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_integration_split.F        2013-04-01 20:37:07 UTC (rev 2692)
@@ -929,7 +929,7 @@
 
         ! Call ocean diagnostic solve in preparation for vertical mixing.  Note 
         ! it is called again after vertical mixing, because u and tracers change.
-        ! For Richardson vertical mixing, only rho, layerThicknessEdge, and ke_edge need to 
+        ! For Richardson vertical mixing, only density, layerThicknessEdge, and ke_edge need to 
         ! be computed.  For kpp, more variables may be needed.  Either way, this
         ! could be made more efficient by only computing what is needed for the
         ! implicit vmix routine that follows.

Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_forcing_windstress.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_forcing_windstress.F        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_forcing_windstress.F        2013-04-01 20:37:07 UTC (rev 2692)
@@ -130,7 +130,7 @@
 
         do k = 1,min(maxLevelEdgeTop(iEdge),1)
            ! forcing in top layer only
-           tend(k,iEdge) =  tend(k,iEdge) + edgeMask(k, iEdge) * (u_src(k,iEdge) / config_rho0 / layerThicknessEdge(k,iEdge))
+           tend(k,iEdge) =  tend(k,iEdge) + edgeMask(k, iEdge) * (u_src(k,iEdge) / config_density0 / layerThicknessEdge(k,iEdge))
         enddo
 
       enddo

Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_pressure_grad.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_pressure_grad.F        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_pressure_grad.F        2013-04-01 20:37:07 UTC (rev 2692)
@@ -45,7 +45,7 @@
    !--------------------------------------------------------------------
 
    logical :: pgradOn
-   real (kind=RKIND) :: rho0Inv, grho0Inv
+   real (kind=RKIND) :: density0Inv, gdensity0Inv
 
 
 !***********************************************************************
@@ -66,7 +66,7 @@
 !
 !-----------------------------------------------------------------------
 
-   subroutine ocn_vel_pressure_grad_tend(grid, pressure, zMid, rho, tend, err)!{{{
+   subroutine ocn_vel_pressure_grad_tend(grid, pressure, zMid, density, tend, err)!{{{
 
       !-----------------------------------------------------------------
       !
@@ -77,7 +77,7 @@
       real (kind=RKIND), dimension(:,:), intent(in) :: &amp;
          pressure, &amp; !&lt; Input: Pressure field or Mongomery potential
          zMid, &amp;     !&lt; Input: z-coordinate at mid-depth of layer
-         rho         !&lt; Input: density
+         density         !&lt; Input: density
 
       type (mesh_type), intent(in) :: &amp;
          grid          !&lt; Input: grid information
@@ -123,11 +123,11 @@
       edgeMask =&gt; grid % edgeMask % array
 
       ! pressure for generalized coordinates
-      ! -1/rho_0 (grad p_k + rho g grad z_k^{mid})
+      ! -1/density_0 (grad p_k + density g grad z_k^{mid})
 
       ! For pure isopycnal coordinates, we are still using 
       ! grad(M), the gradient of Montgomery Potential, because
-      ! we have set rho0Inv=1 and grho0Inv=0 in the init routine,
+      ! we have set density0Inv=1 and gdensity0Inv=0 in the init routine,
       ! and pressure is passed in as MontPot.
 
       do iEdge=1,nEdgesSolve
@@ -137,9 +137,9 @@
 
          do k=1,maxLevelEdgeTop(iEdge)
             tend(k,iEdge) = tend(k,iEdge)     &amp;
-              - edgeMask(k,iEdge) * rho0Inv*(  pressure(k,cell2) &amp;
+              - edgeMask(k,iEdge) * density0Inv*(  pressure(k,cell2) &amp;
                          - pressure(k,cell1) )* invdcEdge &amp;
-              - edgeMask(k,iEdge) * grho0Inv*  0.5*(rho(k,cell1)+rho(k,cell2)) &amp;
+              - edgeMask(k,iEdge) * gdensity0Inv*  0.5*(density(k,cell1)+density(k,cell2)) &amp;
                         *(  zMid(k,cell2) &amp;
                           - zMid(k,cell1) )* invdcEdge
                       
@@ -192,11 +192,11 @@
       pgradOn = .true.
 
       if (config_pressure_gradient_type.eq.'MontgomeryPotential') then
-        rho0Inv = 1.0
-        grho0Inv = 0.0
+        density0Inv = 1.0
+        gdensity0Inv = 0.0
       else 
-        rho0Inv = 1.0/config_rho0
-        grho0Inv = gravity/config_rho0
+        density0Inv = 1.0/config_density0
+        gdensity0Inv = gravity/config_density0
       end if
 
       if(config_disable_u_pgrad) pgradOn = .false.

Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vmix_coefs_rich.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vmix_coefs_rich.F        2013-04-01 20:24:09 UTC (rev 2691)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vmix_coefs_rich.F        2013-04-01 20:37:07 UTC (rev 2692)
@@ -109,7 +109,7 @@
       integer :: err1, err2, err3, indexT, indexS
 
       real (kind=RKIND), dimension(:,:), pointer :: &amp;
-        vertViscTopOfEdge, vertDiffTopOfCell, u, layerThickness, layerThicknessEdge, rho, rhoDisplaced
+        vertViscTopOfEdge, vertDiffTopOfCell, u, layerThickness, layerThicknessEdge, density, displacedDensity
 
       real (kind=RKIND), dimension(:,:), pointer :: RiTopOfEdge, RiTopOfCell
 
@@ -136,17 +136,17 @@
       u =&gt; s % u % array
       layerThickness =&gt; s % layerThickness % array
       layerThicknessEdge =&gt; s % layerThicknessEdge % array
-      rho =&gt; s % rho % array
-      rhoDisplaced =&gt; s % rhoDisplaced % array
+      density =&gt; s % density % array
+      displacedDensity =&gt; s % displacedDensity % array
       tracers =&gt; s % tracers % array
 
       call mpas_timer_start(&quot;eos rich&quot;, .false., richEOSTimer)
-      call ocn_equation_of_state_rho(s, grid, 0,'relative', err)
-      call ocn_equation_of_state_rho(s, grid, 1,'relative', err)
+      call ocn_equation_of_state_density(s, grid, 0,'relative', err)
+      call ocn_equation_of_state_density(s, grid, 1,'relative', err)
       call mpas_timer_stop(&quot;eos rich&quot;, richEOSTimer)
 
       call ocn_vmix_get_rich_numbers(grid, indexT, indexS, u, layerThickness, layerThicknessEdge, &amp; 
-                                  rho, rhoDisplaced, tracers, RiTopOfEdge, RiTopOfCell, err1)
+                                  density, displacedDensity, tracers, RiTopOfEdge, RiTopOfCell, err1)
 
       call ocn_vel_vmix_coefs_rich(grid, RiTopOfEdge, layerThicknessEdge, vertViscTopOfEdge, err2)
       call ocn_tracer_vmix_coefs_rich(grid, RiTopOfCell, layerThickness, vertDiffTopOfCell, err3)
@@ -309,7 +309,7 @@
 
       maxLevelCell =&gt; grid % maxLevelCell % array
 
-      coef = -gravity/config_rho0/2.0
+      coef = -gravity/config_density0/2.0
       do iCell = 1,nCells
          do k = 2,maxLevelCell(iCell)
             ! efficiency note: these if statements are inside iEdge and k loops.
@@ -349,7 +349,7 @@
 !-----------------------------------------------------------------------
 
    subroutine ocn_vmix_get_rich_numbers(grid, indexT, indexS, u, layerThickness, layerThicknessEdge, &amp; !{{{
-                                 rho, rhoDisplaced, tracers, RiTopOfEdge, RiTopOfCell, err)
+                                 density, displacedDensity, tracers, RiTopOfEdge, RiTopOfCell, err)
 
       !-----------------------------------------------------------------
       !
@@ -381,8 +381,8 @@
       !
       !-----------------------------------------------------------------
 
-      real (kind=RKIND), dimension(:,:), intent(inout) :: rho    !&lt; Input/output: density
-      real (kind=RKIND), dimension(:,:), intent(inout) :: rhoDisplaced    !&lt; Input/output: displaced density
+      real (kind=RKIND), dimension(:,:), intent(inout) :: density    !&lt; Input/output: density
+      real (kind=RKIND), dimension(:,:), intent(inout) :: displacedDensity    !&lt; Input/output: displaced density
       real (kind=RKIND), dimension(:,:), intent(inout) :: RiTopOfEdge     !&lt; Input/output: Richardson number top of cell
       real (kind=RKIND), dimension(:,:), intent(inout) :: RiTopOfCell     !&lt; Input/output: Richardson number top of cell
 
@@ -402,8 +402,8 @@
 
       real (kind=RKIND) :: coef, invAreaCell
       real (kind=RKIND), dimension(:), pointer :: dcEdge, dvEdge, areaCell
-      real (kind=RKIND), dimension(:,:), allocatable :: drhoTopOfCell, du2TopOfCell, &amp;
-                                                        drhoTopOfEdge, du2TopOfEdge
+      real (kind=RKIND), dimension(:,:), allocatable :: ddensityTopOfCell, du2TopOfCell, &amp;
+                                                        ddensityTopOfEdge, du2TopOfEdge
 
       err = 0
 
@@ -425,26 +425,26 @@
       edgeSignOnCell =&gt; grid % edgeSignOnCell % array
 
       allocate( &amp;
-         drhoTopOfCell(nVertLevels+1,nCells+1), drhoTopOfEdge(nVertLevels+1,nEdges), &amp;
+         ddensityTopOfCell(nVertLevels+1,nCells+1), ddensityTopOfEdge(nVertLevels+1,nEdges), &amp;
          du2TopOfCell(nVertLevels+1,nCells+1), du2TopOfEdge(nVertLevels+1,nEdges))
 
-      ! drhoTopOfCell(k) = $\rho^*_{k-1}-\rho^*_k$
-      drhoTopOfCell = 0.0
+      ! ddensityTopOfCell(k) = $\density^*_{k-1}-\density^*_k$
+      ddensityTopOfCell = 0.0
       do iCell=1,nCells
          do k=2,maxLevelCell(iCell)
-            drhoTopOfCell(k,iCell) = rhoDisplaced(k-1,iCell) - rhoDisplaced(k,iCell)
+            ddensityTopOfCell(k,iCell) = displacedDensity(k-1,iCell) - displacedDensity(k,iCell)
           end do
       end do
 
-      ! interpolate drhoTopOfCell to drhoTopOfEdge
-      drhoTopOfEdge = 0.0
+      ! interpolate ddensityTopOfCell to ddensityTopOfEdge
+      ddensityTopOfEdge = 0.0
       do iEdge=1,nEdges
          cell1 = cellsOnEdge(1,iEdge)
          cell2 = cellsOnEdge(2,iEdge)
          do k=2,maxLevelEdgeTop(iEdge)
-            drhoTopOfEdge(k,iEdge) = &amp;
-               (drhoTopOfCell(k,cell1) + &amp;
-                drhoTopOfCell(k,cell2))/2  
+            ddensityTopOfEdge(k,iEdge) = &amp;
+               (ddensityTopOfCell(k,cell1) + &amp;
+                ddensityTopOfCell(k,cell2))/2  
          end do
        end do
 
@@ -469,30 +469,30 @@
         end do
       end do
 
-      ! compute RiTopOfEdge using drhoTopOfEdge and du2TopOfEdge
-      ! coef = -g/rho_0/2
+      ! compute RiTopOfEdge using ddensityTopOfEdge and du2TopOfEdge
+      ! coef = -g/density_0/2
       RiTopOfEdge = 0.0
-      coef = -gravity/config_rho0/2.0
+      coef = -gravity/config_density0/2.0
       do iEdge = 1,nEdges
          do k = 2,maxLevelEdgeTop(iEdge)
-            RiTopOfEdge(k,iEdge) = coef*drhoTopOfEdge(k,iEdge) &amp;
+            RiTopOfEdge(k,iEdge) = coef*ddensityTopOfEdge(k,iEdge) &amp;
                *(layerThicknessEdge(k-1,iEdge)+layerThicknessEdge(k,iEdge)) &amp;
                / (du2TopOfEdge(k,iEdge) + 1e-20)
          end do
       end do
 
-      ! compute RiTopOfCell using drhoTopOfCell and du2TopOfCell
-      ! coef = -g/rho_0/2
+      ! compute RiTopOfCell using ddensityTopOfCell and du2TopOfCell
+      ! coef = -g/density_0/2
       RiTopOfCell = 0.0
       do iCell = 1,nCells
          do k = 2,maxLevelCell(iCell)
-            RiTopOfCell(k,iCell) = coef*drhoTopOfCell(k,iCell) &amp;
+            RiTopOfCell(k,iCell) = coef*ddensityTopOfCell(k,iCell) &amp;
                *(layerThickness(k-1,iCell)+layerThickness(k,iCell)) &amp;
                / (du2TopOfCell(k,iCell) + 1e-20)
          end do
       end do
 
-      deallocate(drhoTopOfCell, drhoTopOfEdge, &amp;
+      deallocate(ddensityTopOfCell, ddensityTopOfEdge, &amp;
         du2TopOfCell, du2TopOfEdge)
 
    !--------------------------------------------------------------------

</font>
</pre>