MOM6
DOME_initialization.F90
1 !> Configures the model for the "DOME" experiment.
2 !! DOME = Dynamics of Overflows and Mixing Experiment
4 
5 ! This file is part of MOM6. See LICENSE.md for the license.
6 
7 use mom_sponge, only : sponge_cs, set_up_sponge_field, initialize_sponge
9 use mom_error_handler, only : mom_mesg, mom_error, fatal, warning, is_root_pe
11 use mom_get_input, only : directories
12 use mom_grid, only : ocean_grid_type
13 use mom_open_boundary, only : ocean_obc_type, obc_none, obc_simple
14 use mom_open_boundary, only : obc_segment_type, register_segment_tracer
16 use mom_tracer_registry, only : tracer_name_lookup
21 
22 implicit none ; private
23 
24 #include <MOM_memory.h>
25 
26 public dome_initialize_topography
27 public dome_initialize_thickness
28 public dome_initialize_sponges
29 public dome_set_obc_data
30 
31 ! A note on unit descriptions in comments: MOM6 uses units that can be rescaled for dimensional
32 ! consistency testing. These are noted in comments with units like Z, H, L, and T, along with
33 ! their mks counterparts with notation like "a velocity [Z T-1 ~> m s-1]". If the units
34 ! vary with the Boussinesq approximation, the Boussinesq variant is given first.
35 
36 contains
37 
38 ! -----------------------------------------------------------------------------
39 !> This subroutine sets up the DOME topography
40 subroutine dome_initialize_topography(D, G, param_file, max_depth, US)
41  type(dyn_horgrid_type), intent(in) :: g !< The dynamic horizontal grid type
42  real, dimension(G%isd:G%ied,G%jsd:G%jed), &
43  intent(out) :: d !< Ocean bottom depth in m or Z if US is present
44  type(param_file_type), intent(in) :: param_file !< Parameter file structure
45  real, intent(in) :: max_depth !< Maximum model depth in the units of D
46  type(unit_scale_type), optional, intent(in) :: us !< A dimensional unit scaling type
47 
48  ! Local variables
49  real :: m_to_z ! A dimensional rescaling factor.
50  real :: min_depth ! The minimum and maximum depths [Z ~> m].
51  ! This include declares and sets the variable "version".
52 # include "version_variable.h"
53  character(len=40) :: mdl = "DOME_initialize_topography" ! This subroutine's name.
54  integer :: i, j, is, ie, js, je, isd, ied, jsd, jed
55  is = g%isc ; ie = g%iec ; js = g%jsc ; je = g%jec
56  isd = g%isd ; ied = g%ied ; jsd = g%jsd ; jed = g%jed
57 
58  call mom_mesg(" DOME_initialization.F90, DOME_initialize_topography: setting topography", 5)
59 
60  m_to_z = 1.0 ; if (present(us)) m_to_z = us%m_to_Z
61 
62  call log_version(param_file, mdl, version, "")
63  call get_param(param_file, mdl, "MINIMUM_DEPTH", min_depth, &
64  "The minimum depth of the ocean.", units="m", default=0.0, scale=m_to_z)
65 
66  do j=js,je ; do i=is,ie
67  if (g%geoLatT(i,j) < 600.0) then
68  if (g%geoLatT(i,j) < 300.0) then
69  d(i,j) = max_depth
70  else
71  d(i,j) = max_depth - 10.0*m_to_z * (g%geoLatT(i,j)-300.0)
72  endif
73  else
74  if ((g%geoLonT(i,j) > 1000.0) .AND. (g%geoLonT(i,j) < 1100.0)) then
75  d(i,j) = 600.0*m_to_z
76  else
77  d(i,j) = 0.5*min_depth
78  endif
79  endif
80 
81  if (d(i,j) > max_depth) d(i,j) = max_depth
82  if (d(i,j) < min_depth) d(i,j) = 0.5*min_depth
83  enddo ; enddo
84 
85 end subroutine dome_initialize_topography
86 ! -----------------------------------------------------------------------------
87 
88 ! -----------------------------------------------------------------------------
89 !> This subroutine initializes layer thicknesses for the DOME experiment
90 subroutine dome_initialize_thickness(h, G, GV, param_file, just_read_params)
91  type(ocean_grid_type), intent(in) :: g !< The ocean's grid structure.
92  type(verticalgrid_type), intent(in) :: gv !< The ocean's vertical grid structure.
93  real, dimension(SZI_(G),SZJ_(G),SZK_(GV)), &
94  intent(out) :: h !< The thickness that is being initialized [H ~> m or kg m-2].
95  type(param_file_type), intent(in) :: param_file !< A structure indicating the open file
96  !! to parse for model parameter values.
97  logical, optional, intent(in) :: just_read_params !< If present and true, this call will
98  !! only read parameters without changing h.
99 
100  real :: e0(szk_(gv)+1) ! The resting interface heights [Z ~> m], usually
101  ! negative because it is positive upward [Z ~> m].
102  real :: eta1d(szk_(gv)+1) ! Interface height relative to the sea surface
103  ! positive upward [Z ~> m].
104  logical :: just_read ! If true, just read parameters but set nothing.
105  character(len=40) :: mdl = "DOME_initialize_thickness" ! This subroutine's name.
106  integer :: i, j, k, is, ie, js, je, nz
107 
108  is = g%isc ; ie = g%iec ; js = g%jsc ; je = g%jec ; nz = g%ke
109 
110  just_read = .false. ; if (present(just_read_params)) just_read = just_read_params
111 
112  if (just_read) return ! This subroutine has no run-time parameters.
113 
114  call mom_mesg(" DOME_initialization.F90, DOME_initialize_thickness: setting thickness", 5)
115 
116  e0(1)=0.0
117  do k=2,nz
118  e0(k) = -g%max_depth * (real(k-1)-0.5)/real(nz-1)
119  enddo
120 
121  do j=g%jsc,g%jec ; do i=g%isc,g%iec
122 ! This sets the initial thickness (in m) of the layers. The !
123 ! thicknesses are set to insure that: 1. each layer is at least an !
124 ! Angstrom thick, and 2. the interfaces are where they should be !
125 ! based on the resting depths and interface height perturbations, !
126 ! as long at this doesn't interfere with 1. !
127  eta1d(nz+1) = -g%bathyT(i,j)
128  do k=nz,1,-1
129  eta1d(k) = e0(k)
130  if (eta1d(k) < (eta1d(k+1) + gv%Angstrom_Z)) then
131  eta1d(k) = eta1d(k+1) + gv%Angstrom_Z
132  h(i,j,k) = gv%Angstrom_H
133  else
134  h(i,j,k) = gv%Z_to_H * (eta1d(k) - eta1d(k+1))
135  endif
136  enddo
137  enddo ; enddo
138 
139 end subroutine dome_initialize_thickness
140 ! -----------------------------------------------------------------------------
141 
142 ! -----------------------------------------------------------------------------
143 !> This subroutine sets the inverse restoration time (Idamp), and !
144 !! the values towards which the interface heights and an arbitrary !
145 !! number of tracers should be restored within each sponge. The !
146 !! interface height is always subject to damping, and must always be !
147 !! the first registered field. !
148 subroutine dome_initialize_sponges(G, GV, US, tv, PF, CSp)
149  type(ocean_grid_type), intent(in) :: g !< The ocean's grid structure.
150  type(verticalgrid_type), intent(in) :: gv !< The ocean's vertical grid structure.
151  type(unit_scale_type), intent(in) :: us !< A dimensional unit scaling type
152  type(thermo_var_ptrs), intent(in) :: tv !< A structure containing pointers to any available
153  !! thermodynamic fields, including potential temperature and
154  !! salinity or mixed layer density. Absent fields have NULL ptrs.
155  type(param_file_type), intent(in) :: pf !< A structure indicating the open file to
156  !! parse for model parameter values.
157  type(sponge_cs), pointer :: csp !< A pointer that is set to point to the control
158  !! structure for this module.
159 
160  real :: eta(szi_(g),szj_(g),szk_(g)+1) ! A temporary array for eta.
161  real :: temp(szi_(g),szj_(g),szk_(g)) ! A temporary array for other variables. !
162  real :: idamp(szi_(g),szj_(g)) ! The inverse damping rate [s-1].
163 
164  real :: h0(szk_(g)) ! Interface heights [Z ~> m].
165  real :: min_depth
166  real :: damp, e_dense, damp_new
167  character(len=40) :: mdl = "DOME_initialize_sponges" ! This subroutine's name.
168  integer :: i, j, k, is, ie, js, je, isd, ied, jsd, jed, nz
169 
170  is = g%isc ; ie = g%iec ; js = g%jsc ; je = g%jec ; nz = g%ke
171  isd = g%isd ; ied = g%ied ; jsd = g%jsd ; jed = g%jed
172 
173  eta(:,:,:) = 0.0 ; temp(:,:,:) = 0.0 ; idamp(:,:) = 0.0
174 
175 ! Here the inverse damping time [s-1], is set. Set Idamp to 0 !
176 ! wherever there is no sponge, and the subroutines that are called !
177 ! will automatically set up the sponges only where Idamp is positive!
178 ! and mask2dT is 1. !
179 
180 ! Set up sponges for DOME configuration
181  call get_param(pf, mdl, "MINIMUM_DEPTH", min_depth, &
182  "The minimum depth of the ocean.", units="m", default=0.0, scale=us%m_to_Z)
183 
184  h0(1) = 0.0
185  do k=2,nz ; h0(k) = -(real(k-1)-0.5)*g%max_depth / real(nz-1) ; enddo
186  do i=is,ie; do j=js,je
187  if (g%geoLonT(i,j) < 100.0) then ; damp = 10.0
188  elseif (g%geoLonT(i,j) < 200.0) then
189  damp = 10.0*(200.0-g%geoLonT(i,j))/100.0
190  else ; damp=0.0
191  endif
192 
193  if (g%geoLonT(i,j) > 1400.0) then ; damp_new = 10.0
194  elseif (g%geoLonT(i,j) > 1300.0) then
195  damp_new = 10.0*(g%geoLonT(i,j)-1300.0)/100.0
196  else ; damp_new = 0.0
197  endif
198 
199  if (damp <= damp_new) damp=damp_new
200 
201  ! These will be stretched inside of apply_sponge, so they can be in
202  ! depth space for Boussinesq or non-Boussinesq models.
203  eta(i,j,1) = 0.0
204  do k=2,nz
205 ! eta(i,j,K)=max(H0(k), -G%bathyT(i,j), GV%Angstrom_Z*(nz-k+1) - G%bathyT(i,j))
206  e_dense = -g%bathyT(i,j)
207  if (e_dense >= h0(k)) then ; eta(i,j,k) = e_dense
208  else ; eta(i,j,k) = h0(k) ; endif
209  if (eta(i,j,k) < gv%Angstrom_Z*(nz-k+1) - g%bathyT(i,j)) &
210  eta(i,j,k) = gv%Angstrom_Z*(nz-k+1) - g%bathyT(i,j)
211  enddo
212  eta(i,j,nz+1) = -g%bathyT(i,j)
213 
214  if (g%bathyT(i,j) > min_depth) then
215  idamp(i,j) = damp/86400.0
216  else ; idamp(i,j) = 0.0 ; endif
217  enddo ; enddo
218 
219 ! This call sets up the damping rates and interface heights.
220 ! This sets the inverse damping timescale fields in the sponges. !
221  call initialize_sponge(idamp, eta, g, pf, csp, gv)
222 
223 ! Now register all of the fields which are damped in the sponge. !
224 ! By default, momentum is advected vertically within the sponge, but !
225 ! momentum is typically not damped within the sponge. !
226 
227 ! At this point, the DOME configuration is done. The following are here as a
228 ! template for other configurations.
229 
230 ! The remaining calls to set_up_sponge_field can be in any order. !
231  if ( associated(tv%T) ) then
232  call mom_error(fatal,"DOME_initialize_sponges is not set up for use with"//&
233  " a temperatures defined.")
234  ! This should use the target values of T in temp.
235  call set_up_sponge_field(temp, tv%T, g, nz, csp)
236  ! This should use the target values of S in temp.
237  call set_up_sponge_field(temp, tv%S, g, nz, csp)
238  endif
239 
240 end subroutine dome_initialize_sponges
241 
242 !> This subroutine sets the properties of flow at open boundary conditions.
243 !! This particular example is for the DOME inflow describe in Legg et al. 2006.
244 subroutine dome_set_obc_data(OBC, tv, G, GV, US, param_file, tr_Reg)
245  type(ocean_obc_type), pointer :: obc !< This open boundary condition type specifies
246  !! whether, where, and what open boundary
247  !! conditions are used.
248  type(thermo_var_ptrs), intent(in) :: tv !< A structure containing pointers to any
249  !! available thermodynamic fields, including potential
250  !! temperature and salinity or mixed layer density. Absent
251  !! fields have NULL ptrs.
252  type(ocean_grid_type), intent(in) :: g !< The ocean's grid structure.
253  type(verticalgrid_type), intent(in) :: gv !< The ocean's vertical grid structure.
254  type(unit_scale_type), intent(in) :: us !< A dimensional unit scaling type
255  type(param_file_type), intent(in) :: param_file !< A structure indicating the open file
256  !! to parse for model parameter values.
257  type(tracer_registry_type), pointer :: tr_reg !< Tracer registry.
258 
259 ! Local variables
260  ! The following variables are used to set the target temperature and salinity.
261  real :: t0(szk_(g)), s0(szk_(g))
262  real :: pres(szk_(g)) ! An array of the reference pressure [Pa].
263  real :: drho_dt(szk_(g)) ! Derivative of density with temperature [kg m-3 degC-1].
264  real :: drho_ds(szk_(g)) ! Derivative of density with salinity [kg m-3 ppt-1].
265  real :: rho_guess(szk_(g)) ! Potential density at T0 & S0 [kg m-3].
266  ! The following variables are used to set up the transport in the DOME example.
267  real :: tr_0, y1, y2, tr_k, rst, rsb, rc, v_k, lon_im1
268  real :: d_edge ! The thickness [Z ~> m], of the dense fluid at the
269  ! inner edge of the inflow.
270  real :: g_prime_tot ! The reduced gravity across all layers [L2 Z-1 T-2 ~> m s-2].
271  real :: def_rad ! The deformation radius, based on fluid of
272  ! thickness D_edge, in the same units as lat.
273  real :: ri_trans ! The shear Richardson number in the transition
274  ! region of the specified shear profile.
275  character(len=40) :: mdl = "DOME_set_OBC_data" ! This subroutine's name.
276  character(len=32) :: name
277  integer :: i, j, k, itt, is, ie, js, je, isd, ied, jsd, jed, m, nz, ntr
278  integer :: isdb, iedb, jsdb, jedb
279  type(obc_segment_type), pointer :: segment => null()
280  type(tracer_type), pointer :: tr_ptr => null()
281 
282  is = g%isc ; ie = g%iec ; js = g%jsc ; je = g%jec ; nz = g%ke
283  isd = g%isd ; ied = g%ied ; jsd = g%jsd ; jed = g%jed
284  isdb = g%IsdB ; iedb = g%IedB ; jsdb = g%JsdB ; jedb = g%JedB
285 
286  ! The following variables should be transformed into runtime parameters.
287  d_edge = 300.0*us%m_to_Z ! The thickness of dense fluid in the inflow.
288  ri_trans = 1.0/3.0 ! The shear Richardson number in the transition region
289  ! region of the specified shear profile.
290 
291  if (.not.associated(obc)) return
292 
293  g_prime_tot = (gv%g_Earth / gv%Rho0)*2.0
294  def_rad = us%L_to_m*sqrt(d_edge*g_prime_tot) / (1.0e-4*us%T_to_s * 1000.0)
295  tr_0 = (-d_edge*sqrt(d_edge*g_prime_tot)*0.5e3*us%s_to_T*us%L_to_m*def_rad) * gv%Z_to_H
296 
297  if (obc%number_of_segments /= 1) then
298  call mom_error(warning, 'Error in DOME OBC segment setup', .true.)
299  return !!! Need a better error message here
300  endif
301  segment => obc%segment(1)
302  if (.not. segment%on_pe) return
303 
304  ntr = tr_reg%NTR
305  allocate(segment%field(ntr))
306 
307  do k=1,nz
308  rst = -1.0
309  if (k>1) rst = -1.0 + (real(k-1)-0.5)/real(nz-1)
310 
311  rsb = 0.0
312  if (k<nz) rsb = -1.0 + (real(k-1)+0.5)/real(nz-1)
313  rc = -1.0 + real(k-1)/real(nz-1)
314 
315  ! These come from assuming geostrophy and a constant Ri profile.
316  y1 = (2.0*ri_trans*rst + ri_trans + 2.0)/(2.0 - ri_trans)
317  y2 = (2.0*ri_trans*rsb + ri_trans + 2.0)/(2.0 - ri_trans)
318  tr_k = tr_0 * (2.0/(ri_trans*(2.0-ri_trans))) * &
319  ((log(y1)+1.0)/y1 - (log(y2)+1.0)/y2)
320  v_k = -us%L_T_to_m_s*sqrt(d_edge*g_prime_tot)*log((2.0 + ri_trans*(1.0 + 2.0*rc)) / &
321  (2.0 - ri_trans))
322  if (k == nz) tr_k = tr_k + tr_0 * (2.0/(ri_trans*(2.0+ri_trans))) * &
323  log((2.0+ri_trans)/(2.0-ri_trans))
324  ! New way
325  isd = segment%HI%isd ; ied = segment%HI%ied
326  jsdb = segment%HI%JsdB ; jedb = segment%HI%JedB
327  do j=jsdb,jedb ; do i=isd,ied
328  lon_im1 = 2.0*g%geoLonCv(i,j) - g%geoLonBu(i,j)
329  segment%normal_trans(i,j,k) = tr_k * (exp(-2.0*(lon_im1 - 1000.0)/def_rad) -&
330  exp(-2.0*(g%geoLonBu(i,j) - 1000.0)/def_rad))
331  segment%normal_vel(i,j,k) = v_k * exp(-2.0*(g%geoLonCv(i,j) - 1000.0)/def_rad)
332  enddo ; enddo
333  enddo
334 
335  ! The inflow values of temperature and salinity also need to be set here if
336  ! these variables are used. The following code is just a naive example.
337  if (associated(tv%S)) then
338  ! In this example, all S inflows have values of 35 psu.
339  name = 'salt'
340  call tracer_name_lookup(tr_reg, tr_ptr, name)
341  call register_segment_tracer(tr_ptr, param_file, gv, segment, obc_scalar=35.0)
342  endif
343  if (associated(tv%T)) then
344  ! In this example, the T values are set to be consistent with the layer
345  ! target density and a salinity of 35 psu. This code is taken from
346  ! USER_initialize_temp_sal.
347  pres(:) = tv%P_Ref ; s0(:) = 35.0 ; t0(1) = 25.0
348  call calculate_density(t0(1),s0(1),pres(1),rho_guess(1),tv%eqn_of_state)
349  call calculate_density_derivs(t0,s0,pres,drho_dt,drho_ds,1,1,tv%eqn_of_state)
350 
351  do k=1,nz ; t0(k) = t0(1) + (gv%Rlay(k)-rho_guess(1)) / drho_dt(1) ; enddo
352  do itt=1,6
353  call calculate_density(t0,s0,pres,rho_guess,1,nz,tv%eqn_of_state)
354  call calculate_density_derivs(t0,s0,pres,drho_dt,drho_ds,1,nz,tv%eqn_of_state)
355  do k=1,nz ; t0(k) = t0(k) + (gv%Rlay(k)-rho_guess(k)) / drho_dt(k) ; enddo
356  enddo
357 
358  ! Temperature on tracer 1???
359  allocate(segment%field(1)%buffer_src(segment%HI%isd:segment%HI%ied,segment%HI%JsdB:segment%HI%JedB,nz))
360  do k=1,nz ; do j=jsdb,jedb ; do i=isd,ied
361  segment%field(1)%buffer_src(i,j,k) = t0(k)
362  enddo ; enddo ; enddo
363  name = 'temp'
364  call tracer_name_lookup(tr_reg, tr_ptr, name)
365  call register_segment_tracer(tr_ptr, param_file, gv, segment, obc_array=.true.)
366  endif
367 
368  ! Dye tracers - fight with T,S???
369  ! First dye - only one with OBC values
370  ! This field(1) requires tr_D1 to be the first tracer.
371  allocate(segment%field(1)%buffer_src(segment%HI%isd:segment%HI%ied,segment%HI%JsdB:segment%HI%JedB,nz))
372  do k=1,nz ; do j=segment%HI%jsd,segment%HI%jed ; do i=segment%HI%isd,segment%HI%ied
373  if (k < nz/2) then ; segment%field(1)%buffer_src(i,j,k) = 0.0
374  else ; segment%field(1)%buffer_src(i,j,k) = 1.0 ; endif
375  enddo ; enddo ; enddo
376  name = 'tr_D1'
377  call tracer_name_lookup(tr_reg, tr_ptr, name)
378  call register_segment_tracer(tr_ptr, param_file, gv, &
379  obc%segment(1), obc_array=.true.)
380 
381  ! All tracers but the first have 0 concentration in their inflows. As this
382  ! is the default value, the following calls are unnecessary.
383  do m=2,ntr
384  if (m < 10) then ; write(name,'("tr_D",I1.1)') m
385  else ; write(name,'("tr_D",I2.2)') m ; endif
386  call tracer_name_lookup(tr_reg, tr_ptr, name)
387  call register_segment_tracer(tr_ptr, param_file, gv, &
388  obc%segment(1), obc_scalar=0.0)
389  enddo
390 
391 end subroutine dome_set_obc_data
392 
393 end module dome_initialization
mom_verticalgrid
Provides a transparent vertical ocean grid type and supporting routines.
Definition: MOM_verticalGrid.F90:2
mom_tracer_registry::tracer_type
The tracer type.
Definition: MOM_tracer_registry.F90:37
mom_file_parser::log_version
An overloaded interface to log version information about modules.
Definition: MOM_file_parser.F90:109
mom_variables::thermo_var_ptrs
Pointers to an assortment of thermodynamic fields that may be available, including potential temperat...
Definition: MOM_variables.F90:82
mom_get_input::directories
Container for paths and parameter file names.
Definition: MOM_get_input.F90:20
mom_dyn_horgrid
Contains a shareable dynamic type for describing horizontal grids and metric data and utilty routines...
Definition: MOM_dyn_horgrid.F90:3
mom_eos
Provides subroutines for quantities specific to the equation of state.
Definition: MOM_EOS.F90:2
mom_tracer_registry
This module contains the tracer_registry_type and the subroutines that handle registration of tracers...
Definition: MOM_tracer_registry.F90:5
mom_file_parser::param_file_type
A structure that can be parsed to read and document run-time parameters.
Definition: MOM_file_parser.F90:54
mom_file_parser::get_param
An overloaded interface to read and log the values of various types of parameters.
Definition: MOM_file_parser.F90:102
mom_get_input
Reads the only Fortran name list needed to boot-strap the model.
Definition: MOM_get_input.F90:6
mom_unit_scaling::unit_scale_type
Describes various unit conversion factors.
Definition: MOM_unit_scaling.F90:14
mom_eos::eos_type
A control structure for the equation of state.
Definition: MOM_EOS.F90:86
mom_verticalgrid::verticalgrid_type
Describes the vertical ocean grid, including unit conversion factors.
Definition: MOM_verticalGrid.F90:24
mom_variables
Provides transparent structures with groups of MOM6 variables and supporting routines.
Definition: MOM_variables.F90:2
mom_open_boundary
Controls where open boundary conditions are applied.
Definition: MOM_open_boundary.F90:2
dome_initialization
Configures the model for the "DOME" experiment. DOME = Dynamics of Overflows and Mixing Experiment.
Definition: DOME_initialization.F90:3
mom_file_parser
The MOM6 facility to parse input files for runtime parameters.
Definition: MOM_file_parser.F90:2
mom_sponge
Implements sponge regions in isopycnal mode.
Definition: MOM_sponge.F90:2
mom_eos::calculate_density_derivs
Calculate the derivatives of density with temperature and salinity from T, S, and P.
Definition: MOM_EOS.F90:70
mom_tracer_registry::tracer_registry_type
Type to carry basic tracer information.
Definition: MOM_tracer_registry.F90:122
mom_grid
Provides the ocean grid type.
Definition: MOM_grid.F90:2
mom_open_boundary::ocean_obc_type
Open-boundary data.
Definition: MOM_open_boundary.F90:186
mom_sponge::sponge_cs
This control structure holds memory and parameters for the MOM_sponge module.
Definition: MOM_sponge.F90:40
mom_unit_scaling
Provides a transparent unit rescaling type to facilitate dimensional consistency testing.
Definition: MOM_unit_scaling.F90:2
mom_open_boundary::obc_segment_type
Open boundary segment data structure.
Definition: MOM_open_boundary.F90:107
mom_error_handler
Routines for error handling and I/O management.
Definition: MOM_error_handler.F90:2
mom_dyn_horgrid::dyn_horgrid_type
Describes the horizontal ocean grid with only dynamic memory arrays.
Definition: MOM_dyn_horgrid.F90:22
mom_grid::ocean_grid_type
Ocean grid type. See mom_grid for details.
Definition: MOM_grid.F90:25
mom_eos::calculate_density
Calculates density of sea water from T, S and P.
Definition: MOM_EOS.F90:60