MOM6
|
This routine drives the diabatic/dianeutral physics for MOM.
By Robert Hallberg, Alistair Adcroft, and Stephen Griffies
This program contains the subroutine that, along with the subroutines that it calls, implements diapycnal mass and momentum fluxes and a bulk mixed layer. The diapycnal diffusion can be used without the bulk mixed layer.
The downward buoyancy flux in each layer is determined from an implicit calculation based on the previously calculated flux of the layer above and an estimated flux in the layer below. This flux is subject to the following conditions: (1) the flux in the top and bottom layers are set by the boundary conditions, and (2) no layer may be driven below an Angstrom thick- ness. If there is a bulk mixed layer, the buffer layer is treated as a fixed density layer with vanishingly small diffusivity.
diabatic takes 5 arguments: the two velocities (u and v), the thicknesses (h), a structure containing the forcing fields, and the length of time over which to act (dt). The velocities and thickness are taken as inputs and modified within the subroutine. There is no limit on the time step.
Data Types | |
type | diabatic_cs |
Control structure for this module. More... | |
integer | id_clock_entrain |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
integer | id_clock_mixedlayer |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
integer | id_clock_set_diffusivity |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
integer | id_clock_tracers |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
integer | id_clock_tridiag |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
integer | id_clock_pass |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
integer | id_clock_sponge |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
integer | id_clock_geothermal |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
integer | id_clock_differential_diff |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
integer | id_clock_remap |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
integer | id_clock_kpp |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
subroutine, public | diabatic (u, v, h, tv, Hml, fluxes, visc, ADp, CDp, dt, Time_end, G, GV, US, CS, WAVES) |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
subroutine | diabatic_ale_legacy (u, v, h, tv, Hml, fluxes, visc, ADp, CDp, dt, Time_end, G, GV, US, CS, WAVES) |
Applies diabatic forcing and diapycnal mixing of temperature, salinity and other tracers for use with an ALE algorithm. This version uses an older set of algorithms compared with diabatic_ALE. More... | |
subroutine | diabatic_ale (u, v, h, tv, Hml, fluxes, visc, ADp, CDp, dt, Time_end, G, GV, US, CS, Waves) |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers. More... | |
subroutine | layered_diabatic (u, v, h, tv, Hml, fluxes, visc, ADp, CDp, dt, Time_end, G, GV, US, CS, WAVES) |
Imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers using the original MOM6 algorithms. More... | |
subroutine, public | extract_diabatic_member (CS, opacity_CSp, optics_CSp, evap_CFL_limit, minimum_forcing_depth, KPP_CSp, energetic_PBL_CSp, diabatic_aux_CSp) |
Returns pointers or values of members within the diabatic_CS type. For extensibility, each returned argument is an optional argument. More... | |
subroutine, public | adiabatic (h, tv, fluxes, dt, G, GV, US, CS) |
Routine called for adiabatic physics. More... | |
subroutine | diagnose_diabatic_diff_tendency (tv, h, temp_old, saln_old, dt, G, GV, CS) |
This routine diagnoses tendencies from application of diabatic diffusion using ALE algorithm. Note that layer thickness is not altered by diabatic diffusion. More... | |
subroutine | diagnose_boundary_forcing_tendency (tv, h, temp_old, saln_old, h_old, dt, G, GV, CS) |
This routine diagnoses tendencies from application of boundary fluxes. These impacts are generally 3d, in particular for penetrative shortwave. Other fluxes contribute 3d in cases when the layers vanish or are very thin, in which case we distribute the flux into k > 1 layers. More... | |
subroutine | diagnose_frazil_tendency (tv, h, temp_old, dt, G, GV, CS) |
This routine diagnoses tendencies for temperature and heat from frazil formation. This routine is called twice from within subroutine diabatic; at start and at end of the diabatic processes. The impacts from frazil are generally a function of depth. Hence, when checking heat budget, be sure to remove HFSIFRAZIL from HFDS in k=1. More... | |
subroutine, public | adiabatic_driver_init (Time, G, param_file, diag, CS, tracer_flow_CSp) |
A simplified version of diabatic_driver_init that will allow tracer column functions to be called without allowing any of the diabatic processes to be used. More... | |
subroutine, public | diabatic_driver_init (Time, G, GV, US, param_file, useALEalgorithm, diag, ADp, CDp, CS, tracer_flow_CSp, sponge_CSp, ALE_sponge_CSp) |
This routine initializes the diabatic driver module. More... | |
subroutine, public | diabatic_driver_end (CS) |
Routine to close the diabatic driver module. More... | |
subroutine, public mom_diabatic_driver::adiabatic | ( | real, dimension(szi_(g),szj_(g),szk_(g)), intent(inout) | h, |
type(thermo_var_ptrs), intent(inout) | tv, | ||
type(forcing), intent(inout) | fluxes, | ||
real, intent(in) | dt, | ||
type(ocean_grid_type), intent(inout) | G, | ||
type(verticalgrid_type), intent(in) | GV, | ||
type(unit_scale_type), intent(in) | US, | ||
type(diabatic_cs), pointer | CS | ||
) |
Routine called for adiabatic physics.
[in,out] | g | ocean grid structure |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields |
[in,out] | fluxes | boundary fluxes |
[in] | dt | time step [T ~> s] |
[in] | gv | ocean vertical grid structure |
[in] | us | A dimensional unit scaling type |
cs | module control structure |
Definition at line 2892 of file MOM_diabatic_driver.F90.
References mom_tracer_flow_control::call_tracer_column_fns().
Referenced by mom::step_mom_thermo().
subroutine, public mom_diabatic_driver::adiabatic_driver_init | ( | type(time_type), intent(in) | Time, |
type(ocean_grid_type), intent(in) | G, | ||
type(param_file_type), intent(in) | param_file, | ||
type(diag_ctrl), intent(inout), target | diag, | ||
type(diabatic_cs), pointer | CS, | ||
type(tracer_flow_control_cs), pointer | tracer_flow_CSp | ||
) |
A simplified version of diabatic_driver_init that will allow tracer column functions to be called without allowing any of the diabatic processes to be used.
[in] | time | current model time |
[in] | g | model grid structure |
[in] | param_file | the file to parse for parameter values |
[in,out] | diag | regulates diagnostic output |
cs | module control structure | |
tracer_flow_csp | pointer to control structure of the tracer flow control module |
Definition at line 3155 of file MOM_diabatic_driver.F90.
Referenced by mom::initialize_mom().
subroutine, public mom_diabatic_driver::diabatic | ( | 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(thermo_var_ptrs), intent(inout) | tv, | ||
real, dimension(:,:), pointer | Hml, | ||
type(forcing), intent(inout) | fluxes, | ||
type(vertvisc_type), intent(inout) | visc, | ||
type(accel_diag_ptrs), intent(inout) | ADp, | ||
type(cont_diag_ptrs), intent(inout) | CDp, | ||
real, intent(in) | dt, | ||
type(time_type), intent(in) | Time_end, | ||
type(ocean_grid_type), intent(inout) | G, | ||
type(verticalgrid_type), intent(in) | GV, | ||
type(unit_scale_type), intent(in) | US, | ||
type(diabatic_cs), pointer | CS, | ||
type(wave_parameters_cs), optional, pointer | WAVES | ||
) |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
[in] | us | A dimensional unit scaling type |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 259 of file MOM_diabatic_driver.F90.
References mom_error_handler::calltree_waypoint(), diabatic_ale(), diabatic_ale_legacy(), diagnose_frazil_tendency(), mom_diapyc_energy_req::diapyc_energy_req_test(), id_clock_pass, id_clock_set_diffusivity, layered_diabatic(), mom_checksum_packages::mom_state_stats(), mom_time_manager::real_to_time(), and mom_wave_speed::wave_speeds().
|
private |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in] | us | A dimensional unit scaling type |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 1229 of file MOM_diabatic_driver.F90.
References mom_ale_sponge::apply_ale_sponge(), mom_cvmix_conv::calculate_cvmix_conv(), mom_forcing_type::calculatebuoyancyflux2d(), mom_tracer_flow_control::call_tracer_column_fns(), mom_error_handler::calltree_enter(), mom_error_handler::calltree_leave(), mom_error_handler::calltree_waypoint(), diagnose_boundary_forcing_tendency(), diagnose_diabatic_diff_tendency(), mom_domains::do_group_pass(), mom_energetic_pbl::energetic_pbl_get_mld(), mom_geothermal::geothermal(), id_clock_differential_diff, id_clock_geothermal, id_clock_kpp, id_clock_pass, id_clock_remap, id_clock_set_diffusivity, id_clock_sponge, id_clock_tracers, id_clock_tridiag, mom_cvmix_kpp::kpp_nonlocaltransport_saln(), mom_cvmix_kpp::kpp_nonlocaltransport_temp(), mom_checksum_packages::mom_state_stats(), mom_variables::mom_thermovar_chksum(), mom_opacity::optics_nbands(), mom_diabatic_aux::set_pen_shortwave(), and mom_tracer_diabatic::tracer_vertdiff().
Referenced by diabatic().
|
private |
Applies diabatic forcing and diapycnal mixing of temperature, salinity and other tracers for use with an ALE algorithm. This version uses an older set of algorithms compared with diabatic_ALE.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in] | us | A dimensional unit scaling type |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 446 of file MOM_diabatic_driver.F90.
References mom_ale_sponge::apply_ale_sponge(), mom_cvmix_conv::calculate_cvmix_conv(), mom_forcing_type::calculatebuoyancyflux2d(), mom_tracer_flow_control::call_tracer_column_fns(), mom_error_handler::calltree_enter(), mom_error_handler::calltree_leave(), mom_error_handler::calltree_waypoint(), diagnose_boundary_forcing_tendency(), diagnose_diabatic_diff_tendency(), mom_energetic_pbl::energetic_pbl_get_mld(), mom_geothermal::geothermal(), id_clock_differential_diff, id_clock_geothermal, id_clock_kpp, id_clock_remap, id_clock_set_diffusivity, id_clock_sponge, id_clock_tracers, id_clock_tridiag, mom_cvmix_kpp::kpp_nonlocaltransport_saln(), mom_cvmix_kpp::kpp_nonlocaltransport_temp(), mom_checksum_packages::mom_state_stats(), mom_variables::mom_thermovar_chksum(), mom_opacity::optics_nbands(), mom_diabatic_aux::set_pen_shortwave(), and mom_tracer_diabatic::tracer_vertdiff().
Referenced by diabatic().
subroutine, public mom_diabatic_driver::diabatic_driver_end | ( | type(diabatic_cs), pointer | CS | ) |
Routine to close the diabatic driver module.
cs | module control structure |
Definition at line 3758 of file MOM_diabatic_driver.F90.
References mom_cvmix_conv::cvmix_conv_end(), mom_entrain_diffusive::entrain_diffusive_end(), and mom_tidal_mixing::tidal_mixing_end().
Referenced by mom::mom_end().
subroutine, public mom_diabatic_driver::diabatic_driver_init | ( | type(time_type), 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, | ||
logical, intent(in) | useALEalgorithm, | ||
type(diag_ctrl), intent(inout), target | diag, | ||
type(accel_diag_ptrs), intent(inout) | ADp, | ||
type(cont_diag_ptrs), intent(inout) | CDp, | ||
type(diabatic_cs), pointer | CS, | ||
type(tracer_flow_control_cs), pointer | tracer_flow_CSp, | ||
type(sponge_cs), pointer | sponge_CSp, | ||
type(ale_sponge_cs), pointer | ALE_sponge_CSp | ||
) |
This routine initializes the diabatic driver module.
time | model time | |
[in,out] | g | model grid structure |
[in] | gv | model vertical grid structure |
[in] | us | A dimensional unit scaling type |
[in] | param_file | file to parse for parameter values |
[in] | usealealgorithm | logical for whether to use ALE remapping |
[in,out] | diag | structure to regulate diagnostic output |
[in,out] | adp | pointers to accelerations in momentum equations, to enable diagnostics, like energy budgets |
[in,out] | cdp | pointers to terms in continuity equations |
cs | module control structure | |
tracer_flow_csp | pointer to control structure of the tracer flow control module | |
sponge_csp | pointer to the sponge module control structure | |
ale_sponge_csp | pointer to the ALE sponge module control structure |
Definition at line 3187 of file MOM_diabatic_driver.F90.
References mom_bulk_mixed_layer::bulkmixedlayer_init(), mom_cvmix_ddiff::cvmix_ddiff_is_used(), mom_cvmix_shear::cvmix_shear_is_used(), mom_geothermal::geothermal_init(), mom_verticalgrid::get_thickness_units(), id_clock_differential_diff, id_clock_entrain, id_clock_geothermal, id_clock_kpp, id_clock_mixedlayer, id_clock_pass, id_clock_remap, id_clock_set_diffusivity, id_clock_sponge, id_clock_tracers, id_clock_tridiag, mom_internal_tides::internal_tides_init(), mom_kappa_shear::kappa_shear_is_used(), and mom_regularize_layers::regularize_layers_init().
|
private |
This routine diagnoses tendencies from application of boundary fluxes. These impacts are generally 3d, in particular for penetrative shortwave. Other fluxes contribute 3d in cases when the layers vanish or are very thin, in which case we distribute the flux into k > 1 layers.
[in] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in] | tv | points to updated thermodynamic fields |
[in] | h | thickness after boundary flux application [H ~> m or kg m-2] |
[in] | temp_old | temperature prior to boundary flux application [degC] |
[in] | saln_old | salinity prior to boundary flux application [ppt] |
[in] | h_old | thickness prior to boundary flux application [H ~> m or kg m-2] |
[in] | dt | time step [T ~> s] |
cs | module control structure |
Definition at line 3008 of file MOM_diabatic_driver.F90.
Referenced by diabatic_ale(), and diabatic_ale_legacy().
|
private |
This routine diagnoses tendencies from application of diabatic diffusion using ALE algorithm. Note that layer thickness is not altered by diabatic diffusion.
[in] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in] | tv | points to updated thermodynamic fields |
[in] | h | thickness [H ~> m or kg m-2] |
[in] | temp_old | temperature prior to diabatic physics |
[in] | saln_old | salinity prior to diabatic physics [ppt] |
[in] | dt | time step [T ~> s] |
cs | module control structure |
Definition at line 2916 of file MOM_diabatic_driver.F90.
Referenced by diabatic_ale(), diabatic_ale_legacy(), and layered_diabatic().
|
private |
This routine diagnoses tendencies for temperature and heat from frazil formation. This routine is called twice from within subroutine diabatic; at start and at end of the diabatic processes. The impacts from frazil are generally a function of depth. Hence, when checking heat budget, be sure to remove HFSIFRAZIL from HFDS in k=1.
[in] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
cs | module control structure | |
[in] | tv | points to updated thermodynamic fields |
[in] | h | thickness [H ~> m or kg m-2] |
[in] | temp_old | temperature prior to frazil formation [degC] |
[in] | dt | time step [T ~> s] |
Definition at line 3104 of file MOM_diabatic_driver.F90.
Referenced by diabatic().
subroutine, public mom_diabatic_driver::extract_diabatic_member | ( | type(diabatic_cs), intent(in) | CS, |
type(opacity_cs), optional, pointer | opacity_CSp, | ||
type(optics_type), optional, pointer | optics_CSp, | ||
real, intent(out), optional | evap_CFL_limit, | ||
real, intent(out), optional | minimum_forcing_depth, | ||
type(kpp_cs), optional, pointer | KPP_CSp, | ||
type(energetic_pbl_cs), optional, pointer | energetic_PBL_CSp, | ||
type(diabatic_aux_cs), optional, pointer | diabatic_aux_CSp | ||
) |
Returns pointers or values of members within the diabatic_CS type. For extensibility, each returned argument is an optional argument.
[in] | cs | module control structure |
opacity_csp | A pointer to be set to the opacity control structure | |
optics_csp | A pointer to be set to the optics control structure | |
kpp_csp | A pointer to be set to the KPP CS | |
energetic_pbl_csp | A pointer to be set to the ePBL CS | |
[out] | evap_cfl_limit | The largest fraction of a layer that can be evaporated in one time-step [nondim]. |
[out] | minimum_forcing_depth | The smallest depth over which heat and freshwater fluxes are applied [H ~> m or kg m-2]. |
diabatic_aux_csp | A pointer to be set to the diabatic_aux control structure |
Definition at line 2865 of file MOM_diabatic_driver.F90.
Referenced by mom_lateral_boundary_diffusion::lateral_boundary_diffusion_init(), mom_neutral_diffusion::neutral_diffusion_init(), and mom_offline_main::offline_transport_init().
|
private |
Imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers using the original MOM6 algorithms.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in] | us | A dimensional unit scaling type |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 1908 of file MOM_diabatic_driver.F90.
References mom_sponge::apply_sponge(), mom_bulk_mixed_layer::bulkmixedlayer(), mom_cvmix_conv::calculate_cvmix_conv(), mom_forcing_type::calculatebuoyancyflux2d(), mom_tracer_flow_control::call_tracer_column_fns(), mom_error_handler::calltree_enter(), mom_error_handler::calltree_leave(), mom_error_handler::calltree_waypoint(), diagnose_diabatic_diff_tendency(), mom_domains::do_group_pass(), mom_geothermal::geothermal(), id_clock_differential_diff, id_clock_entrain, id_clock_geothermal, id_clock_kpp, id_clock_mixedlayer, id_clock_pass, id_clock_remap, id_clock_set_diffusivity, id_clock_sponge, id_clock_tracers, id_clock_tridiag, mom_cvmix_kpp::kpp_nonlocaltransport_saln(), mom_cvmix_kpp::kpp_nonlocaltransport_temp(), mom_checksum_packages::mom_state_stats(), mom_variables::mom_thermovar_chksum(), mom_regularize_layers::regularize_layers(), mom_diabatic_aux::set_pen_shortwave(), and mom_tracer_diabatic::tracer_vertdiff().
Referenced by diabatic().
|
private |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
[in] | us | A dimensional unit scaling type |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 250 of file MOM_diabatic_driver.F90.
Referenced by diabatic_ale(), diabatic_ale_legacy(), diabatic_driver_init(), and layered_diabatic().
integer mom_diabatic_driver::id_clock_entrain |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
[in] | us | A dimensional unit scaling type |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 248 of file MOM_diabatic_driver.F90.
Referenced by diabatic_driver_init(), and layered_diabatic().
|
private |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
[in] | us | A dimensional unit scaling type |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 250 of file MOM_diabatic_driver.F90.
Referenced by diabatic_ale(), diabatic_ale_legacy(), diabatic_driver_init(), and layered_diabatic().
|
private |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
[in] | us | A dimensional unit scaling type |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 251 of file MOM_diabatic_driver.F90.
Referenced by diabatic_ale(), diabatic_ale_legacy(), diabatic_driver_init(), and layered_diabatic().
|
private |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
[in] | us | A dimensional unit scaling type |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 248 of file MOM_diabatic_driver.F90.
Referenced by diabatic_driver_init(), and layered_diabatic().
|
private |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
[in] | us | A dimensional unit scaling type |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 249 of file MOM_diabatic_driver.F90.
Referenced by diabatic(), diabatic_ale(), diabatic_driver_init(), and layered_diabatic().
|
private |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
[in] | us | A dimensional unit scaling type |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 250 of file MOM_diabatic_driver.F90.
Referenced by diabatic_ale(), diabatic_ale_legacy(), diabatic_driver_init(), and layered_diabatic().
|
private |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
[in] | us | A dimensional unit scaling type |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 248 of file MOM_diabatic_driver.F90.
Referenced by diabatic(), diabatic_ale(), diabatic_ale_legacy(), diabatic_driver_init(), and layered_diabatic().
|
private |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
[in] | us | A dimensional unit scaling type |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 249 of file MOM_diabatic_driver.F90.
Referenced by diabatic_ale(), diabatic_ale_legacy(), diabatic_driver_init(), and layered_diabatic().
|
private |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
[in] | us | A dimensional unit scaling type |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 249 of file MOM_diabatic_driver.F90.
Referenced by diabatic_ale(), diabatic_ale_legacy(), diabatic_driver_init(), and layered_diabatic().
|
private |
This subroutine imposes the diapycnal mass fluxes and the accompanying diapycnal advection of momentum and tracers.
[in,out] | g | ocean grid structure |
[in] | gv | ocean vertical grid structure |
[in,out] | u | zonal velocity [L T-1 ~> m s-1] |
[in,out] | v | meridional velocity [L T-1 ~> m s-1] |
[in,out] | h | thickness [H ~> m or kg m-2] |
[in,out] | tv | points to thermodynamic fields unused have NULL ptrs |
hml | Active mixed layer depth [m] | |
[in,out] | fluxes | points to forcing fields unused fields have NULL ptrs |
[in,out] | visc | vertical viscosities, BBL properies, and |
[in,out] | adp | related points to accelerations in momentum equations, to enable the later derived diagnostics, like energy budgets |
[in,out] | cdp | points to terms in continuity equations |
[in] | dt | time increment [T ~> s] |
[in] | time_end | Time at the end of the interval |
[in] | us | A dimensional unit scaling type |
cs | module control structure | |
waves | Surface gravity waves |
Definition at line 249 of file MOM_diabatic_driver.F90.
Referenced by diabatic_ale(), diabatic_ale_legacy(), diabatic_driver_init(), and layered_diabatic().