<p><b>lipscomb</b> 2012-01-10 12:55:35 -0700 (Tue, 10 Jan 2012)</p><p>Changed 'sw' to 'land_ice' in module and subroutine names, as appropriate.<br>
<br>
sw_test_case_* is still called sw_test_case_*<br>
</p><hr noshade><pre><font color="gray">Modified: branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_advection.F
===================================================================
--- branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_advection.F        2012-01-10 18:53:05 UTC (rev 1336)
+++ branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_advection.F        2012-01-10 19:55:35 UTC (rev 1337)
@@ -1,4 +1,4 @@
-module sw_advection
+module land_ice_advection
 
    use mpas_kind_types
    use mpas_grid_types
@@ -9,7 +9,7 @@
    contains
 
 
-   subroutine sw_initialize_advection_rk( grid )
+   subroutine land_ice_initialize_advection_rk( grid )
                                       
 !
 ! compute the cell coefficients for the polynomial fit.
@@ -255,7 +255,7 @@
  
          end if
  
-         call sw_poly_fit_2( amatrix, bmatrix, wmatrix, ma, na, 25 )
+         call land_ice_poly_fit_2( amatrix, bmatrix, wmatrix, ma, na, 25 )
 
          do i=1,grid % nEdgesOnCell % array (iCell)
             ip1 = i+1
@@ -270,7 +270,7 @@
             zv2 = grid % zVertex % array(grid % verticesOnEdge % array (2,iedge))/a
   
             if ( grid % on_a_sphere ) then
-               call sw_arc_bisect( xv1, yv1, zv1,  &amp;
+               call land_ice_arc_bisect( xv1, yv1, zv1,  &amp;
                                 xv2, yv2, zv2,  &amp;
                                 xec, yec, zec   )
   
@@ -382,7 +382,7 @@
 !      end do
 !      stop
 
-   end subroutine sw_initialize_advection_rk
+   end subroutine land_ice_initialize_advection_rk
 
 
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
@@ -523,13 +523,13 @@
    
    
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
-   ! subroutine sw_arc_bisect
+   ! subroutine land_ice_arc_bisect
    !
    ! Returns the point C=(cx, cy, cz) that bisects the great circle arc from
    !   A=(ax, ay, az) to B=(bx, by, bz). It is assumed that A and B lie on the
    !   surface of a sphere centered at the origin.
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
-   subroutine sw_arc_bisect(ax, ay, az, bx, by, bz, cx, cy, cz)
+   subroutine land_ice_arc_bisect(ax, ay, az, bx, by, bz, cx, cy, cz)
    
       implicit none
    
@@ -554,10 +554,10 @@
          cz = r * cz / d
       end if
    
-   end subroutine sw_arc_bisect
+   end subroutine land_ice_arc_bisect
 
 
-   subroutine sw_poly_fit_2(a_in,b_out,weights_in,m,n,ne)
+   subroutine land_ice_poly_fit_2(a_in,b_out,weights_in,m,n,ne)
 
       implicit none
 
@@ -594,14 +594,14 @@
       ata = matmul(at,a)
 
 !      if (m == n) then
-!         call sw_migs(a,n,b,indx)
+!         call land_ice_migs(a,n,b,indx)
 !      else
 
-         call sw_migs(atha,n,atha_inv,indx)
+         call land_ice_migs(atha,n,atha_inv,indx)
 
          b = matmul(atha_inv,ath)
 
-!         call sw_migs(ata,n,ata_inv,indx)
+!         call land_ice_migs(ata,n,ata_inv,indx)
 !         b = matmul(ata_inv,at)
 !      end if
       b_out(1:n,1:m) = b(1:n,1:m)
@@ -612,7 +612,7 @@
 !
 !     write(6,*) ' '
 
-   end subroutine sw_poly_fit_2
+   end subroutine land_ice_poly_fit_2
 
 
 ! Updated 10/24/2001.
@@ -631,7 +631,7 @@
 !                                                                       !
 !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
 !
-subroutine sw_migs (A,N,X,INDX)
+subroutine land_ice_migs (A,N,X,INDX)
 !
 ! subroutine to invert matrix A(N,N) with the inverse stored
 ! in X(N,N) in the output.  Copyright (c) Tao Pang 2001.
@@ -653,7 +653,7 @@
     B(I,I) = 1.0
   END DO
 !
-  call sw_elgs (A,N,INDX)
+  call land_ice_elgs (A,N,INDX)
 !
   DO I = 1, N-1
     DO J = I+1, N
@@ -673,10 +673,10 @@
       X(J,I) =  X(J,I)/A(INDX(J),J)
     END DO
   END DO
-end subroutine sw_migs
+end subroutine land_ice_migs
 
 
-subroutine sw_elgs (A,N,INDX)
+subroutine land_ice_elgs (A,N,INDX)
 !
 ! subroutine to perform the partial-pivoting Gaussian elimination.
 ! A(N,N) is the original matrix in the input and transformed matrix
@@ -739,11 +739,11 @@
     END DO
   END DO
 !
-end subroutine sw_elgs
+end subroutine land_ice_elgs
 
 !-------------------------------------------------------------
 
-   subroutine sw_initialize_deformation_weights( grid )
+   subroutine land_ice_initialize_deformation_weights( grid )
                                       
 !
 ! compute the cell coefficients for the deformation calculations
@@ -929,6 +929,6 @@
 
       if (debug) write(0,*) ' exiting def weight calc '
 
-   end subroutine sw_initialize_deformation_weights
+   end subroutine land_ice_initialize_deformation_weights
 
-end module sw_advection
+end module land_ice_advection

Modified: branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_global_diagnostics.F
===================================================================
--- branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_global_diagnostics.F        2012-01-10 18:53:05 UTC (rev 1336)
+++ branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_global_diagnostics.F        2012-01-10 19:55:35 UTC (rev 1337)
@@ -1,4 +1,4 @@
-module sw_global_diagnostics
+module land_ice_global_diagnostics
 
    use mpas_grid_types
    use mpas_configure
@@ -11,7 +11,7 @@
 
    contains
 
-   subroutine sw_compute_global_diagnostics(dminfo, state, grid, timeIndex, dt)
+   subroutine land_ice_compute_global_diagnostics(dminfo, state, grid, timeIndex, dt)
 
       ! Note: this routine assumes that there is only one block per processor. No looping
       ! is preformed over blocks.
@@ -206,12 +206,12 @@
       ! Step 4
       ! 4. Call Function to compute Global Stat that you want.
       ! Computing Kinetic and Potential Energy Tendency Terms
-      call sw_compute_global_sum(dminfo, nVertLevels, nEdgesSolve, keTend_PressureGradient, globalKineticEnergyTendency)
-      call sw_compute_global_sum(dminfo, nVertLevels, nCells, peTend_DivThickness, globalPotentialEnergyTendency)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nEdgesSolve, keTend_PressureGradient, globalKineticEnergyTendency)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nCells, peTend_DivThickness, globalPotentialEnergyTendency)
 
       ! Computing top and bottom of global mass integral
-      call sw_compute_global_sum(dminfo, nVertLevels, nCellsSolve, cellVolume, sumCellVolume)
-      call sw_compute_global_sum(dminfo, nVertLevels, nCellsSolve, cellArea, sumCellArea)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nCellsSolve, cellVolume, sumCellVolume)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nCellsSolve, cellArea, sumCellArea)
 
       globalKineticEnergyTendency = globalKineticEnergyTendency / sumCellVolume
       globalPotentialEnergyTendency = globalPotentialEnergyTendency / sumCellVolume
@@ -222,38 +222,38 @@
 
       ! Compute Average Sea Surface Height for Potential Energy and Enstrophy
       ! Reservoir computations
-      call sw_compute_global_sum(dminfo, nVertLevels, nCellsSolve, refAreaWeightedSurfaceHeight, sumrefAreaWeightedSurfaceHeight)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nCellsSolve, refAreaWeightedSurfaceHeight, sumrefAreaWeightedSurfaceHeight)
 
       averageThickness(:) = (sumrefAreaWeightedSurfaceHeight/sumCellArea)-h_s(1:nCellsSolve)
 
       ! Compute Volume Weighted Averages of Potential Vorticity and Potential Enstrophy
-      call sw_compute_global_sum(dminfo, nVertLevels, nVerticesSolve, volumeWeightedPotentialVorticity, globalPotentialVorticity)
-      call sw_compute_global_sum(dminfo, nVertLevels, nVerticesSolve, volumeWeightedPotentialEnstrophy, globalPotentialEnstrophy)
-      call sw_compute_global_sum(dminfo, nVertLevels, nVerticesSolve, vertexVolume, sumVertexVolume)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nVerticesSolve, volumeWeightedPotentialVorticity, globalPotentialVorticity)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nVerticesSolve, volumeWeightedPotentialEnstrophy, globalPotentialEnstrophy)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nVerticesSolve, vertexVolume, sumVertexVolume)
 
       globalPotentialVorticity = globalPotentialVorticity/sumVertexVolume
       globalPotentialEnstrophy = globalPotentialEnstrophy/sumVertexVolume
 
       ! Compte Potential Enstrophy Reservior
       potentialEnstrophyReservior(:) = areaCell(:)*fCell(:)*fCell(:)/averageThickness
-      call sw_compute_global_sum(dminfo, 1, nCellsSolve, potentialEnstrophyReservior, globalPotentialEnstrophyReservoir)
+      call land_ice_compute_global_sum(dminfo, 1, nCellsSolve, potentialEnstrophyReservior, globalPotentialEnstrophyReservoir)
       globalPotentialEnstrophyReservoir = globalPotentialEnstrophyReservoir/sumCellVolume
 
       globalPotentialEnstrophy = globalPotentialEnstrophy - globalPotentialEnstrophyReservoir
 
       ! Compute Kinetic and Potential Energy terms to be combined into total energy
-      call sw_compute_global_sum(dminfo, nVertLevels, nEdgesSolve, volumeWeightedKineticEnergy, globalKineticEnergy)
-      call sw_compute_global_sum(dminfo, nVertLevels, nCellsSolve, volumeWeightedPotentialEnergy, globalPotentialEnergy)
-      call sw_compute_global_sum(dminfo, nVertLevels, nCellsSolve, volumeWeightedPotentialEnergyTopography, global_temp)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nEdgesSolve, volumeWeightedKineticEnergy, globalKineticEnergy)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nCellsSolve, volumeWeightedPotentialEnergy, globalPotentialEnergy)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nCellsSolve, volumeWeightedPotentialEnergyTopography, global_temp)
 
       globalKineticEnergy = globalKineticEnergy/sumCellVolume
       globalPotentialEnergy = (globalPotentialEnergy + global_temp)/sumCellVolume
 
       ! Compute Potential energy reservoir to be subtracted from potential energy term
       volumeWeightedPotentialEnergyReservoir(1:nCellsSolve) = areaCell(1:nCellsSolve)*averageThickness*averageThickness*gravity*0.5
-      call sw_compute_global_sum(dminfo, nVertLevels, nCellsSolve, volumeWeightedPotentialEnergyReservoir, globalPotentialEnergyReservoir)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nCellsSolve, volumeWeightedPotentialEnergyReservoir, globalPotentialEnergyReservoir)
       volumeWeightedPotentialEnergyReservoir(1:nCellsSolve) = areaCell(1:nCellsSolve)*averageThickness*h_s(1:nCellsSolve)*gravity
-      call sw_compute_global_sum(dminfo, nVertLevels, nCellsSolve, volumeWeightedPotentialEnergyReservoir, global_temp)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nCellsSolve, volumeWeightedPotentialEnergyReservoir, global_temp)
 
       globalPotentialEnergyReservoir = (globalPotentialEnergyReservoir + global_temp)/sumCellVolume
 
@@ -261,13 +261,13 @@
       globalEnergy = globalKineticEnergy + globalPotentialEnergy
 
       ! Compute Coriolis energy tendency term
-      call sw_compute_global_sum(dminfo, nVertLevels, nEdgesSolve, keTend_CoriolisForce, globalCoriolisEnergyTendency)
+      call land_ice_compute_global_sum(dminfo, nVertLevels, nEdgesSolve, keTend_CoriolisForce, globalCoriolisEnergyTendency)
       globalCoriolisEnergyTendency = globalCoriolisEnergyTendency/sumCellVolume
 
       ! Step 6
       ! 6. Write out your global stat to the file
       if (dminfo % my_proc_id == IO_NODE) then
-         fileID = sw_get_free_unit()
+         fileID = land_ice_get_free_unit()
 
          if (timeIndex/config_stats_interval == 1) then
              open(fileID, file='GlobalIntegrals.txt',STATUS='unknown')
@@ -281,27 +281,27 @@
       end if
 
       deallocate(areaEdge)
-   end subroutine sw_compute_global_diagnostics
+   end subroutine land_ice_compute_global_diagnostics
 
-   integer function sw_get_free_unit()
+   integer function land_ice_get_free_unit()
       implicit none
 
       integer :: index
       logical :: isOpened
 
-      sw_get_free_unit = 0
+      land_ice_get_free_unit = 0
       do index = 1,99
          if((index /= 5) .and. (index /= 6)) then
             inquire(unit = index, opened = isOpened)
             if( .not. isOpened) then
-               sw_get_free_unit = index
+               land_ice_get_free_unit = index
                return
             end if
          end if
       end do
-   end function sw_get_free_unit
+   end function land_ice_get_free_unit
 
-   subroutine sw_compute_global_sum(dminfo, nVertLevels, nElements, field, globalSum)
+   subroutine land_ice_compute_global_sum(dminfo, nVertLevels, nElements, field, globalSum)
 
       implicit none
 
@@ -315,9 +315,9 @@
       localSum = sum(field)
       call mpas_dmpar_sum_real(dminfo, localSum, globalSum)
 
-   end subroutine sw_compute_global_sum
+   end subroutine land_ice_compute_global_sum
 
-   subroutine sw_compute_global_min(dminfo, nVertLevels, nElements, field, globalMin)
+   subroutine land_ice_compute_global_min(dminfo, nVertLevels, nElements, field, globalMin)
 
       implicit none
 
@@ -331,9 +331,9 @@
       localMin = minval(field)
       call mpas_dmpar_min_real(dminfo, localMin, globalMin)
 
-   end subroutine sw_compute_global_min
+   end subroutine land_ice_compute_global_min
 
-   subroutine sw_compute_global_max(dminfo, nVertLevels, nElements, field, globalMax)
+   subroutine land_ice_compute_global_max(dminfo, nVertLevels, nElements, field, globalMax)
 
       implicit none
 
@@ -347,7 +347,7 @@
       localMax = maxval(field)
       call mpas_dmpar_max_real(dminfo, localMax, globalMax)
 
-   end subroutine sw_compute_global_max
+   end subroutine land_ice_compute_global_max
 
    subroutine compute_global_vert_sum_horiz_min(dminfo, nVertLevels, nElements, field, globalMin)
 
@@ -365,7 +365,7 @@
 
    end subroutine compute_global_vert_sum_horiz_min
 
-   subroutine sw_compute_global_vert_sum_horiz_max(dminfo, nVertLevels, nElements, field, globalMax)
+   subroutine land_ice_compute_global_vert_sum_horiz_max(dminfo, nVertLevels, nElements, field, globalMax)
 
       implicit none
 
@@ -379,6 +379,6 @@
       localMax = maxval(sum(field,1))
       call mpas_dmpar_max_real(dminfo, localMax, globalMax)
 
-   end subroutine sw_compute_global_vert_sum_horiz_max
+   end subroutine land_ice_compute_global_vert_sum_horiz_max
 
-end module sw_global_diagnostics
+end module land_ice_global_diagnostics

Modified: branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_mpas_core.F
===================================================================
--- branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_mpas_core.F        2012-01-10 18:53:05 UTC (rev 1336)
+++ branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_mpas_core.F        2012-01-10 19:55:35 UTC (rev 1337)
@@ -18,7 +18,7 @@
    
       use mpas_configure
       use mpas_grid_types
-      use sw_test_cases
+      use land_ice_test_cases
    
       implicit none
    
@@ -29,7 +29,7 @@
       type (block_type), pointer :: block
 
 
-      if (.not. config_do_restart) call setup_sw_test_case(domain)
+      if (.not. config_do_restart) call setup_land_ice_test_case(domain)
 
       !
       ! Initialize core
@@ -112,7 +112,7 @@
    subroutine mpas_init_block(block, mesh, dt)
    
       use mpas_grid_types
-      use sw_time_integration
+      use land_ice_time_integration
       use mpas_rbf_interpolation
       use mpas_vector_reconstruction
    
@@ -123,7 +123,7 @@
       real (kind=RKIND), intent(in) :: dt
    
 
-      call sw_compute_solve_diagnostics(dt, block % state % time_levs(1) % state, mesh)
+      call land_ice_compute_solve_diagnostics(dt, block % state % time_levs(1) % state, mesh)
       call compute_mesh_scaling(mesh) 
 
       call mpas_rbf_interp_initialize(mesh)
@@ -282,9 +282,9 @@
    subroutine mpas_timestep(domain, itimestep, dt, timeStamp)
    
       use mpas_grid_types
-      use sw_time_integration
+      use land_ice_time_integration
       use mpas_timer
-      use sw_global_diagnostics
+      use land_ice_global_diagnostics
    
       implicit none
    
@@ -296,7 +296,7 @@
       type (block_type), pointer :: block_ptr
       integer :: ierr
    
-      call sw_timestep(domain, dt, timeStamp)
+      call land_ice_timestep(domain, dt, timeStamp)
    
       if(config_stats_interval .gt. 0) then
           if(mod(itimestep, config_stats_interval) == 0) then
@@ -307,7 +307,7 @@
               end if
    
               call mpas_timer_start(&quot;global_diagnostics&quot;)
-              call sw_compute_global_diagnostics(domain % dminfo, &amp;
+              call land_ice_compute_global_diagnostics(domain % dminfo, &amp;
                        block_ptr % state % time_levs(2) % state, block_ptr % mesh, &amp;
                        itimestep, dt)
               call mpas_timer_stop(&quot;global_diagnostics&quot;)
@@ -325,7 +325,7 @@
       !   end if
 
       !   call mpas_timer_start(&quot;global_diagnostics&quot;)
-      !   call sw_compute_global_diagnostics(domain % dminfo, &amp;
+      !   call land_ice_compute_global_diagnostics(domain % dminfo, &amp;
       !            block_ptr % state % time_levs(2) % state, block_ptr % mesh, &amp;
       !            timeStamp, dt)
       !   call mpas_timer_stop(&quot;global_diagnostics&quot;)

Modified: branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_test_cases.F
===================================================================
--- branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_test_cases.F        2012-01-10 18:53:05 UTC (rev 1336)
+++ branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_test_cases.F        2012-01-10 19:55:35 UTC (rev 1337)
@@ -1,14 +1,13 @@
-module sw_test_cases
+module land_ice_test_cases
 
    use mpas_grid_types
    use mpas_configure
    use mpas_constants
 
-
    contains
 
 
-   subroutine setup_sw_test_case(domain)
+   subroutine setup_land_ice_test_case(domain)
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
    ! Configure grid metadata and model state for the shallow water test case 
    !   specified in the namelist
@@ -88,7 +87,7 @@
          stop
       end if
 
-   end subroutine setup_sw_test_case
+   end subroutine setup_land_ice_test_case
 
 
    subroutine sw_test_case_1(grid, state)
@@ -524,4 +523,4 @@
 
    end function cc
 
-end module sw_test_cases
+end module land_ice_test_cases

Modified: branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_time_integration.F
===================================================================
--- branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_time_integration.F        2012-01-10 18:53:05 UTC (rev 1336)
+++ branches/land_ice/mpas/src/core_land_ice/mpas_land_ice_time_integration.F        2012-01-10 19:55:35 UTC (rev 1337)
@@ -1,4 +1,4 @@
-module sw_time_integration
+module land_ice_time_integration
 
    use mpas_vector_reconstruction
    use mpas_grid_types
@@ -10,7 +10,7 @@
    contains
 
 
-   subroutine sw_timestep(domain, dt, timeStamp)
+   subroutine land_ice_timestep(domain, dt, timeStamp)
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! 
    ! Advance model state forward in time by the specified time step
    !
@@ -29,7 +29,7 @@
       type (block_type), pointer :: block
 
       if (trim(config_time_integration) == 'RK4') then
-         call sw_rk4(domain, dt)
+         call land_ice_rk4(domain, dt)
       else
          write(0,*) 'Unknown time integration option '//trim(config_time_integration)
          write(0,*) 'Currently, only ''RK4'' is supported.'
@@ -42,10 +42,10 @@
          block =&gt; block % next
       end do
 
-   end subroutine sw_timestep
+   end subroutine land_ice_timestep
 
 
-   subroutine sw_rk4(domain, dt)
+   subroutine land_ice_rk4(domain, dt)
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! 
    ! Advance model state forward in time by the specified time step using 
    !   4th order Runge-Kutta
@@ -138,9 +138,9 @@
 
         block =&gt; domain % blocklist
         do while (associated(block))
-           call sw_compute_tend(block % tend, provis, block % mesh)
-           call sw_compute_scalar_tend(block % tend, provis, block % mesh)
-           call sw_enforce_boundary_edge(block % tend, block % mesh)
+           call land_ice_compute_tend(block % tend, provis, block % mesh)
+           call land_ice_compute_scalar_tend(block % tend, provis, block % mesh)
+           call land_ice_enforce_boundary_edge(block % tend, block % mesh)
            block =&gt; block % next
         end do
 
@@ -181,7 +181,7 @@
               if (config_test_case == 1) then    ! For case 1, wind field should be fixed
                  provis % u % array(:,:) = block % state % time_levs(1) % state % u % array(:,:)
               end if
-              call sw_compute_solve_diagnostics(dt, provis, block % mesh)
+              call land_ice_compute_solve_diagnostics(dt, provis, block % mesh)
               block =&gt; block % next
            end do
         end if
@@ -227,7 +227,7 @@
             block % state % time_levs(2) % state % u % array(:,:) = block % state % time_levs(1) % state % u % array(:,:)
          end if
 
-         call sw_compute_solve_diagnostics(dt, block % state % time_levs(2) % state, block % mesh)
+         call land_ice_compute_solve_diagnostics(dt, block % state % time_levs(2) % state, block % mesh)
 
          call mpas_reconstruct(block % mesh, block % state % time_levs(2) % state % u % array,          &amp;
                           block % state % time_levs(2) % state % uReconstructX % array,            &amp;
@@ -242,10 +242,10 @@
 
       call mpas_deallocate_state(provis)
 
-   end subroutine sw_rk4
+   end subroutine land_ice_rk4
 
 
-   subroutine sw_compute_tend(tend, s, grid)
+   subroutine land_ice_compute_tend(tend, s, grid)
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! 
    ! Compute height and normal wind tendencies, as well as diagnostic variables
    !
@@ -535,10 +535,10 @@
          end do
      endif
  
-   end subroutine sw_compute_tend
+   end subroutine land_ice_compute_tend
 
 
-   subroutine sw_compute_scalar_tend(tend, s, grid)
+   subroutine land_ice_compute_scalar_tend(tend, s, grid)
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! 
    !
    ! Input: s - current model state
@@ -814,10 +814,10 @@
 
       end if
 
-   end subroutine sw_compute_scalar_tend
+   end subroutine land_ice_compute_scalar_tend
 
 
-   subroutine sw_compute_solve_diagnostics(dt, s, grid)
+   subroutine land_ice_compute_solve_diagnostics(dt, s, grid)
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! 
    ! Compute diagnostic fields used in the tendency computations
    !
@@ -1238,10 +1238,10 @@
    !  endif
 
 
-   end subroutine sw_compute_solve_diagnostics
+   end subroutine land_ice_compute_solve_diagnostics
 
 
-   subroutine sw_enforce_boundary_edge(tend, grid)
+   subroutine land_ice_enforce_boundary_edge(tend, grid)
    !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
    ! Enforce any boundary conditions on the normal velocity at each edge
    !
@@ -1281,7 +1281,7 @@
         enddo
        enddo
 
-   end subroutine sw_enforce_boundary_edge
+   end subroutine land_ice_enforce_boundary_edge
 
 
-end module sw_time_integration
+end module land_ice_time_integration

</font>
</pre>