MOM6
mom_dynamics_unsplit_rk2 Module Reference

Detailed Description

Time steps the ocean dynamics with an unsplit quasi 2nd order Runge-Kutta scheme.

Data Types

type  mom_dyn_unsplit_rk2_cs
 MOM_dynamics_unsplit_RK2 module control structure. More...
 
integer id_clock_cor
 CPU time clock IDs. More...
 
integer id_clock_pres
 CPU time clock IDs. More...
 
integer id_clock_vertvisc
 CPU time clock IDs. More...
 
integer id_clock_horvisc
 CPU time clock IDs. More...
 
integer id_clock_continuity
 CPU time clock IDs. More...
 
integer id_clock_mom_update
 CPU time clock IDs. More...
 
integer id_clock_pass
 CPU time clock IDs. More...
 
integer id_clock_pass_init
 CPU time clock IDs. More...
 
subroutine, public step_mom_dyn_unsplit_rk2 (u_in, v_in, h_in, tv, visc, Time_local, dt, forces, p_surf_begin, p_surf_end, uh, vh, uhtr, vhtr, eta_av, G, GV, US, CS, VarMix, MEKE)
 Step the MOM6 dynamics using an unsplit quasi-2nd order Runge-Kutta scheme. More...
 
subroutine, public register_restarts_dyn_unsplit_rk2 (HI, GV, param_file, CS, restart_CS)
 Allocate the control structure for this module, allocates memory in it, and registers any auxiliary restart variables that are specific to the unsplit RK2 time stepping scheme. More...
 
subroutine, public initialize_dyn_unsplit_rk2 (u, v, h, Time, G, GV, US, param_file, diag, CS, restart_CS, Accel_diag, Cont_diag, MIS, MEKE, OBC, update_OBC_CSp, ALE_CSp, setVisc_CSp, visc, dirs, ntrunc)
 Initialize parameters and allocate memory associated with the unsplit RK2 dynamics module. More...
 
subroutine, public end_dyn_unsplit_rk2 (CS)
 Clean up and deallocate memory associated with the dyn_unsplit_RK2 module. More...
 

Function/Subroutine Documentation

◆ end_dyn_unsplit_rk2()

subroutine, public mom_dynamics_unsplit_rk2::end_dyn_unsplit_rk2 ( type(mom_dyn_unsplit_rk2_cs), pointer  CS)

Clean up and deallocate memory associated with the dyn_unsplit_RK2 module.

Parameters
csdyn_unsplit_RK2 control structure that will be deallocated in this subroutine.

Definition at line 657 of file MOM_dynamics_unsplit_RK2.F90.

657  type(MOM_dyn_unsplit_RK2_CS), pointer :: CS !< dyn_unsplit_RK2 control structure that
658  !! will be deallocated in this subroutine.
659 
660  dealloc_(cs%diffu) ; dealloc_(cs%diffv)
661  dealloc_(cs%CAu) ; dealloc_(cs%CAv)
662  dealloc_(cs%PFu) ; dealloc_(cs%PFv)
663 
664  deallocate(cs)

◆ initialize_dyn_unsplit_rk2()

subroutine, public mom_dynamics_unsplit_rk2::initialize_dyn_unsplit_rk2 ( real, dimension( g %isdb: g %iedb, g %jsd: g %jed, g %ke), intent(inout)  u,
real, dimension( g %isd: g %ied, g %jsdb: g %jedb, g %ke), intent(inout)  v,
real, dimension( g %isd: g %ied, g %jsd: g %jed, g %ke), intent(inout)  h,
type(time_type), intent(in), target  Time,
type(ocean_grid_type), intent(inout)  G,
type(verticalgrid_type), intent(in)  GV,
type(unit_scale_type), intent(in)  US,
type(param_file_type), intent(in)  param_file,
type(diag_ctrl), intent(inout), target  diag,
type(mom_dyn_unsplit_rk2_cs), pointer  CS,
type(mom_restart_cs), pointer  restart_CS,
type(accel_diag_ptrs), intent(inout), target  Accel_diag,
type(cont_diag_ptrs), intent(inout), target  Cont_diag,
type(ocean_internal_state), intent(inout)  MIS,
type(meke_type), pointer  MEKE,
type(ocean_obc_type), pointer  OBC,
type(update_obc_cs), pointer  update_OBC_CSp,
type(ale_cs), pointer  ALE_CSp,
type(set_visc_cs), pointer  setVisc_CSp,
type(vertvisc_type), intent(inout)  visc,
type(directories), intent(in)  dirs,
integer, intent(inout), target  ntrunc 
)

Initialize parameters and allocate memory associated with the unsplit RK2 dynamics module.

Parameters
[in,out]gThe ocean's grid structure.
[in]gvThe ocean's vertical grid structure.
[in]usA dimensional unit scaling type
[in,out]uThe zonal velocity [L T-1 ~> m s-1].
[in,out]vThe meridional velocity [L T-1 ~> m s-1].
[in,out]hLayer thicknesses [H ~> m or kg m-2]
[in]timeThe current model time.
[in]param_fileA structure to parse for run-time parameters.
[in,out]diagA structure that is used to regulate diagnostic output.
csThe control structure set up by initialize_dyn_unsplit_RK2.
restart_csA pointer to the restart control structure.
[in,out]accel_diagA set of pointers to the various accelerations in the momentum equations, which can be used for later derived diagnostics, like energy budgets.
[in,out]cont_diagA structure with pointers to various terms in the continuity equations.
[in,out]misThe "MOM6 Internal State" structure, used to pass around pointers to various arrays for diagnostic purposes.
mekeMEKE data
obcIf open boundary conditions are used, this points to the ocean_OBC_type that was set up in MOM_initialization.
update_obc_cspIf open boundary condition updates are used, this points to the appropriate control structure.
ale_cspThis points to the ALE control structure.
setvisc_cspThis points to the set_visc control structure.
[in,out]viscA structure containing vertical viscosities, bottom drag viscosities, and related fields.
[in]dirsA structure containing several relevant directory paths.
[in,out]ntruncA target for the variable that records the number of times the velocity is truncated (this should be 0).

Definition at line 510 of file MOM_dynamics_unsplit_RK2.F90.

510  type(ocean_grid_type), intent(inout) :: G !< The ocean's grid structure.
511  type(verticalGrid_type), intent(in) :: GV !< The ocean's vertical grid structure.
512  type(unit_scale_type), intent(in) :: US !< A dimensional unit scaling type
513  real, dimension(SZIB_(G),SZJ_(G),SZK_(G)), intent(inout) :: u !< The zonal velocity [L T-1 ~> m s-1].
514  real, dimension(SZI_(G),SZJB_(G),SZK_(G)), intent(inout) :: v !< The meridional velocity [L T-1 ~> m s-1].
515  real, dimension(SZI_(G),SZJ_(G),SZK_(G)) , intent(inout) :: h !< Layer thicknesses [H ~> m or kg m-2]
516  type(time_type), target, intent(in) :: Time !< The current model time.
517  type(param_file_type), intent(in) :: param_file !< A structure to parse
518  !! for run-time parameters.
519  type(diag_ctrl), target, intent(inout) :: diag !< A structure that is used to
520  !! regulate diagnostic output.
521  type(MOM_dyn_unsplit_RK2_CS), pointer :: CS !< The control structure set up
522  !! by initialize_dyn_unsplit_RK2.
523  type(MOM_restart_CS), pointer :: restart_CS !< A pointer to the restart
524  !! control structure.
525  type(accel_diag_ptrs), target, intent(inout) :: Accel_diag !< A set of pointers to the
526  !! various accelerations in the momentum equations, which can
527  !! be used for later derived diagnostics, like energy budgets.
528  type(cont_diag_ptrs), target, intent(inout) :: Cont_diag !< A structure with pointers
529  !! to various terms in the
530  !! continuity equations.
531  type(ocean_internal_state), intent(inout) :: MIS !< The "MOM6 Internal State"
532  !! structure, used to pass around pointers
533  !! to various arrays for diagnostic purposes.
534  type(MEKE_type), pointer :: MEKE !< MEKE data
535  type(ocean_OBC_type), pointer :: OBC !< If open boundary conditions
536  !! are used, this points to the ocean_OBC_type
537  !! that was set up in MOM_initialization.
538  type(update_OBC_CS), pointer :: update_OBC_CSp !< If open boundary
539  !! condition updates are used, this points
540  !! to the appropriate control structure.
541  type(ALE_CS), pointer :: ALE_CSp !< This points to the ALE
542  !! control structure.
543  type(set_visc_CS), pointer :: setVisc_CSp !< This points to the
544  !! set_visc control
545  !! structure.
546  type(vertvisc_type), intent(inout) :: visc !< A structure containing
547  !! vertical viscosities, bottom drag
548  !! viscosities, and related fields.
549  type(directories), intent(in) :: dirs !< A structure containing several
550  !! relevant directory paths.
551  integer, target, intent(inout) :: ntrunc !< A target for the variable
552  !! that records the number of times the
553  !! velocity is truncated (this should be 0).
554 
555  ! This subroutine initializes all of the variables that are used by this
556  ! dynamic core, including diagnostics and the cpu clocks.
557 
558  ! Local varaibles
559  character(len=40) :: mdl = "MOM_dynamics_unsplit_RK2" ! This module's name.
560  character(len=48) :: thickness_units, flux_units
561  real :: H_convert
562  logical :: use_tides
563  integer :: isd, ied, jsd, jed, nz, IsdB, IedB, JsdB, JedB
564  isd = g%isd ; ied = g%ied ; jsd = g%jsd ; jed = g%jed ; nz = g%ke
565  isdb = g%IsdB ; iedb = g%IedB ; jsdb = g%JsdB ; jedb = g%JedB
566 
567  if (.not.associated(cs)) call mom_error(fatal, &
568  "initialize_dyn_unsplit_RK2 called with an unassociated control structure.")
569  if (cs%module_is_initialized) then
570  call mom_error(warning, "initialize_dyn_unsplit_RK2 called with a control "// &
571  "structure that has already been initialized.")
572  return
573  endif
574  cs%module_is_initialized = .true.
575 
576  cs%diag => diag
577 
578  call get_param(param_file, mdl, "BE", cs%be, &
579  "If SPLIT is true, BE determines the relative weighting "//&
580  "of a 2nd-order Runga-Kutta baroclinic time stepping "//&
581  "scheme (0.5) and a backward Euler scheme (1) that is "//&
582  "used for the Coriolis and inertial terms. BE may be "//&
583  "from 0.5 to 1, but instability may occur near 0.5. "//&
584  "BE is also applicable if SPLIT is false and USE_RK2 "//&
585  "is true.", units="nondim", default=0.6)
586  call get_param(param_file, mdl, "BEGW", cs%begw, &
587  "If SPLIT is true, BEGW is a number from 0 to 1 that "//&
588  "controls the extent to which the treatment of gravity "//&
589  "waves is forward-backward (0) or simulated backward "//&
590  "Euler (1). 0 is almost always used. "//&
591  "If SPLIT is false and USE_RK2 is true, BEGW can be "//&
592  "between 0 and 0.5 to damp gravity waves.", &
593  units="nondim", default=0.0)
594  call get_param(param_file, mdl, "DEBUG", cs%debug, &
595  "If true, write out verbose debugging data.", &
596  default=.false., debuggingparam=.true.)
597  call get_param(param_file, mdl, "TIDES", use_tides, &
598  "If true, apply tidal momentum forcing.", default=.false.)
599 
600  allocate(cs%taux_bot(isdb:iedb,jsd:jed)) ; cs%taux_bot(:,:) = 0.0
601  allocate(cs%tauy_bot(isd:ied,jsdb:jedb)) ; cs%tauy_bot(:,:) = 0.0
602 
603  mis%diffu => cs%diffu ; mis%diffv => cs%diffv
604  mis%PFu => cs%PFu ; mis%PFv => cs%PFv
605  mis%CAu => cs%CAu ; mis%CAv => cs%CAv
606 
607  cs%ADp => accel_diag ; cs%CDp => cont_diag
608  accel_diag%diffu => cs%diffu ; accel_diag%diffv => cs%diffv
609  accel_diag%PFu => cs%PFu ; accel_diag%PFv => cs%PFv
610  accel_diag%CAu => cs%CAu ; accel_diag%CAv => cs%CAv
611 
612  call continuity_init(time, g, gv, us, param_file, diag, cs%continuity_CSp)
613  call coriolisadv_init(time, g, gv, us, param_file, diag, cs%ADp, cs%CoriolisAdv_CSp)
614  if (use_tides) call tidal_forcing_init(time, g, param_file, cs%tides_CSp)
615  call pressureforce_init(time, g, gv, us, param_file, diag, cs%PressureForce_CSp, &
616  cs%tides_CSp)
617  call hor_visc_init(time, g, us, param_file, diag, cs%hor_visc_CSp, meke)
618  call vertvisc_init(mis, time, g, gv, us, param_file, diag, cs%ADp, dirs, &
619  ntrunc, cs%vertvisc_CSp)
620  if (.not.associated(setvisc_csp)) call mom_error(fatal, &
621  "initialize_dyn_unsplit_RK2 called with setVisc_CSp unassociated.")
622  cs%set_visc_CSp => setvisc_csp
623 
624  if (associated(ale_csp)) cs%ALE_CSp => ale_csp
625  if (associated(obc)) cs%OBC => obc
626 
627  flux_units = get_flux_units(gv)
628  h_convert = gv%H_to_m ; if (.not.gv%Boussinesq) h_convert = gv%H_to_kg_m2
629  cs%id_uh = register_diag_field('ocean_model', 'uh', diag%axesCuL, time, &
630  'Zonal Thickness Flux', flux_units, y_cell_method='sum', v_extensive=.true., &
631  conversion=h_convert*us%L_to_m**2*us%s_to_T)
632  cs%id_vh = register_diag_field('ocean_model', 'vh', diag%axesCvL, time, &
633  'Meridional Thickness Flux', flux_units, x_cell_method='sum', v_extensive=.true., &
634  conversion=h_convert*us%L_to_m**2*us%s_to_T)
635  cs%id_CAu = register_diag_field('ocean_model', 'CAu', diag%axesCuL, time, &
636  'Zonal Coriolis and Advective Acceleration', 'meter second-2', conversion=us%L_T2_to_m_s2)
637  cs%id_CAv = register_diag_field('ocean_model', 'CAv', diag%axesCvL, time, &
638  'Meridional Coriolis and Advective Acceleration', 'meter second-2', conversion=us%L_T2_to_m_s2)
639  cs%id_PFu = register_diag_field('ocean_model', 'PFu', diag%axesCuL, time, &
640  'Zonal Pressure Force Acceleration', 'meter second-2', conversion=us%L_T2_to_m_s2)
641  cs%id_PFv = register_diag_field('ocean_model', 'PFv', diag%axesCvL, time, &
642  'Meridional Pressure Force Acceleration', 'meter second-2', conversion=us%L_T2_to_m_s2)
643 
644  id_clock_cor = cpu_clock_id('(Ocean Coriolis & mom advection)', grain=clock_module)
645  id_clock_continuity = cpu_clock_id('(Ocean continuity equation)', grain=clock_module)
646  id_clock_pres = cpu_clock_id('(Ocean pressure force)', grain=clock_module)
647  id_clock_vertvisc = cpu_clock_id('(Ocean vertical viscosity)', grain=clock_module)
648  id_clock_horvisc = cpu_clock_id('(Ocean horizontal viscosity)', grain=clock_module)
649  id_clock_mom_update = cpu_clock_id('(Ocean momentum increments)', grain=clock_module)
650  id_clock_pass = cpu_clock_id('(Ocean message passing)', grain=clock_module)
651  id_clock_pass_init = cpu_clock_id('(Ocean init message passing)', grain=clock_routine)
652 

References mom_continuity::continuity_init(), mom_coriolisadv::coriolisadv_init(), mom_verticalgrid::get_flux_units(), mom_hor_visc::hor_visc_init(), id_clock_continuity, id_clock_cor, id_clock_horvisc, id_clock_mom_update, id_clock_pass, id_clock_pass_init, id_clock_pres, id_clock_vertvisc, mom_pressureforce::pressureforce_init(), mom_tidal_forcing::tidal_forcing_init(), and mom_vert_friction::vertvisc_init().

Here is the call graph for this function:

◆ register_restarts_dyn_unsplit_rk2()

subroutine, public mom_dynamics_unsplit_rk2::register_restarts_dyn_unsplit_rk2 ( type(hor_index_type), intent(in)  HI,
type(verticalgrid_type), intent(in)  GV,
type(param_file_type), intent(in)  param_file,
type(mom_dyn_unsplit_rk2_cs), pointer  CS,
type(mom_restart_cs), pointer  restart_CS 
)

Allocate the control structure for this module, allocates memory in it, and registers any auxiliary restart variables that are specific to the unsplit RK2 time stepping scheme.

All variables registered here should have the ability to be recreated if they are not present in a restart file.

Parameters
[in]hiA horizontal index type structure.
[in]gvThe ocean's vertical grid structure.
[in]param_fileA structure to parse for run-time parameters.
csThe control structure set up by initialize_dyn_unsplit_RK2.
restart_csA pointer to the restart control structure.

Definition at line 465 of file MOM_dynamics_unsplit_RK2.F90.

465  type(hor_index_type), intent(in) :: HI !< A horizontal index type structure.
466  type(verticalGrid_type), intent(in) :: GV !< The ocean's vertical grid structure.
467  type(param_file_type), intent(in) :: param_file !< A structure to parse for run-time
468  !! parameters.
469  type(MOM_dyn_unsplit_RK2_CS), pointer :: CS !< The control structure set up by
470  !! initialize_dyn_unsplit_RK2.
471  type(MOM_restart_CS), pointer :: restart_CS !< A pointer to the restart control
472  !! structure.
473 ! This subroutine sets up any auxiliary restart variables that are specific
474 ! to the unsplit time stepping scheme. All variables registered here should
475 ! have the ability to be recreated if they are not present in a restart file.
476 
477  ! Local variables
478  character(len=48) :: thickness_units, flux_units
479  integer :: isd, ied, jsd, jed, nz, IsdB, IedB, JsdB, JedB
480  isd = hi%isd ; ied = hi%ied ; jsd = hi%jsd ; jed = hi%jed ; nz = gv%ke
481  isdb = hi%IsdB ; iedb = hi%IedB ; jsdb = hi%JsdB ; jedb = hi%JedB
482 
483 ! This is where a control structure that is specific to this module would be allocated.
484  if (associated(cs)) then
485  call mom_error(warning, "register_restarts_dyn_unsplit_RK2 called with an associated "// &
486  "control structure.")
487  return
488  endif
489  allocate(cs)
490 
491  alloc_(cs%diffu(isdb:iedb,jsd:jed,nz)) ; cs%diffu(:,:,:) = 0.0
492  alloc_(cs%diffv(isd:ied,jsdb:jedb,nz)) ; cs%diffv(:,:,:) = 0.0
493  alloc_(cs%CAu(isdb:iedb,jsd:jed,nz)) ; cs%CAu(:,:,:) = 0.0
494  alloc_(cs%CAv(isd:ied,jsdb:jedb,nz)) ; cs%CAv(:,:,:) = 0.0
495  alloc_(cs%PFu(isdb:iedb,jsd:jed,nz)) ; cs%PFu(:,:,:) = 0.0
496  alloc_(cs%PFv(isd:ied,jsdb:jedb,nz)) ; cs%PFv(:,:,:) = 0.0
497 
498  thickness_units = get_thickness_units(gv)
499  flux_units = get_flux_units(gv)
500 
501 ! No extra restart fields are needed with this time stepping scheme.
502 

References mom_verticalgrid::get_flux_units().

Here is the call graph for this function:

◆ step_mom_dyn_unsplit_rk2()

subroutine, public mom_dynamics_unsplit_rk2::step_mom_dyn_unsplit_rk2 ( real, dimension(szib_(g),szj_(g),szk_(g)), intent(inout)  u_in,
real, dimension(szi_(g),szjb_(g),szk_(g)), intent(inout)  v_in,
real, dimension(szi_(g),szj_(g),szk_(g)), intent(inout)  h_in,
type(thermo_var_ptrs), intent(in)  tv,
type(vertvisc_type), intent(inout)  visc,
type(time_type), intent(in)  Time_local,
real, intent(in)  dt,
type(mech_forcing), intent(in)  forces,
real, dimension(:,:), pointer  p_surf_begin,
real, dimension(:,:), pointer  p_surf_end,
real, dimension(szib_(g),szj_(g),szk_(g)), intent(inout)  uh,
real, dimension(szi_(g),szjb_(g),szk_(g)), intent(inout)  vh,
real, dimension(szib_(g),szj_(g),szk_(g)), intent(inout)  uhtr,
real, dimension(szi_(g),szjb_(g),szk_(g)), intent(inout)  vhtr,
real, dimension(szi_(g),szj_(g)), intent(out)  eta_av,
type(ocean_grid_type), intent(inout)  G,
type(verticalgrid_type), intent(in)  GV,
type(unit_scale_type), intent(in)  US,
type(mom_dyn_unsplit_rk2_cs), pointer  CS,
type(varmix_cs), pointer  VarMix,
type(meke_type), pointer  MEKE 
)

Step the MOM6 dynamics using an unsplit quasi-2nd order Runge-Kutta scheme.

Parameters
[in,out]gThe ocean's grid structure.
[in]gvThe ocean's vertical grid structure.
[in]usA dimensional unit scaling type
[in,out]u_inThe input and output zonal velocity [L T-1 ~> m s-1].
[in,out]v_inThe input and output meridional velocity [L T-1 ~> m s-1].
[in,out]h_inThe input and output layer thicknesses, [H ~> m or kg m-2], depending on whether the Boussinesq approximation is made.
[in]tvA structure pointing to various thermodynamic variables.
[in,out]viscA structure containing vertical viscosities, bottom drag viscosities, and related fields.
[in]time_localThe model time at the end of the time step.
[in]dtThe baroclinic dynamics time step [T ~> s].
[in]forcesA structure with the driving mechanical forces
p_surf_beginA pointer (perhaps NULL) to the surface pressure at the beginning of this dynamic step [Pa].
p_surf_endA pointer (perhaps NULL) to the surface pressure at the end of this dynamic step [Pa].
[in,out]uhThe zonal volume or mass transport [H L2 T-1 ~> m3 s-1 or kg s-1].
[in,out]vhThe meridional volume or mass transport [H L2 T-1 ~> m3 s-1 or kg s-1].
[in,out]uhtrThe accumulated zonal volume or mass transport since the last tracer advection [H L2 ~> m3 or kg].
[in,out]vhtrThe accumulated meridional volume or mass transport since the last tracer advection [H L2 ~> m3 or kg].
[out]eta_avThe time-mean free surface height or column mass [H ~> m or kg m-2].
csThe control structure set up by initialize_dyn_unsplit_RK2.
varmixA pointer to a structure with fields that specify the spatially variable viscosities.
mekeA pointer to a structure containing fields related to the Mesoscale Eddy Kinetic Energy.

Definition at line 191 of file MOM_dynamics_unsplit_RK2.F90.

191  type(ocean_grid_type), intent(inout) :: G !< The ocean's grid structure.
192  type(verticalGrid_type), intent(in) :: GV !< The ocean's vertical grid structure.
193  type(unit_scale_type), intent(in) :: US !< A dimensional unit scaling type
194  real, dimension(SZIB_(G),SZJ_(G),SZK_(G)), intent(inout) :: u_in !< The input and output zonal
195  !! velocity [L T-1 ~> m s-1].
196  real, dimension(SZI_(G),SZJB_(G),SZK_(G)), intent(inout) :: v_in !< The input and output meridional
197  !! velocity [L T-1 ~> m s-1].
198  real, dimension(SZI_(G),SZJ_(G),SZK_(G)), intent(inout) :: h_in !< The input and output layer thicknesses,
199  !! [H ~> m or kg m-2], depending on whether
200  !! the Boussinesq approximation is made.
201  type(thermo_var_ptrs), intent(in) :: tv !< A structure pointing to various
202  !! thermodynamic variables.
203  type(vertvisc_type), intent(inout) :: visc !< A structure containing vertical
204  !! viscosities, bottom drag
205  !! viscosities, and related fields.
206  type(time_type), intent(in) :: Time_local !< The model time at the end of
207  !! the time step.
208  real, intent(in) :: dt !< The baroclinic dynamics time step [T ~> s].
209  type(mech_forcing), intent(in) :: forces !< A structure with the driving mechanical forces
210  real, dimension(:,:), pointer :: p_surf_begin !< A pointer (perhaps NULL) to
211  !! the surface pressure at the beginning
212  !! of this dynamic step [Pa].
213  real, dimension(:,:), pointer :: p_surf_end !< A pointer (perhaps NULL) to
214  !! the surface pressure at the end of
215  !! this dynamic step [Pa].
216  real, dimension(SZIB_(G),SZJ_(G),SZK_(G)), intent(inout) :: uh !< The zonal volume or mass transport
217  !! [H L2 T-1 ~> m3 s-1 or kg s-1].
218  real, dimension(SZI_(G),SZJB_(G),SZK_(G)), intent(inout) :: vh !< The meridional volume or mass
219  !! transport [H L2 T-1 ~> m3 s-1 or kg s-1].
220  real, dimension(SZIB_(G),SZJ_(G),SZK_(G)), intent(inout) :: uhtr !< The accumulated zonal volume or
221  !! mass transport since the last
222  !! tracer advection [H L2 ~> m3 or kg].
223  real, dimension(SZI_(G),SZJB_(G),SZK_(G)), intent(inout) :: vhtr !< The accumulated meridional volume
224  !! or mass transport since the last
225  !! tracer advection [H L2 ~> m3 or kg].
226  real, dimension(SZI_(G),SZJ_(G)), intent(out) :: eta_av !< The time-mean free surface height
227  !! or column mass [H ~> m or kg m-2].
228  type(MOM_dyn_unsplit_RK2_CS), pointer :: CS !< The control structure set up by
229  !! initialize_dyn_unsplit_RK2.
230  type(VarMix_CS), pointer :: VarMix !< A pointer to a structure with
231  !! fields that specify the spatially
232  !! variable viscosities.
233  type(MEKE_type), pointer :: MEKE !< A pointer to a structure containing
234  !! fields related to the Mesoscale
235  !! Eddy Kinetic Energy.
236  ! Local variables
237  real, dimension(SZI_(G),SZJ_(G),SZK_(G)) :: h_av, hp
238  real, dimension(SZIB_(G),SZJ_(G),SZK_(G)) :: up ! Predicted zonal velocities [L T-1 ~> m s-1]
239  real, dimension(SZI_(G),SZJB_(G),SZK_(G)) :: vp ! Predicted meridional velocities [L T-1 ~> m s-1]
240  real, dimension(:,:), pointer :: p_surf => null()
241  real :: dt_pred ! The time step for the predictor part of the baroclinic
242  ! time stepping [T ~> s].
243  logical :: dyn_p_surf
244  integer :: i, j, k, is, ie, js, je, Isq, Ieq, Jsq, Jeq, nz
245  is = g%isc ; ie = g%iec ; js = g%jsc ; je = g%jec ; nz = g%ke
246  isq = g%IscB ; ieq = g%IecB ; jsq = g%JscB ; jeq = g%JecB
247  dt_pred = dt * cs%BE
248 
249  h_av(:,:,:) = 0; hp(:,:,:) = 0
250  up(:,:,:) = 0
251  vp(:,:,:) = 0
252 
253  dyn_p_surf = associated(p_surf_begin) .and. associated(p_surf_end)
254  if (dyn_p_surf) then
255  call safe_alloc_ptr(p_surf,g%isd,g%ied,g%jsd,g%jed) ; p_surf(:,:) = 0.0
256  else
257  p_surf => forces%p_surf
258  endif
259 
260 ! Runge-Kutta second order accurate two step scheme is used to step
261 ! all of the fields except h. h is stepped separately.
262 
263  if (cs%debug) then
264  call mom_state_chksum("Start Predictor ", u_in, v_in, h_in, uh, vh, g, gv, us)
265  endif
266 
267 ! diffu = horizontal viscosity terms (u,h)
268  call enable_averages(dt,time_local, cs%diag)
269  call cpu_clock_begin(id_clock_horvisc)
270  call horizontal_viscosity(u_in, v_in, h_in, cs%diffu, cs%diffv, meke, varmix, &
271  g, gv, us, cs%hor_visc_CSp)
272  call cpu_clock_end(id_clock_horvisc)
273  call disable_averaging(cs%diag)
274  call pass_vector(cs%diffu, cs%diffv, g%Domain, clock=id_clock_pass)
275 
276 ! This continuity step is solely for the Coroilis terms, specifically in the
277 ! denominator of PV and in the mass transport or PV.
278 ! uh = u[n-1]*h[n-1/2]
279 ! hp = h[n-1/2] + dt/2 div . uh
280  call cpu_clock_begin(id_clock_continuity)
281  ! This is a duplicate calculation of the last continuity from the previous step
282  ! and could/should be optimized out. -AJA
283  call continuity(u_in, v_in, h_in, hp, uh, vh, dt_pred, g, gv, us, &
284  cs%continuity_CSp, obc=cs%OBC)
285  call cpu_clock_end(id_clock_continuity)
286  call pass_var(hp, g%Domain, clock=id_clock_pass)
287  call pass_vector(uh, vh, g%Domain, clock=id_clock_pass)
288 
289 ! h_av = (h + hp)/2 (used in PV denominator)
290  call cpu_clock_begin(id_clock_mom_update)
291  do k=1,nz
292  do j=js-2,je+2 ; do i=is-2,ie+2
293  h_av(i,j,k) = (h_in(i,j,k) + hp(i,j,k)) * 0.5
294  enddo ; enddo ; enddo
295  call cpu_clock_end(id_clock_mom_update)
296 
297 ! CAu = -(f+zeta)/h_av vh + d/dx KE (function of u[n-1] and uh[n-1])
298  call cpu_clock_begin(id_clock_cor)
299  call coradcalc(u_in, v_in, h_av, uh, vh, cs%CAu, cs%CAv, cs%OBC, cs%ADp, &
300  g, gv, us, cs%CoriolisAdv_CSp)
301  call cpu_clock_end(id_clock_cor)
302 
303 ! PFu = d/dx M(h_av,T,S) (function of h[n-1/2])
304  call cpu_clock_begin(id_clock_pres)
305  if (dyn_p_surf) then ; do j=js-2,je+2 ; do i=is-2,ie+2
306  p_surf(i,j) = 0.5*p_surf_begin(i,j) + 0.5*p_surf_end(i,j)
307  enddo ; enddo ; endif
308  call pressureforce(h_in, tv, cs%PFu, cs%PFv, g, gv, us, &
309  cs%PressureForce_CSp, cs%ALE_CSp, p_surf)
310  call cpu_clock_end(id_clock_pres)
311  call pass_vector(cs%PFu, cs%PFv, g%Domain, clock=id_clock_pass)
312  call pass_vector(cs%CAu, cs%CAv, g%Domain, clock=id_clock_pass)
313 
314  if (associated(cs%OBC)) then; if (cs%OBC%update_OBC) then
315  call update_obc_data(cs%OBC, g, gv, us, tv, h_in, cs%update_OBC_CSp, time_local)
316  endif; endif
317  if (associated(cs%OBC)) then
318  call open_boundary_zero_normal_flow(cs%OBC, g, cs%PFu, cs%PFv)
319  call open_boundary_zero_normal_flow(cs%OBC, g, cs%CAu, cs%CAv)
320  call open_boundary_zero_normal_flow(cs%OBC, g, cs%diffu, cs%diffv)
321  endif
322 
323 ! up+[n-1/2] = u[n-1] + dt_pred * (PFu + CAu)
324  call cpu_clock_begin(id_clock_mom_update)
325  do k=1,nz ; do j=js,je ; do i=isq,ieq
326  up(i,j,k) = g%mask2dCu(i,j) * (u_in(i,j,k) + dt_pred * &
327  ((cs%PFu(i,j,k) + cs%CAu(i,j,k)) + cs%diffu(i,j,k)))
328  enddo ; enddo ; enddo
329  do k=1,nz ; do j=jsq,jeq ; do i=is,ie
330  vp(i,j,k) = g%mask2dCv(i,j) * (v_in(i,j,k) + dt_pred * &
331  ((cs%PFv(i,j,k) + cs%CAv(i,j,k)) + cs%diffv(i,j,k)))
332  enddo ; enddo ; enddo
333  call cpu_clock_end(id_clock_mom_update)
334 
335  if (cs%debug) &
336  call mom_accel_chksum("Predictor 1 accel", cs%CAu, cs%CAv, cs%PFu, cs%PFv,&
337  cs%diffu, cs%diffv, g, gv, us)
338 
339  ! up[n-1/2] <- up*[n-1/2] + dt/2 d/dz visc d/dz up[n-1/2]
340  call cpu_clock_begin(id_clock_vertvisc)
341  call enable_averages(dt, time_local, cs%diag)
342  call set_viscous_ml(up, vp, h_av, tv, forces, visc, dt_pred, g, gv, us, &
343  cs%set_visc_CSp)
344  call disable_averaging(cs%diag)
345  call vertvisc_coef(up, vp, h_av, forces, visc, dt_pred, g, gv, us, &
346  cs%vertvisc_CSp, cs%OBC)
347  call vertvisc(up, vp, h_av, forces, visc, dt_pred, cs%OBC, cs%ADp, cs%CDp, &
348  g, gv, us, cs%vertvisc_CSp)
349  call cpu_clock_end(id_clock_vertvisc)
350  call pass_vector(up, vp, g%Domain, clock=id_clock_pass)
351 
352 ! uh = up[n-1/2] * h[n-1/2]
353 ! h_av = h + dt div . uh
354  call cpu_clock_begin(id_clock_continuity)
355  call continuity(up, vp, h_in, hp, uh, vh, dt, g, gv, us, cs%continuity_CSp, obc=cs%OBC)
356  call cpu_clock_end(id_clock_continuity)
357  call pass_var(hp, g%Domain, clock=id_clock_pass)
358  call pass_vector(uh, vh, g%Domain, clock=id_clock_pass)
359 
360 ! h_av <- (h + hp)/2 (centered at n-1/2)
361  do k=1,nz ; do j=js-2,je+2 ; do i=is-2,ie+2
362  h_av(i,j,k) = (h_in(i,j,k) + hp(i,j,k)) * 0.5
363  enddo ; enddo ; enddo
364 
365  if (cs%debug) &
366  call mom_state_chksum("Predictor 1", up, vp, h_av, uh, vh, g, gv, us)
367 
368 ! CAu = -(f+zeta(up))/h_av vh + d/dx KE(up) (function of up[n-1/2], h[n-1/2])
369  call cpu_clock_begin(id_clock_cor)
370  call coradcalc(up, vp, h_av, uh, vh, cs%CAu, cs%CAv, cs%OBC, cs%ADp, &
371  g, gv, us, cs%CoriolisAdv_CSp)
372  call cpu_clock_end(id_clock_cor)
373  if (associated(cs%OBC)) then
374  call open_boundary_zero_normal_flow(cs%OBC, g, cs%CAu, cs%CAv)
375  endif
376 
377 ! call enable_averages(dt, Time_local, CS%diag) ?????????????????????/
378 
379 ! up* = u[n] + (1+gamma) * dt * ( PFu + CAu ) Extrapolated for damping
380 ! u*[n+1] = u[n] + dt * ( PFu + CAu )
381  do k=1,nz ; do j=js,je ; do i=isq,ieq
382  up(i,j,k) = g%mask2dCu(i,j) * (u_in(i,j,k) + dt * (1.+cs%begw) * &
383  ((cs%PFu(i,j,k) + cs%CAu(i,j,k)) + cs%diffu(i,j,k)))
384  u_in(i,j,k) = g%mask2dCu(i,j) * (u_in(i,j,k) + dt * &
385  ((cs%PFu(i,j,k) + cs%CAu(i,j,k)) + cs%diffu(i,j,k)))
386  enddo ; enddo ; enddo
387  do k=1,nz ; do j=jsq,jeq ; do i=is,ie
388  vp(i,j,k) = g%mask2dCv(i,j) * (v_in(i,j,k) + dt * (1.+cs%begw) * &
389  ((cs%PFv(i,j,k) + cs%CAv(i,j,k)) + cs%diffv(i,j,k)))
390  v_in(i,j,k) = g%mask2dCv(i,j) * (v_in(i,j,k) + dt * &
391  ((cs%PFv(i,j,k) + cs%CAv(i,j,k)) + cs%diffv(i,j,k)))
392  enddo ; enddo ; enddo
393 
394 ! up[n] <- up* + dt d/dz visc d/dz up
395 ! u[n] <- u*[n] + dt d/dz visc d/dz u[n]
396  call cpu_clock_begin(id_clock_vertvisc)
397  call vertvisc_coef(up, vp, h_av, forces, visc, dt, g, gv, us, &
398  cs%vertvisc_CSp, cs%OBC)
399  call vertvisc(up, vp, h_av, forces, visc, dt, cs%OBC, cs%ADp, cs%CDp, &
400  g, gv, us, cs%vertvisc_CSp, cs%taux_bot, cs%tauy_bot)
401  call vertvisc_coef(u_in, v_in, h_av, forces, visc, dt, g, gv, us, &
402  cs%vertvisc_CSp, cs%OBC)
403  call vertvisc(u_in, v_in, h_av, forces, visc, dt, cs%OBC, cs%ADp, cs%CDp,&
404  g, gv, us, cs%vertvisc_CSp, cs%taux_bot, cs%tauy_bot)
405  call cpu_clock_end(id_clock_vertvisc)
406  call pass_vector(up, vp, g%Domain, clock=id_clock_pass)
407  call pass_vector(u_in, v_in, g%Domain, clock=id_clock_pass)
408 
409 ! uh = up[n] * h[n] (up[n] might be extrapolated to damp GWs)
410 ! h[n+1] = h[n] + dt div . uh
411  call cpu_clock_begin(id_clock_continuity)
412  call continuity(up, vp, h_in, h_in, uh, vh, dt, g, gv, us, cs%continuity_CSp, obc=cs%OBC)
413  call cpu_clock_end(id_clock_continuity)
414  call pass_var(h_in, g%Domain, clock=id_clock_pass)
415  call pass_vector(uh, vh, g%Domain, clock=id_clock_pass)
416 
417 ! Accumulate mass flux for tracer transport
418  do k=1,nz
419  do j=js-2,je+2 ; do i=isq-2,ieq+2
420  uhtr(i,j,k) = uhtr(i,j,k) + dt*uh(i,j,k)
421  enddo ; enddo
422  do j=jsq-2,jeq+2 ; do i=is-2,ie+2
423  vhtr(i,j,k) = vhtr(i,j,k) + dt*vh(i,j,k)
424  enddo ; enddo
425  enddo
426 
427  if (cs%debug) then
428  call mom_state_chksum("Corrector", u_in, v_in, h_in, uh, vh, g, gv, us)
429  call mom_accel_chksum("Corrector accel", cs%CAu, cs%CAv, cs%PFu, cs%PFv, &
430  cs%diffu, cs%diffv, g, gv, us)
431  endif
432 
433  if (gv%Boussinesq) then
434  do j=js,je ; do i=is,ie ; eta_av(i,j) = -gv%Z_to_H*g%bathyT(i,j) ; enddo ; enddo
435  else
436  do j=js,je ; do i=is,ie ; eta_av(i,j) = 0.0 ; enddo ; enddo
437  endif
438  do k=1,nz ; do j=js,je ; do i=is,ie
439  eta_av(i,j) = eta_av(i,j) + h_av(i,j,k)
440  enddo ; enddo ; enddo
441 
442  if (dyn_p_surf) deallocate(p_surf)
443 
444 ! Here various terms used in to update the momentum equations are
445 ! offered for averaging.
446  if (cs%id_PFu > 0) call post_data(cs%id_PFu, cs%PFu, cs%diag)
447  if (cs%id_PFv > 0) call post_data(cs%id_PFv, cs%PFv, cs%diag)
448  if (cs%id_CAu > 0) call post_data(cs%id_CAu, cs%CAu, cs%diag)
449  if (cs%id_CAv > 0) call post_data(cs%id_CAv, cs%CAv, cs%diag)
450 
451 ! Here the thickness fluxes are offered for averaging.
452  if (cs%id_uh > 0) call post_data(cs%id_uh, uh, cs%diag)
453  if (cs%id_vh > 0) call post_data(cs%id_vh, vh, cs%diag)
454 

References mom_continuity::continuity(), mom_coriolisadv::coradcalc(), mom_hor_visc::horizontal_viscosity(), id_clock_continuity, id_clock_cor, id_clock_horvisc, id_clock_mom_update, id_clock_pass, id_clock_pres, id_clock_vertvisc, mom_checksum_packages::mom_accel_chksum(), mom_open_boundary::open_boundary_zero_normal_flow(), mom_pressureforce::pressureforce(), mom_set_visc::set_viscous_ml(), mom_boundary_update::update_obc_data(), mom_vert_friction::vertvisc(), and mom_vert_friction::vertvisc_coef().

Here is the call graph for this function:

Variable Documentation

◆ id_clock_continuity

integer mom_dynamics_unsplit_rk2::id_clock_continuity
private

CPU time clock IDs.

Definition at line 179 of file MOM_dynamics_unsplit_RK2.F90.

Referenced by initialize_dyn_unsplit_rk2(), and step_mom_dyn_unsplit_rk2().

◆ id_clock_cor

integer mom_dynamics_unsplit_rk2::id_clock_cor

CPU time clock IDs.

Definition at line 178 of file MOM_dynamics_unsplit_RK2.F90.

178 integer :: id_clock_Cor, id_clock_pres, id_clock_vertvisc

Referenced by initialize_dyn_unsplit_rk2(), and step_mom_dyn_unsplit_rk2().

◆ id_clock_horvisc

integer mom_dynamics_unsplit_rk2::id_clock_horvisc
private

CPU time clock IDs.

Definition at line 179 of file MOM_dynamics_unsplit_RK2.F90.

179 integer :: id_clock_horvisc, id_clock_continuity, id_clock_mom_update

Referenced by initialize_dyn_unsplit_rk2(), and step_mom_dyn_unsplit_rk2().

◆ id_clock_mom_update

integer mom_dynamics_unsplit_rk2::id_clock_mom_update
private

CPU time clock IDs.

Definition at line 179 of file MOM_dynamics_unsplit_RK2.F90.

Referenced by initialize_dyn_unsplit_rk2(), and step_mom_dyn_unsplit_rk2().

◆ id_clock_pass

integer mom_dynamics_unsplit_rk2::id_clock_pass
private

CPU time clock IDs.

Definition at line 180 of file MOM_dynamics_unsplit_RK2.F90.

180 integer :: id_clock_pass, id_clock_pass_init

Referenced by initialize_dyn_unsplit_rk2(), and step_mom_dyn_unsplit_rk2().

◆ id_clock_pass_init

integer mom_dynamics_unsplit_rk2::id_clock_pass_init
private

CPU time clock IDs.

Definition at line 180 of file MOM_dynamics_unsplit_RK2.F90.

Referenced by initialize_dyn_unsplit_rk2().

◆ id_clock_pres

integer mom_dynamics_unsplit_rk2::id_clock_pres
private

CPU time clock IDs.

Definition at line 178 of file MOM_dynamics_unsplit_RK2.F90.

Referenced by initialize_dyn_unsplit_rk2(), and step_mom_dyn_unsplit_rk2().

◆ id_clock_vertvisc

integer mom_dynamics_unsplit_rk2::id_clock_vertvisc
private

CPU time clock IDs.

Definition at line 178 of file MOM_dynamics_unsplit_RK2.F90.

Referenced by initialize_dyn_unsplit_rk2(), and step_mom_dyn_unsplit_rk2().