<p><b>dwj07@fsu.edu</b> 2013-04-03 10:25:11 -0600 (Wed, 03 Apr 2013)</p><p><br>
        -- BRANCH COMMIT --<br>
<br>
        Renaming variables.<br>
<br>
        vorticity -> relativeVorticity<br>
        Vor_cell -> potentialVorticityCell<br>
        Vor_edge -> potentialVorticityEdge<br>
        Vor_vertex -> potentialVorticityVertex<br>
        u -> normalVelocity<br>
        tend_u -> tend_normalVelocity<br>
</p><hr noshade><pre><font color="gray">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-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/Registry.xml        2013-04-03 16:25:11 UTC (rev 2714)
@@ -573,7 +573,7 @@
                <var name="xtime" type="text" dimensions="Time" streams="ro" units="unitless"
                 description="model time, with format 'YYYY-MM-DD_HH:MM:SS'"
                />
-                <var name="u" type="real" dimensions="nVertLevels nEdges Time" streams="ir" units="m s^{-1}"
+                <var name="normalVelocity" type="real" dimensions="nVertLevels nEdges Time" streams="ir" units="m s^{-1}"
                 description="horizonal velocity, normal component to an edge"
                />
                <var name="layerThickness" type="real" dimensions="nVertLevels nCells Time" streams="iro" units="m"
@@ -642,12 +642,18 @@
                <var name="divergence" type="real" dimensions="nVertLevels nCells Time" streams="o" units="s^{-1}"
                 description="divergence of horizonal velocity"
                />
-                <var name="vorticity" type="real" dimensions="nVertLevels nVertices Time" streams="o" units="s^{-1}"
+                <var name="relativeVorticity" type="real" dimensions="nVertLevels nVertices Time" streams="o" units="s^{-1}"
                 description="curl of horizontal velocity"
                />
-                <var name="Vor_edge" type="real" dimensions="nVertLevels nEdges Time" units="s^{-1}"
+                <var name="potentialVorticityEdge" type="real" dimensions="nVertLevels nEdges Time" units="s^{-1}"
                 description="vorticity averaged from vertices to edges"
                />
+                <var name="potentialVorticityVertex" type="real" dimensions="nVertLevels nVertices Time" units="s^{-1}"
+                 description="curl of horizontal velocity defined at vertices"
+                />
+                <var name="potentialVorticityCell" type="real" dimensions="nVertLevels nCells Time" streams="o" units="s^{-1}"
+                 description="curl of horizontal velocity defined at cell centers"
+                />
                <var name="layerThicknessEdge" type="real" dimensions="nVertLevels nEdges Time" units="m"
                 description="layer thickness averaged from cell center to edges"
                />
@@ -666,12 +672,6 @@
                <var name="ke_edge" type="real" dimensions="nVertLevels nEdges Time" units="m^2 s^{-2}"
                 description="kinetic energy of horizonal velocity defined at edges"
                />
-                <var name="Vor_vertex" type="real" dimensions="nVertLevels nVertices Time" units="s^{-1}"
-                 description="curl of horizontal velocity defined at vertices"
-                />
-                <var name="Vor_cell" type="real" dimensions="nVertLevels nCells Time" streams="o" units="s^{-1}"
-                 description="curl of horizontal velocity defined at cell centers"
-                />
                <var name="uReconstructX" type="real" dimensions="nVertLevels nCells Time" units="m s^{-1}"
                 description="component of horizontal velocity in the x-direction (cartesian)"
                />
@@ -1044,7 +1044,7 @@
                         description="time tendency of an arbitary tracer"
                        />
                </var_array>
-                <var name="tend_u" type="real" dimensions="nVertLevels nEdges Time" units="m s^{-2}" name_in_code="u"
+                <var name="tend_normalVelocity" type="real" dimensions="nVertLevels nEdges Time" units="m s^{-2}" name_in_code="normalVelocity"
                 description="time tendency of normal component of velocity"
                />
                <var name="tend_layerThickness" type="real" dimensions="nVertLevels nCells Time" units="m s^{-1}" name_in_code="layerThickness"
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-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_diagnostics.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -43,8 +43,8 @@
public :: ocn_diagnostic_solve, &
ocn_wtop, &
ocn_fuperp, &
- ocn_filter_btr_mode_u, &
- ocn_filter_btr_mode_tend_u, &
+ ocn_filter_btr_mode_vel, &
+ ocn_filter_btr_mode_tend_vel, &
ocn_diagnostics_init
!--------------------------------------------------------------------
@@ -99,30 +99,30 @@
real (kind=RKIND), dimension(:), pointer :: &
bottomDepth, fVertex, dvEdge, dcEdge, areaCell, areaTriangle, ssh, seaSurfacePressure
real (kind=RKIND), dimension(:,:), pointer :: &
- weightsOnEdge, kiteAreasOnVertex, layerThicknessEdge, layerThickness, u, v, pressure,&
- circulation, vorticity, ke, ke_edge, MontPot, wTop, zMid, &
- Vor_edge, Vor_vertex, Vor_cell, gradVor_n, gradVor_t, divergence, &
+ weightsOnEdge, kiteAreasOnVertex, layerThicknessEdge, layerThickness, normalVelocity, v, pressure,&
+ circulation, relativeVorticity, ke, ke_edge, MontPot, wTop, zMid, &
+ potentialVorticityEdge, potentialVorticityVertex, potentialVorticityCell, gradVor_n, gradVor_t, divergence, &
density, displacedDensity, temperature, salinity, kev, kevc, uBolusGM, uTransport, &
vertVelocityTop, BruntVaisalaFreqTop
real (kind=RKIND), dimension(:,:,:), pointer :: tracers, deriv_two
character :: c1*6
layerThickness => s % layerThickness % array
- u => s % u % array
+ normalVelocity => s % normalVelocity % array
uTransport => s % uTransport % array
uBolusGM => s % uBolusGM % array
v => s % v % array
layerThicknessEdge => s % layerThicknessEdge % array
circulation => s % circulation % array
- vorticity => s % vorticity % array
+ relativeVorticity => s % relativeVorticity % array
divergence => s % divergence % array
ke => s % ke % array
kev => s % kev % array
kevc => s % kevc % array
ke_edge => s % ke_edge % array
- Vor_edge => s % Vor_edge % array
- Vor_vertex => s % Vor_vertex % array
- Vor_cell => s % Vor_cell % array
+ potentialVorticityEdge => s % potentialVorticityEdge % array
+ potentialVorticityVertex => s % potentialVorticityVertex % array
+ potentialVorticityCell => s % potentialVorticityCell % array
gradVor_n => s % gradVor_n % array
gradVor_t => s % gradVor_t % array
density => s % density % array
@@ -193,13 +193,13 @@
! set the velocity and height at dummy address
! used -1e34 so error clearly occurs if these values are used.
!
- u(:,nEdges+1) = -1e34
+ normalVelocity(:,nEdges+1) = -1e34
layerThickness(:,nCells+1) = -1e34
tracers(s % index_temperature,:,nCells+1) = -1e34
tracers(s % index_salinity,:,nCells+1) = -1e34
circulation(:,:) = 0.0
- vorticity(:,:) = 0.0
+ relativeVorticity(:,:) = 0.0
divergence(:,:) = 0.0
vertVelocityTop(:,:)=0.0
ke(:,:) = 0.0
@@ -209,10 +209,10 @@
do i = 1, vertexDegree
iEdge = edgesOnVertex(i, iVertex)
do k = 1, maxLevelVertexBot(iVertex)
- r_tmp = dcEdge(iEdge) * u(k, iEdge)
+ r_tmp = dcEdge(iEdge) * normalVelocity(k, iEdge)
circulation(k, iVertex) = circulation(k, iVertex) + edgeSignOnVertex(i, iVertex) * r_tmp
- vorticity(k, iVertex) = vorticity(k, iVertex) + edgeSignOnVertex(i, iVertex) * r_tmp * invAreaTri1
+ relativeVorticity(k, iVertex) = relativeVorticity(k, iVertex) + edgeSignOnVertex(i, iVertex) * r_tmp * invAreaTri1
end do
end do
end do
@@ -224,11 +224,11 @@
do i = 1, nEdgesOnCell(iCell)
iEdge = edgesOnCell(i, iCell)
do k = 1, maxLevelCell(iCell)
- r_tmp = dvEdge(iEdge) * u(k, iEdge) * invAreaCell1
+ r_tmp = dvEdge(iEdge) * normalVelocity(k, iEdge) * invAreaCell1
divergence(k, iCell) = divergence(k, iCell) - edgeSignOnCell(i, iCell) * r_tmp
div_hu(k) = div_hu(k) - layerThicknessEdge(k, iEdge) * edgeSignOnCell(i, iCell) * r_tmp
- ke(k, iCell) = ke(k, iCell) + 0.25 * r_tmp * dcEdge(iEdge) * u(k,iEdge)
+ ke(k, iCell) = ke(k, iCell) + 0.25 * r_tmp * dcEdge(iEdge) * normalVelocity(k,iEdge)
end do
end do
! Vertical velocity at bottom (maxLevelCell(iCell)+1) is zero, initialized above.
@@ -243,7 +243,7 @@
do i=1,nEdgesOnEdge(iEdge)
eoe = edgesOnEdge(i,iEdge)
do k = 1,maxLevelEdgeTop(iEdge)
- v(k,iEdge) = v(k,iEdge) + weightsOnEdge(i,iEdge) * u(k, eoe)
+ v(k,iEdge) = v(k,iEdge) + weightsOnEdge(i,iEdge) * normalVelocity(k, eoe)
end do
end do
end do
@@ -257,7 +257,7 @@
iEdge = edgesOnVertex(i, iVertex)
r_tmp = dcEdge(iEdge) * dvEdge(iEdge) * 0.25 / areaTriangle(iVertex)
do k = 1, nVertLevels
- kev(k, iVertex) = kev(k, iVertex) + r_tmp * u(k, iEdge)**2
+ kev(k, iVertex) = kev(k, iVertex) + r_tmp * normalVelocity(k, iEdge)**2
end do
end do
end do
@@ -295,7 +295,7 @@
!
! Compute height at vertices, pv at vertices, and average pv to edge locations
- ! ( this computes Vor_vertex at all vertices bounding real cells and distance-1 ghost cells )
+ ! ( this computes potentialVorticityVertex at all vertices bounding real cells and distance-1 ghost cells )
!
do iVertex = 1,nVertices
invAreaTri1 = 1.0 / areaTriangle(iVertex)
@@ -306,17 +306,17 @@
end do
layerThicknessVertex = layerThicknessVertex * invAreaTri1
- Vor_vertex(k,iVertex) = (fCoef*fVertex(iVertex) + vorticity(k,iVertex)) / layerThicknessVertex
+ potentialVorticityVertex(k,iVertex) = (fCoef*fVertex(iVertex) + relativeVorticity(k,iVertex)) / layerThicknessVertex
end do
end do
- Vor_cell(:,:) = 0.0
- Vor_edge(:,:) = 0.0
+ potentialVorticityCell(:,:) = 0.0
+ potentialVorticityEdge(:,:) = 0.0
do iEdge = 1, nEdges
vertex1 = verticesOnEdge(1, iEdge)
vertex2 = verticesOnEdge(2, iEdge)
do k = 1, maxLevelEdgeBot(iEdge)
- Vor_edge(k, iEdge) = 0.5 * (Vor_vertex(k, vertex1) + Vor_vertex(k, vertex2))
+ potentialVorticityEdge(k, iEdge) = 0.5 * (potentialVorticityVertex(k, vertex1) + potentialVorticityVertex(k, vertex2))
end do
end do
@@ -327,7 +327,7 @@
j = kiteIndexOnCell(i, iCell)
iVertex = verticesOnCell(i, iCell)
do k = 1, maxLevelCell(iCell)
- Vor_cell(k, iCell) = Vor_cell(k, iCell) + kiteAreasOnVertex(j, iVertex) * Vor_vertex(k, iVertex) * invAreaCell1
+ potentialVorticityCell(k, iCell) = potentialVorticityCell(k, iCell) + kiteAreasOnVertex(j, iVertex) * potentialVorticityVertex(k, iVertex) * invAreaCell1
end do
end do
end do
@@ -342,14 +342,14 @@
! Compute gradient of PV in normal direction
! ( this computes gradVor_n for all edges bounding real cells )
do k=1,maxLevelEdgeTop(iEdge)
- gradVor_n(k,iEdge) = (Vor_cell(k,cell2) - Vor_cell(k,cell1)) * invLength
+ gradVor_n(k,iEdge) = (potentialVorticityCell(k,cell2) - potentialVorticityCell(k,cell1)) * invLength
enddo
invLength = 1.0 / dvEdge(iEdge)
! Compute gradient of PV in the tangent direction
! ( this computes gradVor_t at all edges bounding real cells and distance-1 ghost cells )
do k = 1,maxLevelEdgeBot(iEdge)
- gradVor_t(k,iEdge) = (Vor_vertex(k,vertex2) - Vor_vertex(k,vertex1)) * invLength
+ gradVor_t(k,iEdge) = (potentialVorticityVertex(k,vertex2) - potentialVorticityVertex(k,vertex1)) * invLength
enddo
enddo
@@ -359,8 +359,8 @@
!
do iEdge = 1,nEdges
do k = 1,maxLevelEdgeBot(iEdge)
- Vor_edge(k,iEdge) = Vor_edge(k,iEdge) &
- - config_apvm_scale_factor * dt* ( u(k,iEdge) * gradVor_n(k,iEdge) &
+ potentialVorticityEdge(k,iEdge) = potentialVorticityEdge(k,iEdge) &
+ - config_apvm_scale_factor * dt* ( normalVelocity(k,iEdge) * gradVor_n(k,iEdge) &
+ v(k,iEdge) * gradVor_t(k,iEdge) )
enddo
enddo
@@ -494,7 +494,7 @@
!> cell.
!
!-----------------------------------------------------------------------
- subroutine ocn_wtop(grid,layerThickness,layerThicknessEdge,u,wTop, err)!{{{
+ subroutine ocn_wtop(grid,layerThickness,layerThicknessEdge,normalVelocity,wTop, err)!{{{
!-----------------------------------------------------------------
!
@@ -512,7 +512,7 @@
layerThicknessEdge !< Input: layerThickness interpolated to an edge
real (kind=RKIND), dimension(:,:), intent(in) :: &
- u !< Input: transport
+ normalVelocity !< Input: transport
!-----------------------------------------------------------------
!
@@ -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, density0Inv, hSum, invAreaCell
+ real (kind=RKIND) :: flux, layerThicknessVertex, workpv, density0Inv, hSum, invAreaCell
integer :: nCells, nEdges, nVertices, nVertLevels, vertexDegree
@@ -589,7 +589,7 @@
iEdge = edgesOnCell(i, iCell)
do k = 1, maxLevelEdgeBot(iEdge)
- flux = layerThicknessEdge(k, iEdge) * u(k, iEdge) * dvEdge(iEdge) * edgeSignOnCell(i, iCell) * invAreaCell
+ flux = layerThicknessEdge(k, iEdge) * normalVelocity(k, iEdge) * dvEdge(iEdge) * edgeSignOnCell(i, iCell) * invAreaCell
div_hu(k) = div_hu(k) - flux
div_hu_btr = div_hu_btr - flux
end do
@@ -638,7 +638,7 @@
integer :: iEdge, cell1, cell2, eoe, i, j, k
integer :: nEdgesSolve
real (kind=RKIND), dimension(:), pointer :: fEdge
- real (kind=RKIND), dimension(:,:), pointer :: weightsOnEdge, u, uBcl
+ real (kind=RKIND), dimension(:,:), pointer :: weightsOnEdge, normalVelocity, uBcl
type (dm_info) :: dminfo
integer, dimension(:), pointer :: maxLevelEdgeTop, nEdgesOnEdge
@@ -646,7 +646,7 @@
call mpas_timer_start("ocn_fuperp")
- u => s % u % array
+ normalVelocity => s % normalVelocity % array
uBcl => s % uBcl % array
weightsOnEdge => grid % weightsOnEdge % array
fEdge => grid % fEdge % array
@@ -668,10 +668,10 @@
do k=1,maxLevelEdgeTop(iEdge)
- u(k,iEdge) = 0.0
+ normalVelocity(k,iEdge) = 0.0
do j = 1,nEdgesOnEdge(iEdge)
eoe = edgesOnEdge(j,iEdge)
- u(k,iEdge) = u(k,iEdge) + weightsOnEdge(j,iEdge) * uBcl(k,eoe) * fEdge(eoe)
+ normalVelocity(k,iEdge) = normalVelocity(k,iEdge) + weightsOnEdge(j,iEdge) * uBcl(k,eoe) * fEdge(eoe)
end do
end do
end do
@@ -682,7 +682,7 @@
!***********************************************************************
!
-! routine ocn_filter_btr_mode_u
+! routine ocn_filter_btr_mode_vel
!
!> \brief filters barotropic mode out of the velocity variable.
!> \author Mark Petersen
@@ -692,7 +692,7 @@
!> This routine filters barotropic mode out of the velocity variable.
!
!-----------------------------------------------------------------------
- subroutine ocn_filter_btr_mode_u(s, grid)!{{{
+ subroutine ocn_filter_btr_mode_vel(s, grid)!{{{
implicit none
type (state_type), intent(inout) :: s
@@ -700,13 +700,13 @@
integer :: iEdge, k, nEdges
real (kind=RKIND) :: vertSum, uhSum, hSum
- real (kind=RKIND), dimension(:,:), pointer :: layerThicknessEdge, u
+ real (kind=RKIND), dimension(:,:), pointer :: layerThicknessEdge, normalVelocity
integer, dimension(:), pointer :: maxLevelEdgeTop
- call mpas_timer_start("ocn_filter_btr_mode_u")
+ call mpas_timer_start("ocn_filter_btr_mode_vel")
- u => s % u % array
- layerThicknessEdge => s % layerThicknessEdge % array
+ normalVelocity => s % normalVelocity % array
+ layerThicknessEdge => s % layerThicknessEdge % array
maxLevelEdgeTop => grid % maxLevelEdgeTop % array
nEdges = grid % nEdges
@@ -715,37 +715,37 @@
! hSum is initialized outside the loop because on land boundaries
! maxLevelEdgeTop=0, but I want to initialize hSum with a
! nonzero value to avoid a NaN.
- uhSum = layerThicknessEdge(1,iEdge) * u(1,iEdge)
+ uhSum = layerThicknessEdge(1,iEdge) * normalVelocity(1,iEdge)
hSum = layerThicknessEdge(1,iEdge)
do k=2,maxLevelEdgeTop(iEdge)
- uhSum = uhSum + layerThicknessEdge(k,iEdge) * u(k,iEdge)
+ uhSum = uhSum + layerThicknessEdge(k,iEdge) * normalVelocity(k,iEdge)
hSum = hSum + layerThicknessEdge(k,iEdge)
enddo
vertSum = uhSum/hSum
do k=1,maxLevelEdgeTop(iEdge)
- u(k,iEdge) = u(k,iEdge) - vertSum
+ normalVelocity(k,iEdge) = normalVelocity(k,iEdge) - vertSum
enddo
enddo ! iEdge
- call mpas_timer_stop("ocn_filter_btr_mode_u")
+ call mpas_timer_stop("ocn_filter_btr_mode_vel")
- end subroutine ocn_filter_btr_mode_u!}}}
+ end subroutine ocn_filter_btr_mode_vel!}}}
!***********************************************************************
!
-! routine ocn_filter_btr_mode_tend_u
+! routine ocn_filter_btr_mode_tend_vel
!
-!> \brief ocn_filters barotropic mode out of the u tendency
+!> \brief ocn_filters barotropic mode out of the velocity tendency
!> \author Mark Petersen
!> \date 23 September 2011
!> \version SVN:$Id$
!> \details
-!> This routine filters barotropic mode out of the u tendency.
+!> This routine filters barotropic mode out of the velocity tendency.
!
!-----------------------------------------------------------------------
- subroutine ocn_filter_btr_mode_tend_u(tend, s, grid)!{{{
+ subroutine ocn_filter_btr_mode_tend_vel(tend, s, grid)!{{{
implicit none
type (tend_type), intent(inout) :: tend
@@ -754,13 +754,13 @@
integer :: iEdge, k, nEdges
real (kind=RKIND) :: vertSum, uhSum, hSum
- real (kind=RKIND), dimension(:,:), pointer :: layerThicknessEdge, tend_u
+ real (kind=RKIND), dimension(:,:), pointer :: layerThicknessEdge, tend_normalVelocity
integer, dimension(:), pointer :: maxLevelEdgeTop
- call mpas_timer_start("ocn_filter_btr_mode_tend_u")
+ call mpas_timer_start("ocn_filter_btr_mode_tend_vel")
- tend_u => tend % u % array
+ tend_normalVelocity => tend % normalVelocity % array
layerThicknessEdge => s % layerThicknessEdge % array
maxLevelEdgeTop => grid % maxLevelEdgeTop % array
nEdges = grid % nEdges
@@ -770,23 +770,23 @@
! hSum is initialized outside the loop because on land boundaries
! maxLevelEdgeTop=0, but I want to initialize hSum with a
! nonzero value to avoid a NaN.
- uhSum = layerThicknessEdge(1,iEdge) * tend_u(1,iEdge)
+ uhSum = layerThicknessEdge(1,iEdge) * tend_normalVelocity(1,iEdge)
hSum = layerThicknessEdge(1,iEdge)
do k=2,maxLevelEdgeTop(iEdge)
- uhSum = uhSum + layerThicknessEdge(k,iEdge) * tend_u(k,iEdge)
+ uhSum = uhSum + layerThicknessEdge(k,iEdge) * tend_normalVelocity(k,iEdge)
hSum = hSum + layerThicknessEdge(k,iEdge)
enddo
vertSum = uhSum/hSum
do k=1,maxLevelEdgeTop(iEdge)
- tend_u(k,iEdge) = tend_u(k,iEdge) - vertSum
+ tend_normalVelocity(k,iEdge) = tend_normalVelocity(k,iEdge) - vertSum
enddo
enddo ! iEdge
- call mpas_timer_stop("ocn_filter_btr_mode_tend_u")
+ call mpas_timer_stop("ocn_filter_btr_mode_tend_vel")
- end subroutine ocn_filter_btr_mode_tend_u!}}}
+ end subroutine ocn_filter_btr_mode_tend_vel!}}}
!***********************************************************************
!
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-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_global_diagnostics.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -46,8 +46,8 @@
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, &
- Vor_cell, gradVor_n, gradVor_t, pressure, MontPot, wTop, density, tracerTemp
+ real (kind=RKIND), dimension(:,:), pointer :: layerThickness, normalVelocity, v, layerThicknessEdge, relativeVorticity, ke, potentialVorticityEdge, potentialVorticityVertex, &
+ potentialVorticityCell, 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
@@ -86,17 +86,17 @@
areaEdge = dcEdge(1:nEdgesSolve)*dvEdge(1:nEdgesSolve)
layerThickness => state % layerThickness % array
- u => state % u % array
+ normalVelocity => state % normalVelocity % array
density => state % density % array
tracers => state % tracers % array
v => state % v % array
wTop => state % wTop % array
layerThicknessEdge => state % layerThicknessEdge % array
- vorticity => state % vorticity % array
+ relativeVorticity => state % relativeVorticity % array
ke => state % ke % array
- Vor_edge => state % Vor_edge % array
- Vor_vertex => state % Vor_vertex % array
- Vor_cell => state % Vor_cell % array
+ potentialVorticityEdge => state % potentialVorticityEdge % array
+ potentialVorticityVertex => state % potentialVorticityVertex % array
+ potentialVorticityCell => state % potentialVorticityCell % array
gradVor_n => state % gradVor_n % array
gradVor_t => state % gradVor_t % array
MontPot => state % MontPot % array
@@ -116,7 +116,7 @@
! u
variableIndex = variableIndex + 1
call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), layerThicknessEdge(:,1:nEdgesSolve), &
- u(:,1:nEdgesSolve), sums_tmp(variableIndex), mins_tmp(variableIndex), maxes_tmp(variableIndex), verticalSumMins_tmp(variableIndex), &
+ normalVelocity(:,1:nEdgesSolve), sums_tmp(variableIndex), mins_tmp(variableIndex), maxes_tmp(variableIndex), verticalSumMins_tmp(variableIndex), &
verticalSumMaxes_tmp(variableIndex))
sums(variableIndex) = sums(variableIndex) + sums_tmp(variableIndex)
mins(variableIndex) = min(mins(variableIndex), mins_tmp(variableIndex))
@@ -145,9 +145,9 @@
verticalSumMins(variableIndex) = min(verticalSumMins(variableIndex), verticalSumMins_tmp(variableIndex))
verticalSumMaxes(variableIndex) = max(verticalSumMaxes(variableIndex), verticalSumMaxes_tmp(variableIndex))
- ! vorticity
+ ! relativeVorticity
variableIndex = variableIndex + 1
- call ocn_compute_field_local_stats(dminfo, nVertLevels, nVerticesSolve, vorticity(:,1:nVerticesSolve), &
+ call ocn_compute_field_local_stats(dminfo, nVertLevels, nVerticesSolve, relativeVorticity(:,1:nVerticesSolve), &
sums_tmp(variableIndex), mins_tmp(variableIndex), maxes_tmp(variableIndex), verticalSumMins_tmp(variableIndex), verticalSumMaxes_tmp(variableIndex))
sums(variableIndex) = sums(variableIndex) + sums_tmp(variableIndex)
mins(variableIndex) = min(mins(variableIndex), mins_tmp(variableIndex))
@@ -155,9 +155,9 @@
verticalSumMins(variableIndex) = min(verticalSumMins(variableIndex), verticalSumMins_tmp(variableIndex))
verticalSumMaxes(variableIndex) = max(verticalSumMaxes(variableIndex), verticalSumMaxes_tmp(variableIndex))
- ! vorticity**2
+ ! relativeVorticity**2
allocate(enstrophy(nVertLevels,nVerticesSolve))
- enstrophy(:,:)=vorticity(:,1:nVerticesSolve)**2
+ enstrophy(:,:)=relativeVorticity(:,1:nVerticesSolve)**2
variableIndex = variableIndex + 1
call ocn_compute_field_area_weighted_local_stats(dminfo, nVertLevels, nVerticesSolve, areaTriangle(1:nVerticesSolve), &
enstrophy(:,:), sums_tmp(variableIndex), mins_tmp(variableIndex), maxes_tmp(variableIndex), &
@@ -180,10 +180,10 @@
verticalSumMins(variableIndex) = min(verticalSumMins(variableIndex), verticalSumMins_tmp(variableIndex))
verticalSumMaxes(variableIndex) = max(verticalSumMaxes(variableIndex), verticalSumMaxes_tmp(variableIndex))
- ! Vor_edge
+ ! potentialVorticityEdge
variableIndex = variableIndex + 1
call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nEdgesSolve, areaEdge(1:nEdgesSolve), layerThicknessEdge(:,1:nEdgesSolve), &
- Vor_edge(:,1:nEdgesSolve), sums_tmp(variableIndex), mins_tmp(variableIndex), maxes_tmp(variableIndex), verticalSumMins_tmp(variableIndex), &
+ potentialVorticityEdge(:,1:nEdgesSolve), sums_tmp(variableIndex), mins_tmp(variableIndex), maxes_tmp(variableIndex), verticalSumMins_tmp(variableIndex), &
verticalSumMaxes_tmp(variableIndex))
sums(variableIndex) = sums(variableIndex) + sums_tmp(variableIndex)
mins(variableIndex) = min(mins(variableIndex), mins_tmp(variableIndex))
@@ -191,10 +191,10 @@
verticalSumMins(variableIndex) = min(verticalSumMins(variableIndex), verticalSumMins_tmp(variableIndex))
verticalSumMaxes(variableIndex) = max(verticalSumMaxes(variableIndex), verticalSumMaxes_tmp(variableIndex))
- ! Vor_vertex
+ ! potentialVorticityVertex
variableIndex = variableIndex + 1
call ocn_compute_field_area_weighted_local_stats(dminfo, nVertLevels, nVerticesSolve, areaTriangle(1:nVerticesSolve), &
- Vor_vertex(:,1:nVerticesSolve), sums_tmp(variableIndex), mins_tmp(variableIndex), maxes_tmp(variableIndex), &
+ potentialVorticityVertex(:,1:nVerticesSolve), sums_tmp(variableIndex), mins_tmp(variableIndex), maxes_tmp(variableIndex), &
verticalSumMins_tmp(variableIndex), verticalSumMaxes_tmp(variableIndex))
sums(variableIndex) = sums(variableIndex) + sums_tmp(variableIndex)
mins(variableIndex) = min(mins(variableIndex), mins_tmp(variableIndex))
@@ -202,10 +202,10 @@
verticalSumMins(variableIndex) = min(verticalSumMins(variableIndex), verticalSumMins_tmp(variableIndex))
verticalSumMaxes(variableIndex) = max(verticalSumMaxes(variableIndex), verticalSumMaxes_tmp(variableIndex))
- ! Vor_cell
+ ! potentialVorticityCell
variableIndex = variableIndex + 1
call ocn_compute_field_volume_weighted_local_stats(dminfo, nVertLevels, nCellsSolve, areaCell(1:nCellsSolve), layerThickness(:,1:nCellsSolve), &
- Vor_cell(:,1:nCellsSolve), sums_tmp(variableIndex), mins_tmp(variableIndex), maxes_tmp(variableIndex), verticalSumMins_tmp(variableIndex), &
+ potentialVorticityCell(:,1:nCellsSolve), sums_tmp(variableIndex), mins_tmp(variableIndex), maxes_tmp(variableIndex), verticalSumMins_tmp(variableIndex), &
verticalSumMaxes_tmp(variableIndex))
sums(variableIndex) = sums(variableIndex) + sums_tmp(variableIndex)
mins(variableIndex) = min(mins(variableIndex), mins_tmp(variableIndex))
@@ -309,7 +309,7 @@
localCFL = 0.0
do elementIndex = 1,nEdgesSolve
- localCFL = max(localCFL, maxval(dt*u(:,elementIndex)/dcEdge(elementIndex)))
+ localCFL = max(localCFL, maxval(dt*normalVelocity(:,elementIndex)/dcEdge(elementIndex)))
end do
nMaxes = nMaxes + 1
maxes(nMaxes) = localCFL
@@ -366,11 +366,11 @@
variableIndex = variableIndex + 1
averages(variableIndex) = sums(variableIndex)/(areaEdgeGlobal*nVertLevels)
- ! vorticity
+ ! relativeVorticity
variableIndex = variableIndex + 1
averages(variableIndex) = sums(variableIndex)/(nVerticesGlobal*nVertLevels)
- ! vorticity
+ ! relativeVorticity
variableIndex = variableIndex + 1
averages(variableIndex) = sums(variableIndex)/(areaTriangleGlobal*nVertLevels)
@@ -378,15 +378,15 @@
variableIndex = variableIndex + 1
averages(variableIndex) = sums(variableIndex)/volumeCellGlobal
- ! Vor_edge
+ ! potentialVorticityEdge
variableIndex = variableIndex + 1
averages(variableIndex) = sums(variableIndex)/volumeEdgeGlobal
- ! Vor_vertex
+ ! potentialVorticityVertex
variableIndex = variableIndex + 1
averages(variableIndex) = sums(variableIndex)/(areaTriangleGlobal*nVertLevels)
- ! Vor_cell
+ ! potentialVorticityCell
variableIndex = variableIndex + 1
averages(variableIndex) = sums(variableIndex)/volumeCellGlobal
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_mpas_core.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_mpas_core.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_mpas_core.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -275,14 +275,14 @@
! Compute velocity transport, used in advection terms of layerThickness and tracer tendency
block % state % time_levs(1) % state % uTransport % array(:,:) &
- = block % state % time_levs(1) % state % u % array(:,:) &
+ = block % state % time_levs(1) % state % normalVelocity % array(:,:) &
+ block % state % time_levs(1) % state % uBolusGM % array(:,:)
call ocn_compute_mesh_scaling(mesh)
call mpas_rbf_interp_initialize(mesh)
call mpas_init_reconstruct(mesh)
- call mpas_reconstruct(mesh, block % state % time_levs(1) % state % u % array, &
+ call mpas_reconstruct(mesh, block % state % time_levs(1) % state % normalVelocity % array, &
block % state % time_levs(1) % state % uReconstructX % array, &
block % state % time_levs(1) % state % uReconstructY % array, &
block % state % time_levs(1) % state % uReconstructZ % array, &
@@ -303,11 +303,11 @@
block % mesh % areaCell % array(block % mesh % nCells+1) = -1.0e34
do iEdge=1,block % mesh % nEdges
- block % state % time_levs(1) % state % u % array( &
+ block % state % time_levs(1) % state % normalVelocity % array( &
block % mesh % maxLevelEdgeTop % array(iEdge)+1 &
:block % mesh % maxLevelEdgeBot % array(iEdge), iEdge) = 0.0
- block % state % time_levs(1) % state % u % array( &
+ block % state % time_levs(1) % state % normalVelocity % array( &
block % mesh % maxLevelEdgeBot % array(iEdge)+1: &
block % mesh % nVertLevels,iEdge) = 0.0
end do
@@ -759,7 +759,7 @@
block % state % time_levs(1) % state % uBtr % array(:) = 0.0
block % state % time_levs(1) % state % uBcl % array(:,:) &
- = block % state % time_levs(1) % state % u % array(:,:)
+ = block % state % time_levs(1) % state % normalVelocity % array(:,:)
elseif (trim(config_time_integrator) == 'split_explicit') then
@@ -784,7 +784,7 @@
layerThicknessEdge1 = 0.5*( &
block % state % time_levs(1) % state % layerThickness % array(1,cell1) &
+ block % state % time_levs(1) % state % layerThickness % array(1,cell2) )
- uhSum = layerThicknessEdge1*block % state % time_levs(1) % state % u % array(1,iEdge)
+ uhSum = layerThicknessEdge1*block % state % time_levs(1) % state % normalVelocity % array(1,iEdge)
layerThicknessSum = layerThicknessEdge1
do k=2,block % mesh % maxLevelEdgeTop % array(iEdge)
@@ -795,29 +795,29 @@
+ block % state % time_levs(1) % state % layerThickness % array(k,cell2) )
uhSum = uhSum &
- + layerThicknessEdge1*block % state % time_levs(1) % state % u % array(k,iEdge)
+ + layerThicknessEdge1*block % state % time_levs(1) % state % normalVelocity % array(k,iEdge)
layerThicknessSum = layerThicknessSum + layerThicknessEdge1
enddo
block % state % time_levs(1) % state % uBtr % array(iEdge) = uhSum/layerThicknessSum
- ! uBcl(k,iEdge) = u(k,iEdge) - uBtr(iEdge)
+ ! uBcl(k,iEdge) = normalVelocity(k,iEdge) - uBtr(iEdge)
do k=1,block % mesh % maxLevelEdgeTop % array(iEdge)
block % state % time_levs(1) % state % uBcl % array(k,iEdge) &
- = block % state % time_levs(1) % state % u % array(k,iEdge) &
+ = block % state % time_levs(1) % state % normalVelocity % array(k,iEdge) &
- block % state % time_levs(1) % state % uBtr % array(iEdge)
enddo
- ! uBcl=0, u=0 on land cells
+ ! uBcl=0, normalVelocity=0 on land cells
do k=block % mesh % maxLevelEdgeTop % array(iEdge)+1, block % mesh % nVertLevels
block % state % time_levs(1) % state % uBcl % array(k,iEdge) = 0.0
- block % state % time_levs(1) % state % u % array(k,iEdge) = 0.0
+ block % state % time_levs(1) % state % normalVelocity % array(k,iEdge) = 0.0
enddo
enddo
if (config_filter_btr_mode) then
! filter uBtr out of initial condition
- block % state % time_levs(1) % state % u % array(:,:) &
+ block % state % time_levs(1) % state % normalVelocity % array(:,:) &
= block % state % time_levs(1) % state % uBcl % array(:,:)
block % state % time_levs(1) % state % uBtr % array(:) = 0.0
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-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tendency.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -57,7 +57,7 @@
!--------------------------------------------------------------------
public :: ocn_tend_h, &
- ocn_tend_u, &
+ ocn_tend_vel, &
ocn_tend_tracer, &
ocn_tendency_init
@@ -135,7 +135,7 @@
!***********************************************************************
!
-! routine ocn_tend_u
+! routine ocn_tend_vel
!
!> \brief Computes velocity tendency
!> \author Doug Jacobsen
@@ -146,7 +146,7 @@
!
!-----------------------------------------------------------------------
- subroutine ocn_tend_u(tend, s, d, grid)!{{{
+ subroutine ocn_tend_vel(tend, s, d, grid)!{{{
implicit none
type (tend_type), intent(inout) :: tend !< Input/Output: Tendency structure
@@ -155,39 +155,39 @@
type (mesh_type), intent(in) :: grid !< Input: Grid information
real (kind=RKIND), dimension(:,:), pointer :: &
- layerThicknessEdge, h, u, density, zMid, pressure, &
- tend_u, circulation, vorticity, viscosity, ke, ke_edge, Vor_edge, &
+ layerThicknessEdge, h, normalVelocity, density, zMid, pressure, &
+ tend_normalVelocity, circulation, relativeVorticity, viscosity, ke, ke_edge, potentialVorticityEdge, &
MontPot, wTop, divergence, vertViscTopOfEdge
real (kind=RKIND), dimension(:,:), pointer :: u_src
integer :: err
- call mpas_timer_start("ocn_tend_u")
+ call mpas_timer_start("ocn_tend_vel")
- u => s % u % array
+ normalVelocity => s % normalVelocity % array
density => s % density % array
wTop => s % wTop % array
zMid => s % zMid % array
layerThicknessEdge => s % layerThicknessEdge % array
viscosity => s % viscosity % array
- vorticity => s % vorticity % array
+ relativeVorticity => s % relativeVorticity % array
divergence => s % divergence % array
ke => s % ke % array
ke_edge => s % ke_edge % array
- Vor_edge => s % Vor_edge % array
+ potentialVorticityEdge => s % potentialVorticityEdge % array
MontPot => s % MontPot % array
pressure => s % pressure % array
vertViscTopOfEdge => d % vertViscTopOfEdge % array
- tend_u => tend % u % array
+ tend_normalVelocity => tend % normalVelocity % array
u_src => grid % u_src % array
!
! velocity tendency: start accumulating tendency terms
!
- tend_u(:,:) = 0.0
+ tend_normalVelocity(:,:) = 0.0
if(config_disable_u_all_tend) return
@@ -196,14 +196,14 @@
!
call mpas_timer_start("coriolis", .false., velCorTimer)
- call ocn_vel_coriolis_tend(grid, Vor_edge, layerThicknessEdge, u, ke, tend_u, err)
+ call ocn_vel_coriolis_tend(grid, potentialVorticityEdge, layerThicknessEdge, normalVelocity, ke, tend_normalVelocity, err)
call mpas_timer_stop("coriolis", velCorTimer)
!
! velocity tendency: vertical advection term -w du/dz
!
call mpas_timer_start("vadv", .false., velVadvTimer)
- call ocn_vel_vadv_tend(grid, u, layerThicknessEdge, wtop, tend_u, err)
+ call ocn_vel_vadv_tend(grid, normalVelocity, layerThicknessEdge, wtop, tend_normalVelocity, err)
call mpas_timer_stop("vadv", velVadvTimer)
!
@@ -211,19 +211,19 @@
!
call mpas_timer_start("pressure grad", .false., velPgradTimer)
if (config_pressure_gradient_type.eq.'MontgomeryPotential') then
- call ocn_vel_pressure_grad_tend(grid, MontPot, zMid, density, tend_u, err)
+ call ocn_vel_pressure_grad_tend(grid, MontPot, zMid, density, tend_normalVelocity, err)
else
- call ocn_vel_pressure_grad_tend(grid, pressure, zMid, density, tend_u, err)
+ call ocn_vel_pressure_grad_tend(grid, pressure, zMid, density, tend_normalVelocity, err)
end if
call mpas_timer_stop("pressure grad", velPgradTimer)
!
! velocity tendency: del2 dissipation, </font>
<font color="black">u_2 </font>
<font color="red">abla^2 u
- ! computed as </font>
<font color="black">u( </font>
<font color="black">abla divergence + k \times </font>
<font color="blue">abla vorticity )
+ ! computed as </font>
<font color="black">u( </font>
<font color="black">abla divergence + k \times </font>
<font color="gray">abla relativeVorticity )
! strictly only valid for config_mom_del2 == constant
!
call mpas_timer_start("hmix", .false., velHmixTimer)
- call ocn_vel_hmix_tend(grid, divergence, vorticity, viscosity, tend_u, err)
+ call ocn_vel_hmix_tend(grid, divergence, relativeVorticity, viscosity, tend_normalVelocity, err)
call mpas_timer_stop("hmix", velHmixTimer)
!
@@ -231,15 +231,15 @@
!
call mpas_timer_start("forcings", .false., velForceTimer)
- call ocn_vel_forcing_tend(grid, u, u_src, ke_edge, layerThicknessEdge, tend_u, err)
+ call ocn_vel_forcing_tend(grid, normalVelocity, u_src, ke_edge, layerThicknessEdge, tend_normalVelocity, err)
call mpas_timer_stop("forcings", velForceTimer)
!
! velocity tendency: vertical mixing d/dz( nu_v du/dz))
!
- call mpas_timer_stop("ocn_tend_u")
+ call mpas_timer_stop("ocn_tend_vel")
- end subroutine ocn_tend_u!}}}
+ end subroutine ocn_tend_vel!}}}
!***********************************************************************
!
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_thick_hadv.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_thick_hadv.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_thick_hadv.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -62,7 +62,7 @@
!
!-----------------------------------------------------------------------
- subroutine ocn_thick_hadv_tend(grid, u, layerThicknessEdge, tend, err)!{{{
+ subroutine ocn_thick_hadv_tend(grid, normalVelocity, layerThicknessEdge, tend, err)!{{{
!-----------------------------------------------------------------
!
@@ -71,7 +71,7 @@
!-----------------------------------------------------------------
real (kind=RKIND), dimension(:,:), intent(in) :: &
- u !< Input: velocity
+ normalVelocity !< Input: velocity
real (kind=RKIND), dimension(:,:), intent(in) :: &
layerThicknessEdge !< Input: thickness at edge
@@ -142,7 +142,7 @@
do i = 1, nEdgesOnCell(iCell)
iEdge = edgesOnCell(i, iCell)
do k = 1, maxLevelEdgeBot(iEdge)
- flux = u(k, iEdge) * dvEdge(iEdge) * layerThicknessEdge(k, iEdge)
+ flux = normalVelocity(k, iEdge) * dvEdge(iEdge) * layerThicknessEdge(k, iEdge)
tend(k, iCell) = tend(k, iCell) + edgeSignOnCell(i, iCell) * flux * invAreaCell
end do
end do
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_average.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_average.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_average.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -50,7 +50,7 @@
real (kind=RKIND), pointer :: nAccumulate, old_nAccumulate
real (kind=RKIND), dimension(:), pointer :: ssh
- real (kind=RKIND), dimension(:,:), pointer :: uReconstructZonal, uReconstructMeridional, u, vertVelocityTop
+ real (kind=RKIND), dimension(:,:), pointer :: uReconstructZonal, uReconstructMeridional, normalVelocity, vertVelocityTop
real (kind=RKIND), dimension(:,:), pointer :: acc_u, acc_uVar, acc_vertVelocityTop
real (kind=RKIND), dimension(:,:), pointer :: acc_uReconstructZonal, acc_uReconstructMeridional, acc_uReconstructZonalVar, acc_uReconstructMeridionalVar
@@ -66,7 +66,7 @@
ssh => state % ssh % array
uReconstructZonal => state % uReconstructZonal % array
uReconstructMeridional => state % uReconstructMeridional % array
- u => state % u % array
+ normalVelocity => state % normalVelocity % array
vertVelocityTop => state % vertVelocityTop % array
acc_ssh => state % acc_ssh % array
@@ -95,8 +95,8 @@
acc_uReconstructMeridional = old_acc_uReconstructMeridional + uReconstructMeridional
acc_uReconstructZonalVar = old_acc_uReconstructZonalVar + uReconstructZonal**2
acc_uReconstructMeridionalVar = old_acc_uReconstructMeridionalVar + uReconstructMeridional**2
- acc_u = old_acc_u + u
- acc_uVar = old_acc_uVar + u**2
+ acc_u = old_acc_u + normalVelocity
+ acc_uVar = old_acc_uVar + normalVelocity**2
acc_vertVelocityTop = old_acc_vertVelocityTop + vertVelocityTop
nAccumulate = old_nAccumulate + 1
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_integration.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_integration.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_integration.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -100,7 +100,7 @@
do while (associated(block))
block % state % time_levs(2) % state % xtime % scalar = timeStamp
- nanCheck = sum(block % state % time_levs(2) % state % u % array)
+ nanCheck = sum(block % state % time_levs(2) % state % normalVelocity % array)
if (nanCheck /= nanCheck) then
write(0,*) 'Abort: NaN detected'
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-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_integration_rk4.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -104,7 +104,7 @@
!
block => domain % blocklist
do while (associated(block))
- block % state % time_levs(2) % state % u % array(:,:) = block % state % time_levs(1) % state % u % array(:,:)
+ block % state % time_levs(2) % state % normalVelocity % array(:,:) = block % state % time_levs(1) % state % normalVelocity % array(:,:)
block % state % time_levs(2) % state % layerThickness % array(:,:) = block % state % time_levs(1) % state % layerThickness % array(:,:)
do iCell=1,block % mesh % nCells ! couple tracers to h
do k=1,block % mesh % maxLevelCell % array(iCell)
@@ -137,10 +137,10 @@
! --- update halos for diagnostic variables
call mpas_timer_start("RK4-diagnostic halo update")
- call mpas_dmpar_exch_halo_field(domain % blocklist % provis % Vor_edge)
+ call mpas_dmpar_exch_halo_field(domain % blocklist % provis % potentialVorticityEdge)
if (config_mom_del4 > 0.0) then
call mpas_dmpar_exch_halo_field(domain % blocklist % provis % divergence)
- call mpas_dmpar_exch_halo_field(domain % blocklist % provis % vorticity)
+ call mpas_dmpar_exch_halo_field(domain % blocklist % provis % relativeVorticity)
end if
call mpas_timer_stop("RK4-diagnostic halo update")
@@ -151,15 +151,15 @@
do while (associated(block))
! advection of u uses u, while advection of layerThickness and tracers use uTransport.
call ocn_wtop(block % mesh, block % provis % layerThickness % array, block % provis % layerThicknessEdge % array, &
- block % provis % u % array, block % provis % wTop % array, err)
- call ocn_tend_u(block % tend, block % provis, block % diagnostics, block % mesh)
+ block % provis % normalVelocity % array, block % provis % wTop % array, err)
+ call ocn_tend_vel(block % tend, block % provis, block % diagnostics, block % mesh)
call ocn_wtop(block % mesh, block % provis % layerThickness % array, block % provis % layerThicknessEdge % array, &
block % provis % uTransport % array, block % provis % wTop % array, err)
call ocn_tend_h(block % tend, block % provis, block % mesh)
if (config_filter_btr_mode) then
- call ocn_filter_btr_mode_tend_u(block % tend, block % provis, block % mesh)
+ call ocn_filter_btr_mode_tend_vel(block % tend, block % provis, block % mesh)
endif
call ocn_tend_tracer(block % tend, block % provis, block % diagnostics, block % mesh, dt)
@@ -170,7 +170,7 @@
! --- update halos for prognostic variables
call mpas_timer_start("RK4-pronostic halo update")
- call mpas_dmpar_exch_halo_field(domain % blocklist % tend % u)
+ call mpas_dmpar_exch_halo_field(domain % blocklist % tend % normalVelocity)
call mpas_dmpar_exch_halo_field(domain % blocklist % tend % layerThickness)
call mpas_dmpar_exch_halo_field(domain % blocklist % tend % tracers)
call mpas_timer_stop("RK4-pronostic halo update")
@@ -182,8 +182,8 @@
block => domain % blocklist
do while (associated(block))
- block % provis % u % array(:,:) = block % state % time_levs(1) % state % u % array(:,:) &
- + rk_substep_weights(rk_step) * block % tend % u % array(:,:)
+ block % provis % normalVelocity % array(:,:) = block % state % time_levs(1) % state % normalVelocity % array(:,:) &
+ + rk_substep_weights(rk_step) * block % tend % normalVelocity % array(:,:)
block % provis % layerThickness % array(:,:) = block % state % time_levs(1) % state % layerThickness % array(:,:) &
+ rk_substep_weights(rk_step) * block % tend % layerThickness % array(:,:)
@@ -197,7 +197,7 @@
end do
if (config_prescribe_velocity) then
- block % provis % u % array(:,:) = block % state % time_levs(1) % state % u % array(:,:)
+ block % provis % normalVelocity % array(:,:) = block % state % time_levs(1) % state % normalVelocity % array(:,:)
end if
if (config_prescribe_thickness) then
@@ -208,7 +208,7 @@
! Compute velocity transport, used in advection terms of layerThickness and tracer tendency
block % provis % uTransport % array(:,:) &
- = block % provis % u % array(:,:) &
+ = block % provis % normalVelocity % array(:,:) &
+ block % provis % uBolusGM % array(:,:)
block => block % next
@@ -221,8 +221,8 @@
call mpas_timer_start("RK4-RK4 accumulate update")
block => domain % blocklist
do while (associated(block))
- block % state % time_levs(2) % state % u % array(:,:) = block % state % time_levs(2) % state % u % array(:,:) &
- + rk_weights(rk_step) * block % tend % u % array(:,:)
+ block % state % time_levs(2) % state % normalVelocity % array(:,:) = block % state % time_levs(2) % state % normalVelocity % array(:,:) &
+ + rk_weights(rk_step) * block % tend % normalVelocity % array(:,:)
block % state % time_levs(2) % state % layerThickness % array(:,:) = block % state % time_levs(2) % state % layerThickness % array(:,:) &
+ rk_weights(rk_step) * block % tend % layerThickness % array(:,:)
@@ -283,7 +283,7 @@
! conducted on tendencies, not on the velocity and tracer fields. So this update is required to
! communicate the change due to implicit vertical mixing across the boundary.
call mpas_timer_start("RK4-implicit vert mix halos")
- call mpas_dmpar_exch_halo_field(domain % blocklist % state % time_levs(2) % state % u)
+ call mpas_dmpar_exch_halo_field(domain % blocklist % state % time_levs(2) % state % normalVelocity)
call mpas_dmpar_exch_halo_field(domain % blocklist % state % time_levs(2) % state % tracers)
call mpas_timer_stop("RK4-implicit vert mix halos")
@@ -292,7 +292,7 @@
block => domain % blocklist
do while (associated(block))
if (config_prescribe_velocity) then
- block % state % time_levs(2) % state % u % array(:,:) = block % state % time_levs(1) % state % u % array(:,:)
+ block % state % time_levs(2) % state % normalVelocity % array(:,:) = block % state % time_levs(1) % state % normalVelocity % array(:,:)
end if
if (config_prescribe_thickness) then
@@ -303,10 +303,10 @@
! Compute velocity transport, used in advection terms of layerThickness and tracer tendency
block % state % time_levs(2) % state % uTransport % array(:,:) &
- = block % state % time_levs(2) % state % u % array(:,:) &
+ = block % state % time_levs(2) % state % normalVelocity % array(:,:) &
+ block % state % time_levs(2) % state % uBolusGM % array(:,:)
- call mpas_reconstruct(block % mesh, block % state % time_levs(2) % state % u % array, &
+ call mpas_reconstruct(block % mesh, block % state % time_levs(2) % state % normalVelocity % array, &
block % state % time_levs(2) % state % uReconstructX % array, &
block % state % time_levs(2) % state % uReconstructY % array, &
block % state % time_levs(2) % state % uReconstructZ % array, &
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-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_time_integration_split.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -122,11 +122,11 @@
! weights layerThickness have changed. That is OK, because the GBtrForcing variable
! subtracts out the barotropic component from the baroclinic.
block % state % time_levs(1) % state % uBcl % array(k,iEdge) &
- = block % state % time_levs(1) % state % u % array(k,iEdge) &
+ = block % state % time_levs(1) % state % normalVelocity % array(k,iEdge) &
- block % state % time_levs(1) % state % uBtr % array( iEdge)
- block % state % time_levs(2) % state % u % array(k,iEdge) &
- = block % state % time_levs(1) % state % u % array(k,iEdge)
+ block % state % time_levs(2) % state % normalVelocity % array(k,iEdge) &
+ = block % state % time_levs(1) % state % normalVelocity % array(k,iEdge)
block % state % time_levs(2) % state % uBcl % array(k,iEdge) &
= block % state % time_levs(1) % state % uBcl % array(k,iEdge)
@@ -167,10 +167,10 @@
! --- update halos for diagnostic variables
call mpas_timer_start("se halo diag", .false., timer_halo_diagnostic)
- call mpas_dmpar_exch_halo_field(domain % blocklist % state % time_levs(2) % state % Vor_edge)
+ call mpas_dmpar_exch_halo_field(domain % blocklist % state % time_levs(2) % state % potentialVorticityEdge)
if (config_mom_del4 > 0.0) then
call mpas_dmpar_exch_halo_field(domain % blocklist % state % time_levs(2) % state % divergence)
- call mpas_dmpar_exch_halo_field(domain % blocklist % state % time_levs(2) % state % vorticity)
+ call mpas_dmpar_exch_halo_field(domain % blocklist % state % time_levs(2) % state % relativeVorticity)
end if
call mpas_timer_stop("se halo diag", timer_halo_diagnostic)
@@ -192,10 +192,10 @@
! Use the most recent time level available.
call ocn_wtop(block % mesh, block % state % time_levs(stage1_tend_time) % state % layerThickness % array, &
block % state % time_levs(stage1_tend_time) % state % layerThicknessEdge % array, &
- block % state % time_levs(stage1_tend_time) % state % u % array, &
+ block % state % time_levs(stage1_tend_time) % state % normalVelocity % array, &
block % state % time_levs(stage1_tend_time) % state % wTop % array, err)
- call ocn_tend_u(block % tend, block % state % time_levs(stage1_tend_time) % state, block % diagnostics, block % mesh)
+ call ocn_tend_vel(block % tend, block % state % time_levs(stage1_tend_time) % state, block % diagnostics, block % mesh)
block => block % next
end do
@@ -229,8 +229,8 @@
! uBclNew = uBclOld + dt*(-f*uBclPerp + T(u*,w*,p*) + g*grad(SSH*) )
! Here uNew is a work variable containing -fEdge(iEdge)*uBclPerp(k,iEdge)
uTemp(k) = block % state % time_levs(1) % state % uBcl % array(k,iEdge) &
- + dt * (block % tend % u % array (k,iEdge) &
- + block % state % time_levs(2) % state % u % array (k,iEdge) & ! this is f*uBcl^{perp}
+ + dt * (block % tend % normalVelocity % array (k,iEdge) &
+ + block % state % time_levs(2) % state % normalVelocity % array (k,iEdge) & ! this is f*uBcl^{perp}
+ split * gravity * ( block % state % time_levs(2) % state % ssh % array(cell2) &
- block % state % time_levs(2) % state % ssh % array(cell1) ) &
/block % mesh % dcEdge % array(iEdge) )
@@ -299,7 +299,7 @@
! For Split_Explicit unsplit, simply set uBtrNew=0, uBtrSubcycle=0, and uNew=uBclNew
block % state % time_levs(2) % state % uBtr % array(:) = 0.0
- block % state % time_levs(2) % state % u % array(:,:) = block % state % time_levs(2) % state % uBcl % array(:,:)
+ block % state % time_levs(2) % state % normalVelocity % array(:,:) = block % state % time_levs(2) % state % uBcl % array(:,:)
do iEdge=1,block % mesh % nEdges
do k=1,block % mesh % nVertLevels
@@ -853,7 +853,7 @@
! u = uBtr + uBcl
! here uBcl is at time n+1/2
! This is u used in next iteration or step
- block % state % time_levs(2) % state % u % array(k,iEdge) &
+ block % state % time_levs(2) % state % normalVelocity % array(k,iEdge) &
= block % mesh % edgeMask % array(k,iEdge) &
*( block % state % time_levs(2) % state % uBtr % array( iEdge) &
+ block % state % time_levs(2) % state % uBcl % array(k,iEdge) )
@@ -904,7 +904,7 @@
do iEdge=1,block % mesh % nEdges
do k=1,block % mesh % maxLevelEdgeTop % array(iEdge)
- block % state % time_levs(2) % state % u % array(k,iEdge) &
+ block % state % time_levs(2) % state % normalVelocity % array(k,iEdge) &
= block % state % time_levs(2) % state % uBtr % array( iEdge) &
+2*block % state % time_levs(2) % state % uBcl % array(k,iEdge) &
- block % state % time_levs(1) % state % uBcl % array(k,iEdge)
@@ -945,7 +945,7 @@
! conducted on tendencies, not on the velocity and tracer fields. So this update is required to
! communicate the change due to implicit vertical mixing across the boundary.
call mpas_timer_start("se implicit vert mix halos")
- call mpas_dmpar_exch_halo_field(domain % blocklist % state % time_levs(2) % state % u)
+ call mpas_dmpar_exch_halo_field(domain % blocklist % state % time_levs(2) % state % normalVelocity)
call mpas_dmpar_exch_halo_field(domain % blocklist % state % time_levs(2) % state % tracers)
call mpas_timer_stop("se implicit vert mix halos")
@@ -955,7 +955,7 @@
do while (associated(block))
if (config_prescribe_velocity) then
- block % state % time_levs(2) % state % u % array(:,:) = block % state % time_levs(1) % state % u % array(:,:)
+ block % state % time_levs(2) % state % normalVelocity % array(:,:) = block % state % time_levs(1) % state % normalVelocity % array(:,:)
end if
if (config_prescribe_thickness) then
@@ -966,10 +966,10 @@
! Compute velocity transport, used in advection terms of layerThickness and tracer tendency
block % state % time_levs(2) % state % uTransport % array(:,:) &
- = block % state % time_levs(2) % state % u % array(:,:) &
+ = block % state % time_levs(2) % state % normalVelocity % array(:,:) &
+ block % state % time_levs(2) % state % uBolusGM % array(:,:)
- call mpas_reconstruct(block % mesh, block % state % time_levs(2) % state % u % array, &
+ call mpas_reconstruct(block % mesh, block % state % time_levs(2) % state % normalVelocity % array, &
block % state % time_levs(2) % state % uReconstructX % array, &
block % state % time_levs(2) % state % uReconstructY % array, &
block % state % time_levs(2) % state % uReconstructZ % array, &
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tracer_hadv2.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tracer_hadv2.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tracer_hadv2.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -62,7 +62,7 @@
!
!-----------------------------------------------------------------------
- subroutine ocn_tracer_hadv2_tend(grid, u, layerThicknessEdge, tracers , tend, err)!{{{
+ subroutine ocn_tracer_hadv2_tend(grid, normalVelocity, layerThicknessEdge, tracers , tend, err)!{{{
!-----------------------------------------------------------------
!
@@ -71,7 +71,7 @@
!-----------------------------------------------------------------
real (kind=RKIND), dimension(:,:), intent(in) :: &
- u !< Input: tracer
+ normalVelocity !< Input: tracer
real (kind=RKIND), dimension(:,:), intent(in) :: &
layerThicknessEdge !< Input: thickness at edge
@@ -140,7 +140,7 @@
invAreaCell1 = 1.0 / areaCell(cell1)
invAreaCell2 = 1.0 / areaCell(cell2)
do k=1,maxLevelEdgeTop(iEdge)
- r_tmp = u(k,iEdge) * dvEdge(iEdge) * layerThicknessEdge(k,iEdge)
+ r_tmp = normalVelocity(k,iEdge) * dvEdge(iEdge) * layerThicknessEdge(k,iEdge)
do iTracer=1,num_tracers
tracer_edge = 0.5 * (tracers(iTracer,k,cell1) + tracers(iTracer,k,cell2))
flux = r_tmp * tracer_edge
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tracer_hadv3.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tracer_hadv3.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tracer_hadv3.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -63,7 +63,7 @@
!
!-----------------------------------------------------------------------
- subroutine ocn_tracer_hadv3_tend(grid, u, layerThicknessEdge, tracers , tend, err)!{{{
+ subroutine ocn_tracer_hadv3_tend(grid, normalVelocity, layerThicknessEdge, tracers , tend, err)!{{{
!-----------------------------------------------------------------
!
@@ -72,7 +72,7 @@
!-----------------------------------------------------------------
real (kind=RKIND), dimension(:,:), intent(in) :: &
- u !< Input: tracer
+ normalVelocity !< Input: tracer
real (kind=RKIND), dimension(:,:), intent(in) :: &
layerThicknessEdge !< Input: thickness at edge
@@ -176,8 +176,8 @@
end do
- velMask = 2*(abs(transfer(u(k,iEdge) <= 0, velMask))) - 1
- flux = dvEdge(iEdge) * u(k,iEdge) * layerThicknessEdge(k,iEdge) * ( &
+ velMask = 2*(abs(transfer(normalVelocity(k,iEdge) <= 0, velMask))) - 1
+ flux = dvEdge(iEdge) * normalVelocity(k,iEdge) * layerThicknessEdge(k,iEdge) * ( &
0.5*(tracers(iTracer,k,cell1) + tracers(iTracer,k,cell2)) &
-(dcEdge(iEdge) **2) * (d2fdx2_cell1 + d2fdx2_cell2) / 12. &
+velMask*(dcEdge(iEdge) **2) * coef_3rd_order*(d2fdx2_cell1 - d2fdx2_cell2) / 12. )
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tracer_hadv4.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tracer_hadv4.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_tracer_hadv4.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -62,7 +62,7 @@
!
!-----------------------------------------------------------------------
- subroutine ocn_tracer_hadv4_tend(grid, u, layerThicknessEdge, tracers , tend, err)!{{{
+ subroutine ocn_tracer_hadv4_tend(grid, normalVelocity, layerThicknessEdge, tracers , tend, err)!{{{
!-----------------------------------------------------------------
!
@@ -71,7 +71,7 @@
!-----------------------------------------------------------------
real (kind=RKIND), dimension(:,:), intent(in) :: &
- u !< Input: tracer
+ normalVelocity !< Input: tracer
real (kind=RKIND), dimension(:,:), intent(in) :: &
layerThicknessEdge !< Input: thickness at edge
@@ -170,7 +170,7 @@
deriv_two(i+1,2,iEdge) * tracers(iTracer,k,cellsOnCell(i,cell2))
end do
- flux = dvEdge(iEdge) * u(k,iEdge) * layerThicknessEdge(k,iEdge) * ( &
+ flux = dvEdge(iEdge) * normalVelocity(k,iEdge) * layerThicknessEdge(k,iEdge) * ( &
0.5*(tracers(iTracer,k,cell1) + tracers(iTracer,k,cell2)) &
-(dcEdge(iEdge) **2) * (d2fdx2_cell1 + d2fdx2_cell2) / 12. )
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_coriolis.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_coriolis.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_coriolis.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -63,7 +63,7 @@
!
!-----------------------------------------------------------------------
- subroutine ocn_vel_coriolis_tend(grid, Vor_edge, layerThicknessEdge, u, ke, tend, err)!{{{
+ subroutine ocn_vel_coriolis_tend(grid, Vor_edge, layerThicknessEdge, normalVelocity, ke, tend, err)!{{{
!-----------------------------------------------------------------
!
@@ -76,7 +76,7 @@
real (kind=RKIND), dimension(:,:), intent(in) :: &
layerThicknessEdge !< Input: Thickness on edge
real (kind=RKIND), dimension(:,:), intent(in) :: &
- u !< Input: Horizontal velocity
+ normalVelocity !< Input: Horizontal velocity
real (kind=RKIND), dimension(:,:), intent(in) :: &
ke !< Input: Kinetic Energy
@@ -142,7 +142,7 @@
do j = 1,nEdgesOnEdge(iEdge)
eoe = edgesOnEdge(j,iEdge)
workpv = 0.5 * (Vor_edge(k,iEdge) + Vor_edge(k,eoe))
- q = q + weightsOnEdge(j,iEdge) * u(k,eoe) * workpv * layerThicknessEdge(k,eoe)
+ q = q + weightsOnEdge(j,iEdge) * normalVelocity(k,eoe) * workpv * layerThicknessEdge(k,eoe)
end do
tend(k,iEdge) = tend(k,iEdge) + edgeMask(k, iEdge) * (q - ( ke(k,cell2) - ke(k,cell1) ) * invLength )
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_forcing_rayleigh.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_forcing_rayleigh.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_forcing_rayleigh.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -64,7 +64,7 @@
!
!-----------------------------------------------------------------------
- subroutine ocn_vel_forcing_rayleigh_tend(grid, u, tend, err)!{{{
+ subroutine ocn_vel_forcing_rayleigh_tend(grid, normalVelocity, tend, err)!{{{
!-----------------------------------------------------------------
!
@@ -73,7 +73,7 @@
!-----------------------------------------------------------------
real (kind=RKIND), dimension(:,:), intent(in) :: &
- u !< Input: velocity
+ normalVelocity !< Input: velocity
type (mesh_type), intent(in) :: &
grid !< Input: grid information
@@ -122,7 +122,7 @@
do iEdge=1,nEdgesSolve
do k=1,maxLevelEdgeTop(iEdge)
- tend(k,iEdge) = tend(k,iEdge) - rayleighDampingCoef * u(k,iEdge)
+ tend(k,iEdge) = tend(k,iEdge) - rayleighDampingCoef * normalVelocity(k,iEdge)
enddo
enddo
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_hmix.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_hmix.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_hmix.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -74,7 +74,7 @@
!
!-----------------------------------------------------------------------
- subroutine ocn_vel_hmix_tend(grid, divergence, vorticity, viscosity, tend, err)!{{{
+ subroutine ocn_vel_hmix_tend(grid, divergence, relativeVorticity, viscosity, tend, err)!{{{
!-----------------------------------------------------------------
!
@@ -86,7 +86,7 @@
divergence !< Input: velocity divergence
real (kind=RKIND), dimension(:,:), intent(in) :: &
- vorticity !< Input: vorticity
+ relativeVorticity !< Input: relative vorticity
type (mesh_type), intent(in) :: &
grid !< Input: grid information
@@ -132,15 +132,15 @@
viscosity = 0.0
call mpas_timer_start("del2", .false., del2Timer)
- call ocn_vel_hmix_del2_tend(grid, divergence, vorticity, viscosity, tend, err1)
+ call ocn_vel_hmix_del2_tend(grid, divergence, relativeVorticity, viscosity, tend, err1)
call mpas_timer_stop("del2", del2Timer)
call mpas_timer_start("leith", .false., leithTimer)
- call ocn_vel_hmix_leith_tend(grid, divergence, vorticity, viscosity, tend, err2)
+ call ocn_vel_hmix_leith_tend(grid, divergence, relativeVorticity, viscosity, tend, err2)
call mpas_timer_stop("leith", leithTimer)
call mpas_timer_start("del4", .false., del4Timer)
- call ocn_vel_hmix_del4_tend(grid, divergence, vorticity, tend, err3)
+ call ocn_vel_hmix_del4_tend(grid, divergence, relativeVorticity, tend, err3)
call mpas_timer_stop("del4", del4Timer)
err = ior(ior(err1, err2),err3)
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_hmix_del2.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_hmix_del2.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_hmix_del2.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -64,13 +64,13 @@
!> This routine computes the horizontal mixing tendency for momentum
!> based on a Laplacian form for the mixing, \f$</font>
<font color="black">u_2 </font>
<font color="red">abla^2 u\f$
!> This tendency takes the
-!> form \f$</font>
<font color="black">u( </font>
<font color="black">abla divergence + k \times </font>
<font color="blue">abla vorticity )\f$,
+!> form \f$</font>
<font color="black">u( </font>
<font color="black">abla divergence + k \times </font>
<font color="black">abla relativeVorticity )\f$,
!> where \f$</font>
<font color="black">u\f$ is a viscosity and \f$k\f$ is the vertical unit vector.
!> This form is strictly only valid for constant \f$</font>
<font color="gray">u\f$ .
!
!-----------------------------------------------------------------------
- subroutine ocn_vel_hmix_del2_tend(grid, divergence, vorticity, viscosity, tend, err)!{{{
+ subroutine ocn_vel_hmix_del2_tend(grid, divergence, relativeVorticity, viscosity, tend, err)!{{{
!-----------------------------------------------------------------
!
@@ -82,7 +82,7 @@
divergence !< Input: velocity divergence
real (kind=RKIND), dimension(:,:), intent(in) :: &
- vorticity !< Input: vorticity
+ relativeVorticity !< Input: relative vorticity
type (mesh_type), intent(in) :: &
grid !< Input: grid information
@@ -151,13 +151,13 @@
do k=1,maxLevelEdgeTop(iEdge)
- ! Here -( vorticity(k,vertex2) - vorticity(k,vertex1) ) / dvEdge(iEdge)
- ! is - </font>
<font color="red">abla vorticity pointing from vertex 2 to vertex 1, or equivalently
- ! + k \times </font>
<font color="blue">abla vorticity pointing from cell1 to cell2.
+ ! Here -( relativeVorticity(k,vertex2) - relativeVorticity(k,vertex1) ) / dvEdge(iEdge)
+ ! is - </font>
<font color="blue">abla relativeVorticity pointing from vertex 2 to vertex 1, or equivalently
+ ! + k \times </font>
<font color="gray">abla relativeVorticity pointing from cell1 to cell2.
u_diffusion = ( divergence(k,cell2) - divergence(k,cell1) ) * invLength1 &
-viscVortCoef &
- *( vorticity(k,vertex2) - vorticity(k,vertex1) ) * invLength2
+ *( relativeVorticity(k,vertex2) - relativeVorticity(k,vertex1) ) * invLength2
visc2 = meshScalingDel2(iEdge) * eddyVisc2
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_hmix_del4.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_hmix_del4.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_hmix_del4.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -66,13 +66,13 @@
!> based on a biharmonic form for the mixing. This mixing tendency
!> takes the form \f$-</font>
<font color="black">u_4 </font>
<font color="red">abla^4 u\f$
!> but is computed as
-!> \f$</font>
<font color="black">abla^2 u = </font>
<font color="black">abla divergence + k \times </font>
<font color="blue">abla vorticity\f$
+!> \f$</font>
<font color="black">abla^2 u = </font>
<font color="black">abla divergence + k \times </font>
<font color="black">abla relativeVorticity\f$
!> applied recursively.
!> This formulation is only valid for constant \f$</font>
<font color="gray">u_4\f$ .
!
!-----------------------------------------------------------------------
- subroutine ocn_vel_hmix_del4_tend(grid, divergence, vorticity, tend, err)!{{{
+ subroutine ocn_vel_hmix_del4_tend(grid, divergence, relativeVorticity, tend, err)!{{{
!-----------------------------------------------------------------
!
@@ -84,7 +84,7 @@
divergence !< Input: velocity divergence
real (kind=RKIND), dimension(:,:), intent(in) :: &
- vorticity !< Input: vorticity
+ relativeVorticity !< Input: relative vorticity
type (mesh_type), intent(in) :: &
grid !< Input: grid information
@@ -127,7 +127,7 @@
meshScalingDel4, areaCell
real (kind=RKIND), dimension(:,:), allocatable :: delsq_divergence, &
- delsq_circulation, delsq_vorticity, delsq_u
+ delsq_circulation, delsq_relativeVorticity, delsq_u
err = 0
@@ -159,10 +159,10 @@
allocate(delsq_u(nVertLEvels, nEdges+1))
allocate(delsq_divergence(nVertLevels, nCells+1))
- allocate(delsq_vorticity(nVertLevels, nVertices+1))
+ allocate(delsq_relativeVorticity(nVertLevels, nVertices+1))
delsq_u(:,:) = 0.0
- delsq_vorticity(:,:) = 0.0
+ delsq_relativeVorticity(:,:) = 0.0
delsq_divergence(:,:) = 0.0
!Compute delsq_u
@@ -177,19 +177,19 @@
invDvEdge = 1.0 / dvEdge(iEdge)
do k=1,maxLevelEdgeTop(iEdge)
- ! Compute </font>
<font color="black">abla^2 u = </font>
<font color="black">abla divergence + k \times </font>
<font color="blue">abla vorticity
+ ! Compute </font>
<font color="black">abla^2 u = </font>
<font color="black">abla divergence + k \times </font>
<font color="gray">abla relativeVorticity
delsq_u(k, iEdge) = ( divergence(k,cell2) - divergence(k,cell1) ) * invDcEdge &
- -viscVortCoef *( vorticity(k,vertex2) - vorticity(k,vertex1)) * invDcEdge * sqrt(3.0)
+ -viscVortCoef *( relativeVorticity(k,vertex2) - relativeVorticity(k,vertex1)) * invDcEdge * sqrt(3.0)
end do
end do
- ! Compute delsq_vorticity
+ ! Compute delsq_relativeVorticity
do iVertex = 1, nVertices
invAreaTri1 = 1.0 / areaTriangle(iVertex)
do i = 1, vertexDegree
iEdge = edgesOnVertex(i, iVertex)
do k = 1, maxLevelVertexTop(iVertex)
- delsq_vorticity(k, iVertex) = delsq_vorticity(k, iVertex) + edgeSignOnVertex(i, iVertex) * dcEdge(iEdge) * delsq_u(k, iEdge) * invAreaTri1
+ delsq_relativeVorticity(k, iVertex) = delsq_relativeVorticity(k, iVertex) + edgeSignOnVertex(i, iVertex) * dcEdge(iEdge) * delsq_u(k, iEdge) * invAreaTri1
end do
end do
end do
@@ -219,7 +219,7 @@
do k=1,maxLevelEdgeTop(iEdge)
u_diffusion = (delsq_divergence(k,cell2) - delsq_divergence(k,cell1)) * invDcEdge &
- -viscVortCoef * (delsq_vorticity(k,vertex2) - delsq_vorticity(k,vertex1) ) * invDcEdge * sqrt(3.0)
+ -viscVortCoef * (delsq_relativeVorticity(k,vertex2) - delsq_relativeVorticity(k,vertex1) ) * invDcEdge * sqrt(3.0)
tend(k,iEdge) = tend(k,iEdge) - edgeMask(k, iEdge) * u_diffusion * r_tmp
end do
@@ -227,7 +227,7 @@
deallocate(delsq_u)
deallocate(delsq_divergence)
- deallocate(delsq_vorticity)
+ deallocate(delsq_relativeVorticity)
!--------------------------------------------------------------------
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_hmix_leith.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_hmix_leith.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vel_hmix_leith.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -76,7 +76,7 @@
!
!-----------------------------------------------------------------------
- subroutine ocn_vel_hmix_leith_tend(grid, divergence, vorticity, viscosity, tend, err)!{{{
+ subroutine ocn_vel_hmix_leith_tend(grid, divergence, relativeVorticity, viscosity, tend, err)!{{{
!-----------------------------------------------------------------
!
@@ -88,7 +88,7 @@
divergence !< Input: velocity divergence
real (kind=RKIND), dimension(:,:), intent(in) :: &
- vorticity !< Input: vorticity
+ relativeVorticity !< Input: relative vorticity
type (mesh_type), intent(in) :: &
grid !< Input: grid information
@@ -157,19 +157,19 @@
do k=1,maxLevelEdgeTop(iEdge)
- ! Here -( vorticity(k,vertex2) - vorticity(k,vertex1) ) / dvEdge(iEdge)
- ! is - </font>
<font color="red">abla vorticity pointing from vertex 2 to vertex 1, or equivalently
- ! + k \times </font>
<font color="blue">abla vorticity pointing from cell1 to cell2.
+ ! Here -( relativeVorticity(k,vertex2) - relativeVorticity(k,vertex1) ) / dvEdge(iEdge)
+ ! is - </font>
<font color="blue">abla relativeVorticity pointing from vertex 2 to vertex 1, or equivalently
+ ! + k \times </font>
<font color="red">abla relativeVorticity pointing from cell1 to cell2.
u_diffusion = ( divergence(k,cell2) - divergence(k,cell1) ) * invLength1 &
-viscVortCoef &
- *( vorticity(k,vertex2) - vorticity(k,vertex1) ) * invLength2
+ *( relativeVorticity(k,vertex2) - relativeVorticity(k,vertex1) ) * invLength2
! Here the first line is (\delta x)^3
! the second line is |</font>
<font color="black">abla \omega|
! and u_diffusion is </font>
<font color="gray">abla^2 u (see formula for $\bf{D}$ above).
visc2 = ( config_leith_parameter * config_leith_dx * meshScaling(iEdge) / 3.14)**3 &
- * abs( vorticity(k,vertex2) - vorticity(k,vertex1) ) * invLength1 * sqrt(3.0)
+ * abs( relativeVorticity(k,vertex2) - relativeVorticity(k,vertex1) ) * invLength1 * sqrt(3.0)
visc2 = min(visc2, config_leith_visc2_max)
tend(k,iEdge) = tend(k,iEdge) + edgeMask(k, iEdge) * visc2 * u_diffusion
Modified: branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vmix.F
===================================================================
--- branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vmix.F        2013-04-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vmix.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -149,7 +149,7 @@
!
!-----------------------------------------------------------------------
- subroutine ocn_vel_vmix_tend_implicit(grid, dt, ke_edge, vertViscTopOfEdge, layerThickness, layerThicknessEdge, u, err)!{{{
+ subroutine ocn_vel_vmix_tend_implicit(grid, dt, ke_edge, vertViscTopOfEdge, layerThickness, layerThicknessEdge, normalVelocity, err)!{{{
!-----------------------------------------------------------------
!
@@ -179,7 +179,7 @@
!-----------------------------------------------------------------
real (kind=RKIND), dimension(:,:), intent(inout) :: &
- u !< Input: velocity
+ normalVelocity !< Input: velocity
real (kind=RKIND), dimension(:,:), intent(inout) :: &
layerThicknessEdge !< Input: thickness at edge
@@ -204,7 +204,7 @@
integer, dimension(:,:), pointer :: cellsOnEdge
- real (kind=RKIND), dimension(:), allocatable :: A, B, C, uTemp
+ real (kind=RKIND), dimension(:), allocatable :: A, B, C, velTemp
err = 0
@@ -215,7 +215,7 @@
maxLevelEdgeTop => grid % maxLevelEdgeTop % array
cellsOnEdge => grid % cellsOnEdge % array
- allocate(A(nVertLevels),B(nVertLevels),C(nVertLevels),uTemp(nVertLevels))
+ allocate(A(nVertLevels),B(nVertLevels),C(nVertLevels),velTemp(nVertLevels))
A(1)=0
do iEdge=1,nEdges
@@ -255,15 +255,15 @@
B(N) = 1 - A(N) + dt*config_bottom_drag_coeff &
*sqrt(2.0*ke_edge(k,iEdge))/layerThicknessEdge(k,iEdge)
- call tridiagonal_solve(A(2:N),B,C(1:N-1),u(:,iEdge),uTemp,N)
+ call tridiagonal_solve(A(2:N),B,C(1:N-1),normalVelocity(:,iEdge),velTemp,N)
- u(1:N,iEdge) = uTemp(1:N)
- u(N+1:nVertLevels,iEdge) = 0.0
+ normalVelocity(1:N,iEdge) = velTemp(1:N)
+ normalVelocity(N+1:nVertLevels,iEdge) = 0.0
end if
end do
- deallocate(A,B,C,uTemp)
+ deallocate(A,B,C,velTemp)
!--------------------------------------------------------------------
@@ -403,13 +403,13 @@
integer, intent(out) :: err
integer :: nCells
- real (kind=RKIND), dimension(:,:), pointer :: u, layerThickness, layerThicknessEdge, vertViscTopOfEdge, vertDiffTopOfCell, ke_edge
+ real (kind=RKIND), dimension(:,:), pointer :: normalVelocity, layerThickness, layerThicknessEdge, vertViscTopOfEdge, vertDiffTopOfCell, ke_edge
real (kind=RKIND), dimension(:,:,:), pointer :: tracers
integer, dimension(:), pointer :: maxLevelCell
err = 0
- u => state % u % array
+ normalVelocity => state % normalVelocity % array
tracers => state % tracers % array
layerThickness => state % layerThickness % array
layerThicknessEdge => state % layerThicknessEdge % array
@@ -425,7 +425,7 @@
!
! Implicit vertical solve for momentum
!
- call ocn_vel_vmix_tend_implicit(grid, dt, ke_edge, vertViscTopOfEdge, layerThickness, layerThicknessEdge, u, err)
+ call ocn_vel_vmix_tend_implicit(grid, dt, ke_edge, vertViscTopOfEdge, layerThickness, layerThicknessEdge, normalVelocity, err)
!
! Implicit vertical solve for tracers
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-03 15:39:41 UTC (rev 2713)
+++ branches/ocean_projects/variable_name_change/src/core_ocean/mpas_ocn_vmix_coefs_rich.F        2013-04-03 16:25:11 UTC (rev 2714)
@@ -109,7 +109,7 @@
integer :: err1, err2, err3, indexT, indexS
real (kind=RKIND), dimension(:,:), pointer :: &
- vertViscTopOfEdge, vertDiffTopOfCell, u, layerThickness, layerThicknessEdge, density, displacedDensity
+ vertViscTopOfEdge, vertDiffTopOfCell, normalVelocity, layerThickness, layerThicknessEdge, density, displacedDensity
real (kind=RKIND), dimension(:,:), pointer :: RiTopOfEdge, RiTopOfCell
@@ -133,7 +133,7 @@
RiTopOfEdge => d % RiTopOfEdge % array
RiTopOfCell => d % RiTopOfCell % array
- u => s % u % array
+ normalVelocity => s % normalVelocity % array
layerThickness => s % layerThickness % array
layerThicknessEdge => s % layerThicknessEdge % array
density => s % density % array
@@ -145,7 +145,7 @@
call ocn_equation_of_state_density(s, grid, 1,'relative', err)
call mpas_timer_stop("eos rich", richEOSTimer)
- call ocn_vmix_get_rich_numbers(grid, indexT, indexS, u, layerThickness, layerThicknessEdge, &
+ call ocn_vmix_get_rich_numbers(grid, indexT, indexS, normalVelocity, layerThickness, layerThicknessEdge, &
density, displacedDensity, tracers, RiTopOfEdge, RiTopOfCell, err1)
call ocn_vel_vmix_coefs_rich(grid, RiTopOfEdge, layerThicknessEdge, vertViscTopOfEdge, err2)
@@ -348,7 +348,7 @@
!
!-----------------------------------------------------------------------
- subroutine ocn_vmix_get_rich_numbers(grid, indexT, indexS, u, layerThickness, layerThicknessEdge, & !{{{
+ subroutine ocn_vmix_get_rich_numbers(grid, indexT, indexS, normalVelocity, layerThickness, layerThicknessEdge, & !{{{
density, displacedDensity, tracers, RiTopOfEdge, RiTopOfCell, err)
!-----------------------------------------------------------------
@@ -363,7 +363,7 @@
integer, intent(in) :: indexT !< Input: index for temperature
integer, intent(in) :: indexS !< Input: index for salinity
- real (kind=RKIND), dimension(:,:), intent(in) :: u !< Input: horizontal velocity
+ real (kind=RKIND), dimension(:,:), intent(in) :: normalVelocity !< Input: horizontal velocity
real (kind=RKIND), dimension(:,:), intent(in) :: layerThickness !< Input: thickness
real (kind=RKIND), dimension(:,:), intent(in) :: layerThicknessEdge !< Input: thickness at edge
@@ -452,7 +452,7 @@
du2TopOfEdge=0.0
do iEdge=1,nEdges
do k=2,maxLevelEdgeTop(iEdge)
- du2TopOfEdge(k,iEdge) = (u(k-1,iEdge) - u(k,iEdge))**2
+ du2TopOfEdge(k,iEdge) = (normalVelocity(k-1,iEdge) - normalVelocity(k,iEdge))**2
end do
end do
</font>
</pre>