MPAS-JEDI
mpas_state_mod.F90
Go to the documentation of this file.
1 ! (C) Copyright 2017 UCAR
2 !
3 ! This software is licensed under the terms of the Apache Licence Version 2.0
4 ! which can be obtained at http://www.apache.org/licenses/LICENSE-2.0.
5 
7 
8 use fckit_configuration_module, only: fckit_configuration
9 use fckit_mpi_module, only: fckit_mpi_comm, fckit_mpi_sum
10 use fckit_log_module, only: fckit_log
11 
12 !oops
13 use datetime_mod
14 use kinds, only: kind_real
15 use oops_variables_mod, only: oops_variables
16 
17 !dcmip initialization
18 use dcmip_initial_conditions_test_1_2_3, only : test1_advection_deformation, &
19  test1_advection_hadley, test3_gravity_wave
20 use dcmip_initial_conditions_test_4, only : test4_baroclinic_wave
21 
22 !ufo
23 use ufo_geovals_mod
24 use ufo_vars_mod
25 
26 !MPAS-Model
27 use mpas_constants
28 use mpas_derived_types
29 use mpas_field_routines
30 use mpas_kind_types, only: strkind
31 use mpas_pool_routines
32 use mpas_dmpar, only: mpas_dmpar_exch_halo_field
33 
34 
35 !mpas-jedi
37 use mpas_geom_mod
40 use mpas4da_mod
41 
42 implicit none
43 
44 private
45 
46 public :: add_incr, &
48 
49 ! ------------------------------------------------------------------------------
50 
51 contains
52 
53 
54 ! ------------------------------------------------------------------------------
55 !> add increment to state
56 !!
57 !! \details **add_incr()** adds "increment" to "state", such as
58 !! state (containing analysis) = state (containing guess) + increment
59 !! Here, we also update "theta", "rho", and "u" (edge-normal wind), which are
60 !! close to MPAS prognostic variable.
61 !! Intermediate 3D pressure is diagnosed with hydrostatic balance.
62 !! While conversion to "theta" and "rho" uses full state variables,
63 !! conversion to "u" from cell center winds uses their increment to reduce
64 !! the smoothing effect.
65 !!
66 subroutine add_incr(self, increment)
67 
68  implicit none
69  class(mpas_fields), intent(inout) :: self !< state
70  class(mpas_fields), intent(in) :: increment
71  character(len=StrKIND) :: kind_op
72 
73  integer :: ngrid
74  type (mpas_pool_type), pointer :: state, diag, mesh
75  type (field2dreal), pointer :: fld2d_pb, fld2d_u, fld2d_u_inc, fld2d_urm, fld2d_urz
76  real(kind=kind_real), dimension(:,:), pointer :: ptrr2_qv, ptrr2_sh
77  real(kind=kind_real), dimension(:,:), pointer :: ptrr2_p, ptrr2_rho, ptrr2_t, ptrr2_th, ptrr2_pp
78  real(kind=kind_real), dimension(:), pointer :: ptrr1_ps
79 
80  ! Difference with self_add other is that self%subFields can contain extra fields
81  ! beyond increment%subFields and the resolution of increment can be different.
82 
83  if (self%geom%nCells==increment%geom%nCells .and. self%geom%nVertLevels==increment%geom%nVertLevels) then
84  ! First, update subFields that are common between self and increment
85  kind_op = 'add'
86  call da_operator(trim(kind_op), self%subFields, increment%subFields, fld_select = increment%fldnames_ci)
87 
88  ! Impose positive-definite limits on hydrometeors and moistureFields
89  ! note: nonlinear COV (change of variables) from increment to state
90  call da_posdef( self%subFields, mpas_hydrometeor_fields)
91  call da_posdef( self%subFields, moisturefields)
92 
93  !NOTE: second, also update variables which are closely related to MPAS prognostic vars.
94  ngrid = self%geom%nCellsSolve
95 
96  ! Update qv (water vapor mixing ratio) from spechum (specific humidity) [ w = q / (1 - q) ]
97  ! note: nonlinear COV
98  if ( all(self%has(moisturefields)) .and. &
99  increment%has('spechum') .and. .not.increment%has('qv')) then
100  call self%get( 'qv', ptrr2_qv)
101  call self%get('spechum', ptrr2_sh)
102  call q_to_w( ptrr2_sh(:,1:ngrid), ptrr2_qv(:,1:ngrid) )
103  endif
104 
105  ! Enforce a hydrostatic balance to diagnose 3D pressure,
106  ! plus update full state theta and rho
107  ! note: nonlinear COV
108  if ( all(self%has(analysisthermofields)) .and. &
109  all(self%has(modelthermofields)) .and. &
110  all(increment%has(analysisthermofields)) .and. &
111  .not. all(increment%has(modelthermofields)) ) then
112  call self%get( 'qv', ptrr2_qv)
113  call self%get( 'pressure', ptrr2_p)
114  call self%get( 'rho', ptrr2_rho)
115  call self%get('surface_pressure', ptrr1_ps)
116  call self%get( 'temperature', ptrr2_t)
117  call self%get( 'theta', ptrr2_th)
118 
119  call hydrostatic_balance( ngrid, self%geom%nVertLevels, self%geom%zgrid(:,1:ngrid), &
120  ptrr2_t(:,1:ngrid), ptrr2_qv(:,1:ngrid), ptrr1_ps(1:ngrid), &
121  ptrr2_p(:,1:ngrid), ptrr2_rho(:,1:ngrid), ptrr2_th(:,1:ngrid) )
122  endif
123 
124  ! Update pressure_p (pressure perturbation) , which is a diagnostic variable
125  if ( self%has('pressure_p') .and. self%has('pressure') .and. &
126  .not.increment%has('pressure_p') ) then
127  call self%get( 'pressure', ptrr2_p)
128  call self%get('pressure_p', ptrr2_pp)
129  call mpas_pool_get_field(self%geom%domain%blocklist%allFields, 'pressure_base', fld2d_pb)
130  ptrr2_pp(:,1:ngrid) = ptrr2_p(:,1:ngrid) - fld2d_pb%array(:,1:ngrid)
131  endif
132 
133  ! Update edge normal wind u from uReconstructZonal and uReconstructMeridional "incrementally"
134  ! note: linear COV
135  if ( self%has('u') .and. &
136  all(increment%has(cellcenteredwindfields)) .and. &
137  .not.increment%has('u') ) then
138  call mpas_pool_get_field(self%subFields, 'u', fld2d_u)
139  call mpas_pool_get_field(increment%subFields, 'uReconstructMeridional', fld2d_urm)
140  call mpas_pool_get_field(increment%subFields, 'uReconstructZonal', fld2d_urz)
141 
142  call mpas_duplicate_field(fld2d_u, fld2d_u_inc)
143 
144  call mpas_dmpar_exch_halo_field(fld2d_urz)
145  call mpas_dmpar_exch_halo_field(fld2d_urm)
146  call uv_cell_to_edges(self%geom%domain, fld2d_urz, fld2d_urm, fld2d_u_inc, &
147  self%geom%lonCell, self%geom%latCell, self%geom%nCells, &
148  self%geom%edgeNormalVectors, self%geom%nEdgesOnCell, self%geom%edgesOnCell, &
149  self%geom%nVertLevels)
150  ngrid = self%geom%nEdgesSolve
151  fld2d_u%array(:,1:ngrid) = fld2d_u%array(:,1:ngrid) + fld2d_u_inc%array(:,1:ngrid)
152 
153  ! TODO: DO we need HALO exchange here or in ModelMPAS::initialize for model integration?
154  call mpas_deallocate_field( fld2d_u_inc )
155  endif
156  else
157  call abor1_ftn("mpas_state:add_incr: dimension mismatch")
158  endif
159 
160  return
161 
162 end subroutine add_incr
163 
164 ! ------------------------------------------------------------------------------
165 !> Analytic Initialization for the MPAS Model
166 !!
167 !! \details **analytic_IC()** initializes the MPAS Field and State objects using one of
168 !! several alternative idealized analytic models. This is intended to facilitate testing by
169 !! eliminating the need to read in the initial state from a file and by providing exact expressions
170 !! to test interpolations. This function is activated by setting the "analytic_init" field in the
171 !! "initial" or "StateFile" section of the configuration file.
172 !!
173 !! Initialization options that begin with "dcmip" refer to tests defined by the multi-institutional
174 !! 2012 [Dynamical Core Intercomparison Project](https://earthsystealcmcog.org/projects/dcmip-2012)
175 !! and the associated Summer School, sponsored by NOAA, NSF, DOE, NCAR, and the University of Michigan.
176 !!
177 !! Currently implemented options for analytic_init include:
178 !! * invent-state: Backward compatibility with original analytic init option
179 !! * dcmip-test-1-1: 3D deformational flow
180 !! * dcmip-test-1-2: 3D Hadley-like meridional circulation
181 !! * dcmip-test-3-1: Non-hydrostatic gravity wave
182 !! * dcmip-test-4-0: Baroclinic instability
183 !!
184 !! \author J. Guerrette (adapted from fv3jedi code by M. Miesch)
185 !! \date July, 2018: Created
186 !!
187 subroutine analytic_ic(self, geom, f_conf, vdate)
188 
189 ! !MPAS Test Cases
190 ! !JJG: This initialization requires the init_atmospher_core core_type
191 ! ! in the MPAS library for OOPS, but currently it is not included
192 ! use init_atm_core, only: init_atm_core_run!, init_atm_core_finalize (could be used for cleanup...)
193 
194  implicit none
195 
196  class(mpas_fields), intent(inout) :: self !< State
197  type(mpas_geom), target, intent(in) :: geom !< Geometry
198  type(fckit_configuration), intent(in) :: f_conf !< Configuration
199  type(datetime), intent(inout) :: vdate !< DateTime
200 
201  character(len=:), allocatable :: str
202  character(len=30) :: ic
203  character(len=20) :: sdate
204  character(len=1024) :: buf
205  Integer :: jlev,ii
206  integer :: ierr = 0
207  real(kind=kind_real) :: rlat, rlon, z
208  real(kind=kind_real) :: pk,pe1,pe2,ps
209  real(kind=kind_real) :: u0,v0,w0,t0,phis0,ps0,rho0,hum0,q1,q2,q3,q4
210 
211  real(kind=kind_real) :: dtdummy = 900.0
212  logical, allocatable :: grids_on_this_pe(:)
213  integer :: p_split = 1
214  real (kind=kind_real), dimension(:,:), pointer :: &
215  u_ptr, v_ptr, temperature_ptr, p_ptr, &
216  qv_ptr, qc_ptr, qr_ptr, qi_ptr, qs_ptr, &
217  ln_p_ptr
218  real(kind=kind_real), dimension(:),pointer :: ps_ptr
219  integer, pointer :: index_qv, index_qc, index_qr, index_qi, index_qs
220  type (field3dreal), pointer :: field3d
221  type (mpas_pool_type), pointer :: pool_a, pool_b, state
222  real(kind=kind_real) :: zhalf
223 
224  ! Pointer to geometry component of field object
225  self%geom => geom
226 
227  If (f_conf%has("analytic_init")) Then
228  call f_conf%get_or_die("analytic_init",str)
229  ic = str
230  Else
231  ! This default value is for backward compatibility
232  ic = "invent-state"
233  EndIf
234  call fckit_log%info ("mpas_state:analytic_init: "//ic)
235 
236 ! Conflicts with natural log below
237 ! call log%warning("mpas_state:analytic_init: "//IC)
238  call f_conf%get_or_die("date",str)
239  sdate = str
240  call fckit_log%info ("validity date is: "//sdate)
241 
242  call datetime_set(sdate, vdate)
243 
244  ! Need to initialize variables that are used in interpolation/getVals
245  ! In "create" and "read" subroutines, subFields are
246  ! initialized from geom % domain % blocklist % allFields, zeroed,
247  ! reread from file into allFields, then values copied to subFields
248  ! -> must initialize allFields here and copy to subFields
249 
250  call mpas_pool_get_subpool(geom % domain % blocklist % structs, &
251  'state', state)
252 
253  pool_a => geom % domain % blocklist % allFields
254 
255  !Diagnostic vars (diag pool)
256  call mpas_pool_get_array(pool_a, "pressure", p_ptr)
257  call mpas_pool_get_array(pool_a, "uReconstructZonal", u_ptr)
258  call mpas_pool_get_array(pool_a, "uReconstructMeridional", v_ptr)
259  call mpas_pool_get_array(pool_a, "temperature", temperature_ptr)
260  call mpas_pool_get_array(pool_a, "surface_pressure", ps_ptr)
261 
262 
263  !Scalars (state pool)
264  call mpas_pool_get_field(pool_a, "scalars", field3d)
265  call mpas_pool_get_dimension(state, "index_qv", index_qv)
266  if ( index_qv .gt. 0 ) &
267  qv_ptr => field3d % array(index_qv,:,:)
268 
269  call mpas_pool_get_dimension(state, "index_qc", index_qc)
270  if ( index_qc .gt. 0 ) &
271  qc_ptr => field3d % array(index_qc,:,:)
272 
273  call mpas_pool_get_dimension(state, "index_qr", index_qr)
274  if ( index_qr .gt. 0 ) &
275  qr_ptr => field3d % array(index_qr,:,:)
276 
277  call mpas_pool_get_dimension(state, "index_qi", index_qi)
278  if ( index_qi .gt. 0 ) &
279  qi_ptr => field3d % array(index_qi,:,:)
280 
281  call mpas_pool_get_dimension(state, "index_qs", index_qs)
282  if ( index_qs .gt. 0 ) &
283  qs_ptr => field3d % array(index_qs,:,:)
284 
285  !===================================================================
286  int_option: Select Case (ic)
287 
288  Case("invent-state")
289 
290  call invent_state(self,f_conf)
291 
292 
293 ! !TODO: This case requires the init_atmospher_core core_type to be
294 ! ! built as part of the MPAS library.
295 ! Case("mpas_init_case")
296 !
297 !!Would use init_atm_setup_case in MPAS-Release/src/core_init_atmosphere/mpas_init_atm_cases.F
298 !!mpas_init has already been called at this point from geo_setup
299 !
300 !!init_atms_setup_case is normally called from the following set of subroutines:
301 !!mpas_run => core_run [init_atm_core_run] => init_atm_setup_case => [select from preset cases]
302 !!Can we bypass the first two somehow?
303 !!Would use "config_init_case" in the yaml file, then check for matching with one of the ideal cases below... (not 7 or 8)
304 !
305 !!if ((config_init_case == 1) .or. (config_init_case == 2) .or. (config_init_case == 3)) then
306 !! write(0,*) ' Jablonowski and Williamson baroclinic wave test case '
307 !! if (config_init_case == 1) write(0,*) ' no initial perturbation '
308 !! if (config_init_case == 2) write(0,*) ' initial perturbation included '
309 !! if (config_init_case == 3) write(0,*) ' normal-mode perturbation included '
310 !!else if ((config_init_case == 4) .or. (config_init_case == 5)) then
311 !! write(0,*) ' squall line - super cell test case '
312 !! if (config_init_case == 4) write(0,*) ' squall line test case'
313 !! if (config_init_case == 5) write(0,*) ' supercell test case'
314 !! else if (config_init_case == 6 ) then
315 !! write(0,*) ' mountain wave test case '
316 !!else if (config_init_case == 7 ) then
317 !! write(0,*) ' real-data GFS test case '
318 !!else if (config_init_case == 8 ) then
319 !! write(0,*) 'real-data surface (SST) update test case '
320 !
321 ! ierr = init_atm_core_run(geom % domain)
322 ! if ( ierr .ne. 0 ) then
323 ! call abor1_ftn("mpas_state: init_atm_core_run failed")
324 ! end if
325 
326  Case ("dcmip-test-1-1")
327  do ii = 1, geom%nCellsSolve
328  rlat = geom%latCell(ii)
329  rlon = geom%lonCell(ii)
330 
331  ! Now loop over all levels
332  do jlev = 1, geom%nVertLevels
333 
334  zhalf = mpas_jedi_half_kr * (geom%zgrid(jlev,ii) + geom%zgrid(jlev+1,ii))
335  Call test1_advection_deformation(rlon,rlat,pk,zhalf,1,u0,v0,w0,t0,&
336  phis0,ps0,rho0,hum0,q1,q2,q3,q4)
337  p_ptr(jlev,ii) = pk
338 
339  u_ptr(jlev,ii) = u0 !MMiesch: ATTN Not going to necessary keep a-grid winds, u can be either a-
340  v_ptr(jlev,ii) = v0 ! or staggered-grid so this needs to be generic. You cannot drive the model
341  ! with A grid winds
342  if (index_qv.gt.0) qv_ptr(jlev,ii) = hum0 !set to zero for this test
343  if (index_qc.gt.0) qc_ptr(jlev,ii) = q1
344  if (index_qi.gt.0) qi_ptr(jlev,ii) = q2
345  if (index_qr.gt.0) qr_ptr(jlev,ii) = q3
346  if (index_qs.gt.0) qs_ptr(jlev,ii) = q4
347 
348  temperature_ptr(jlev,ii) = t0
349  enddo
350  ps_ptr(ii) = ps0
351  enddo
352 
353  Case ("dcmip-test-1-2")
354 
355  do ii = 1, geom%nCellsSolve
356  rlat = geom%latCell(ii)
357  rlon = geom%lonCell(ii)
358 
359  ! Now loop over all levels
360  do jlev = 1, geom%nVertLevels
361 
362  zhalf = mpas_jedi_half_kr * (geom%zgrid(jlev,ii) + geom%zgrid(jlev+1,ii))
363  Call test1_advection_hadley(rlon,rlat,pk,zhalf,1,u0,v0,w0,&
364  t0,phis0,ps0,rho0,hum0,q1)
365  p_ptr(jlev,ii) = pk
366 
367  u_ptr(jlev,ii) = u0 !MMiesch: ATTN Not going to necessary keep a-grid winds, u can be either a-
368  v_ptr(jlev,ii) = v0 ! or staggered-grid so this needs to be generic. You cannot drive the model
369  ! with A grid winds
370  if (index_qv.gt.0) qv_ptr(jlev,ii) = hum0 !set to zero for this test
371  if (index_qc.gt.0) qc_ptr(jlev,ii) = q1
372 
373  if (index_qi.gt.0) qi_ptr(jlev,ii) = 0._kind_real
374  if (index_qr.gt.0) qr_ptr(jlev,ii) = 0._kind_real
375  if (index_qs.gt.0) qs_ptr(jlev,ii) = 0._kind_real
376 
377  temperature_ptr(jlev,ii) = t0
378  enddo
379  ps_ptr(ii) = ps0
380  enddo
381 
382  Case ("dcmip-test-3-1")
383 
384  do ii = 1, geom%nCellsSolve
385  rlat = geom%latCell(ii)
386  rlon = geom%lonCell(ii)
387 
388  ! Now loop over all levels
389  do jlev = 1, geom%nVertLevels
390 
391  zhalf = mpas_jedi_half_kr * (geom%zgrid(jlev,ii) + geom%zgrid(jlev+1,ii))
392  Call test3_gravity_wave(rlon,rlat,pk,zhalf,1,u0,v0,w0,&
393  t0,phis0,ps0,rho0,hum0)
394 
395  p_ptr(jlev,ii) = pk
396  u_ptr(jlev,ii) = u0 !MMiesch: ATTN Not going to necessary keep a-grid winds, u can be either a-
397  v_ptr(jlev,ii) = v0 ! or staggered-grid so this needs to be generic. You cannot drive the model
398  ! with A grid winds
399 
400  if (index_qv.gt.0) qv_ptr(jlev,ii) = hum0 !set to zero for this test
401  if (index_qc.gt.0) qc_ptr(jlev,ii) = 0._kind_real
402  if (index_qi.gt.0) qi_ptr(jlev,ii) = 0._kind_real
403  if (index_qr.gt.0) qr_ptr(jlev,ii) = 0._kind_real
404  if (index_qs.gt.0) qs_ptr(jlev,ii) = 0._kind_real
405 
406  temperature_ptr(jlev,ii) = t0
407  enddo
408  ps_ptr(ii) = ps0
409  enddo
410 
411  Case ("dcmip-test-4-0")
412 
413  do ii = 1, geom%nCellsSolve
414  rlat = geom%latCell(ii)
415  rlon = geom%lonCell(ii)
416 
417  ! Now loop over all levels
418  do jlev = 1, geom%nVertLevels
419 
420  zhalf = mpas_jedi_half_kr * (geom%zgrid(jlev,ii) + geom%zgrid(jlev+1,ii))
421  Call test4_baroclinic_wave(0,mpas_jedi_one_kr,rlon,rlat,pk,zhalf,1,u0,v0,w0,&
422  t0,phis0,ps0,rho0,hum0,q1,q2)
423 
424  p_ptr(jlev,ii) = pk
425 
426  u_ptr(jlev,ii) = u0 !MMiesch: ATTN Not going to necessary keep a-grid winds, u can be either a-
427 
428  v_ptr(jlev,ii) = v0 ! or staggered-grid so this needs to be generic. You cannot drive the model
429  ! with A grid winds
430 
431  if (index_qv.gt.0) qv_ptr(jlev,ii) = hum0 !set to zero for this test
432  if (index_qc.gt.0) qc_ptr(jlev,ii) = 0._kind_real
433  if (index_qi.gt.0) qi_ptr(jlev,ii) = 0._kind_real
434  if (index_qr.gt.0) qr_ptr(jlev,ii) = 0._kind_real
435  if (index_qs.gt.0) qs_ptr(jlev,ii) = 0._kind_real
436 
437  temperature_ptr(jlev,ii) = t0
438  enddo
439  ps_ptr(ii) = ps0
440  enddo
441 
442  Case Default
443 
444  call invent_state(self,f_conf)
445 
446  End Select int_option
447 
448  call da_copy_all2sub_fields(self % geom % domain, self % subFields)
449 
450  call fckit_log%debug ('==> end mpas_state:analytic_init')
451 
452 end subroutine analytic_ic
453 
454 ! ------------------------------------------------------------------------------
455 
456 subroutine invent_state(self,f_conf)
457 
458  implicit none
459 
460  class(mpas_fields), intent(inout) :: self !< Model fields
461  type(fckit_configuration), intent(in) :: f_conf !< Configuration structure
462  real (kind=kind_real), dimension(:,:), pointer :: r2d_ptr_a, r2d_ptr_b
463  real (kind=kind_real), dimension(:), pointer :: r1d_ptr_a, r1d_ptr_b
464  integer :: jlev,ii
465  type (mpas_pool_type), pointer :: pool_a, state
466  type (field3dreal), pointer :: field3d
467  integer, pointer :: index_qv
468 
469  !- read/interp.
470 
471  call mpas_pool_get_subpool(self % geom % domain % blocklist % structs, &
472  'state', state)
473  pool_a => self % geom % domain % blocklist % allFields
474 
475  !Diagnostic vars (diag pool)
476  !u
477  call mpas_pool_get_array(pool_a, "uReconstructZonal", r2d_ptr_a)
478  do jlev = 1,self % geom % nVertLevels
479  do ii = 1, self % geom % nCellsSolve
480  r2d_ptr_a(jlev,ii) = cos(0.25*self % geom % lonEdge(ii)) + cos(0.25*self % geom % latEdge(ii))
481  enddo
482  enddo
483 
484  !v
485  call mpas_pool_get_array(pool_a, "uReconstructMeridional", r2d_ptr_a)
486  do jlev = 1,self % geom % nVertLevels
487  do ii = 1, self % geom % nCellsSolve
488  r2d_ptr_a(jlev,ii) = mpas_jedi_one_kr
489  enddo
490  enddo
491 
492  !temperature
493  call mpas_pool_get_array(pool_a, "temperature", r2d_ptr_a)
494  do jlev = 1,self % geom % nVertLevels
495  do ii = 1, self % geom % nCellsSolve
496  r2d_ptr_a(jlev,ii) = cos(0.25*self % geom % lonCell(ii)) + cos(0.25*self % geom % latCell(ii))
497  enddo
498  enddo
499 
500  !pressure
501  call mpas_pool_get_array(pool_a, "pressure", r2d_ptr_a)
502  do jlev = 1,self % geom % nVertLevels
503  do ii = 1, self % geom % nCellsSolve
504  r2d_ptr_a(jlev,ii) = real(jlev,kind_real)
505  enddo
506  enddo
507 
508  !surface_pressure
509  call mpas_pool_get_array(pool_a, "surface_pressure", r1d_ptr_a)
510  do ii = 1, self % geom % nCellsSolve
511  r1d_ptr_a(ii) = mpas_jedi_one_kr
512  enddo
513  !Scalars (state pool)
514  !qv
515  call mpas_pool_get_field(pool_a, 'scalars', field3d)
516  call mpas_pool_get_dimension(state, 'index_qv', index_qv)
517  if ( index_qv .gt. 0 ) then
518  r2d_ptr_a => field3d % array(index_qv,:,:)
519  do jlev = 1,self % geom % nVertLevels
520  do ii = 1, self % geom % nCellsSolve
521  r2d_ptr_a(jlev,ii) = mpas_jedi_zero_kr
522  enddo
523  enddo
524  end if
525 
526  return
527 
528 end subroutine invent_state
529 
530 ! ------------------------------------------------------------------------------
531 
532 end module mpas_state_mod
elemental subroutine, public q_to_w(specific_humidity, mixing_ratio)
subroutine, public hydrostatic_balance(ncells, nlevels, zw, t, qv, ps, p, rho, theta)
subroutine, public da_posdef(pool_a, fld_select)
Performs A = max(0.,A) for pool A.
subroutine, public da_operator(kind_op, pool_a, pool_b, pool_c, fld_select)
Performs A = A 'kind_op' B for pools A and B.
subroutine, public da_copy_all2sub_fields(domain, pool_a)
Performs a copy of allfield to a sub pool A.
subroutine, public uv_cell_to_edges(domain, u_field, v_field, du, lonCell, latCell, nCells, edgeNormalVectors, nEdgesOnCell, edgesOnCell, nVertLevels)
real(kind=kind_real), parameter mpas_jedi_half_kr
real(kind=kind_real), parameter mpas_jedi_zero_kr
real(kind=kind_real), parameter mpas_jedi_one_kr
character(len=maxvarlen), dimension(2), parameter, public cellcenteredwindfields
character(len=maxvarlen), dimension(4), parameter, public modelthermofields
character(len=maxvarlen), dimension(6), public mpas_hydrometeor_fields
character(len=maxvarlen), dimension(2), parameter, public moisturefields
character(len=maxvarlen), dimension(2), parameter, public analysisthermofields
subroutine, public invent_state(self, f_conf)
subroutine, public add_incr(self, increment)
add increment to state
subroutine, public analytic_ic(self, geom, f_conf, vdate)
Analytic Initialization for the MPAS Model.
Fortran derived type to hold MPAS field.
Fortran derived type to hold geometry definition.