MPAS-JEDI
mpas2ufo_vars_mod.F90
Go to the documentation of this file.
1 !***********************************************************************
2 ! Copyright (c) 2018, National Atmospheric for Atmospheric Research (NCAR).
3 !
4 ! Unless noted otherwise source code is licensed under the BSD license.
5 ! Additional copyright and license information can be found in the LICENSE file
6 ! distributed with this code, or at http://mpas-dev.github.com/license.html
7 !
8 !-----------------------------------------------------------------------
9 
11 
12 !***********************************************************************
13 !
14 ! Module mpas2ufo_vars_mod to convert/extract variables from MPAS
15 ! needed for Data assimilation purpose.
16 !> \author Gael Descombes/Mickael Duda NCAR/MMM
17 !> \date Februray 2018
18 !
19 !-----------------------------------------------------------------------
20 
21 use fckit_log_module, only : fckit_log
22 
23 !oops
24 use kinds, only : kind_real
25 
26 !ufo
27 use gnssro_mod_transform, only: geometric2geop
28 use ufo_vars_mod
29 
30 !MPAS-Model
31 use atm_core
32 !use mpas_abort, only : mpas_dmpar_global_abort
33 use mpas_constants, only : gravity, rgas, rv, cp
34 !use mpas_dmpar
35 use mpas_derived_types
36 use mpas_field_routines
37 use mpas_pool_routines
38 
39 !MPAS-JEDI
41 use mpas_geom_mod
42 use mpas_kinds, only : kind_double
43 
44 implicit none
45 
46 private
47 
48 ! public variable conversions
49 ! model2analysis
50 public :: theta_to_temp, &
51  w_to_q
52 
53 ! analysis2model
54 public :: hydrostatic_balance
55 
56 ! model2geovars only
57 public :: effectrad_graupel, &
59 public :: pressure_half_to_full
62 !public :: uv_to_wdir
63 
64 ! model2geovars+tlad
65 public :: q_to_w, &
66  tw_to_tv, &
68 public :: tw_to_tv_tl, tw_to_tv_ad, &
71 
72 
73 ! unknown purpose
74 !public :: twp_to_rho, temp_to_theta
75 
76 ! for fckit_log
77 integer, parameter :: max_string=8000
78 character(max_string) :: message
79 
80 contains
81 
82 !-------------------------------------------------------------------------------------------
83 
84 !-- from WRFDA/da_crtm.f90
85 integer function convert_type_soil(type_in)
86  integer, intent(in) :: type_in
87  integer, parameter :: n_soil_type = 16 ! wrf num_soil_cat
88  integer, parameter :: wrf_to_crtm_soil(n_soil_type) = &
89  (/ 1, 1, 4, 2, 2, 8, 7, 2, 6, 5, 2, 3, 8, 1, 6, 9 /)
90 
91  ! CRTM soil types in crtm/src/SfcOptics/CRTM_MW_Land_SfcOptics.f90
92  ! INTEGER, PARAMETER :: COARSE = 1
93  ! INTEGER, PARAMETER :: MEDIUM = 2
94  ! INTEGER, PARAMETER :: FINE = 3
95  ! INTEGER, PARAMETER :: COARSE_MEDIUM = 4
96  ! INTEGER, PARAMETER :: COARSE_FINE = 5
97  ! INTEGER, PARAMETER :: MEDIUM_FINE = 6
98  ! INTEGER, PARAMETER :: COARSE_MED_FINE = 7
99  ! INTEGER, PARAMETER :: ORGANIC = 8
100  ! Note: 9 corresponds to glacial soil, for which the land fraction
101  ! must be equal to zero.
102 
103  convert_type_soil = max( 1, wrf_to_crtm_soil(type_in) )
104 
105 end function convert_type_soil
106 
107 integer function convert_type_veg(type_in)
108  integer, intent(in) :: type_in
109  integer, parameter :: usgs_n_type = 24
110  integer, parameter :: igbp_n_type = 20
111 
112  ! CRTM vegetation types in crtm/src/SfcOptics/CRTM_MW_Land_SfcOptics.f90
113  ! INTEGER, PARAMETER :: BROADLEAF_EVERGREEN_TREES = 1
114  ! INTEGER, PARAMETER :: BROADLEAF_DECIDUOUS_TREES = 2
115  ! INTEGER, PARAMETER :: BROADLEAF_NEEDLELEAF_TREES = 3
116  ! INTEGER, PARAMETER :: NEEDLELEAF_EVERGREEN_TREES = 4
117  ! INTEGER, PARAMETER :: NEEDLELEAF_DECIDUOUS_TREES = 5
118  ! INTEGER, PARAMETER :: BROADLEAF_TREES_GROUNDCOVER = 6
119  ! INTEGER, PARAMETER :: GROUNDCOVER = 7
120  ! INTEGER, PARAMETER :: GROADLEAF_SHRUBS_GROUNDCOVER = 8
121  ! INTEGER, PARAMETER :: BROADLEAF_SHRUBS_BARE_SOIL = 9
122  ! INTEGER, PARAMETER :: DWARF_TREES_SHRUBS_GROUNDCOVER = 10
123  ! INTEGER, PARAMETER :: BARE_SOIL = 11
124  ! INTEGER, PARAMETER :: CULTIVATIONS = 12
125  ! Note: 13 corresponds to glacial vegetation, for which the land fraction
126  ! must be equal to zero.
127 
128  ! vegetation type mapping for GFS classification scheme
129  ! REL-2.1.3.CRTM_User_Guide.pdf table 4.16
130  integer, parameter :: usgs_to_crtm_mw(usgs_n_type) = &
131  (/ 7, 12, 12, 12, 12, 12, 7, 9, 8, 6, &
132  2, 5, 1, 4, 3, 0, 8, 8, 11, 10, &
133  10, 10, 11, 13 /)
134  integer, parameter :: igbp_to_crtm_mw(igbp_n_type) = &
135  (/ 4, 1, 5, 2, 3, 8, 9, 6, 6, 7, &
136  8, 12, 7, 12, 13, 11, 0, 10, 10, 11 /)
137 
138  !TODO: make this general: consider both dataset, usgs & igbp
139  convert_type_veg = max( 1, usgs_to_crtm_mw(type_in) )
140 
141 end function convert_type_veg
142 
143 ! !-- from GSI/crtm_interface.f90
144 ! integer(i_kind), parameter :: USGS_N_TYPES = 24
145 ! integer(i_kind), parameter :: IGBP_N_TYPES = 20
146 ! integer(i_kind), parameter :: NAM_SOIL_N_TYPES = 16
147 ! integer(i_kind), parameter, dimension(1:IGBP_N_TYPES) :: igbp_to_gfs=(/4, &
148 ! 1, 5, 2, 3, 8, 9, 6, 6, 7, 8, 12, 7, 12, 13, 11, 0, 10, 10, 11/)
149 ! integer(i_kind), parameter, dimension(1:USGS_N_TYPES) :: usgs_to_gfs=(/7, &
150 ! 12, 12, 12, 12, 12, 7, 9, 8, 6, 2, 5, 1, 4, 3, 0, 8, 8, 11, 10, 10, &
151 ! 10, 11, 13/)
152 ! integer(i_kind), parameter, dimension(1:NAM_SOIL_N_TYPES) :: nmm_soil_to_crtm=(/1, &
153 ! 1, 4, 2, 2, 8, 7, 2, 6, 5, 2, 3, 8, 1, 6, 9/)
154 
155 !-------------------------------------------------------------------------------------------
156 
157 !!-from subroutine call_crtm in GSI/crtm_interface.f90
158 !subroutine uv_to_wdir(uu5, vv5, wind10_direction)
159 !
160 ! implicit none
161 !
162 ! real (kind=kind_real), intent(in) :: uu5, vv5
163 ! real (kind=kind_real), intent(out) :: wind10_direction
164 ! real (kind=kind_real) :: windratio, windangle
165 ! integer :: iquadrant
166 ! real(kind=kind_real),parameter:: windscale = 999999.0_kind_real
167 ! real(kind=kind_real),parameter:: windlimit = 0.0001_kind_real
168 ! real(kind=kind_real),parameter:: quadcof (4, 2 ) = &
169 ! reshape((/MPAS_JEDI_ZERO_kr, MPAS_JEDI_ONE_kr, MPAS_JEDI_ONE_kr, MPAS_JEDI_TWO_kr, &
170 ! MPAS_JEDI_ONE_kr, -MPAS_JEDI_ONE_kr, MPAS_JEDI_ONE_kr, -MPAS_JEDI_ONE_kr/), (/4, 2/))
171 !
172 ! if (uu5 >= MPAS_JEDI_ZERO_kr .and. vv5 >= MPAS_JEDI_ZERO_kr) iquadrant = 1
173 ! if (uu5 >= MPAS_JEDI_ZERO_kr .and. vv5 < MPAS_JEDI_ZERO_kr) iquadrant = 2
174 ! if (uu5 < MPAS_JEDI_ZERO_kr .and. vv5 >= MPAS_JEDI_ZERO_kr) iquadrant = 4
175 ! if (uu5 < MPAS_JEDI_ZERO_kr .and. vv5 < MPAS_JEDI_ZERO_kr) iquadrant = 3
176 ! if (abs(vv5) >= windlimit) then
177 ! windratio = uu5 / vv5
178 ! else
179 ! windratio = MPAS_JEDI_ZERO_kr
180 ! if (abs(uu5) > windlimit) then
181 ! windratio = windscale * uu5
182 ! endif
183 ! endif
184 ! windangle = atan(abs(windratio)) ! wind azimuth is in radians
185 ! wind10_direction = ( quadcof(iquadrant, 1) * MPAS_JEDI_PII_kr + windangle * quadcof(iquadrant, 2) )
186 !
187 !end subroutine uv_to_wdir
188 
189 !-------------------------------------------------------------------------------------------
190 elemental subroutine w_to_q(mixing_ratio, specific_humidity)
191  implicit none
192  real (kind=kind_real), intent(in) :: mixing_ratio
193  real (kind=kind_real), intent(out) :: specific_humidity
194 
195  specific_humidity = mixing_ratio / (mpas_jedi_one_kr + mixing_ratio)
196 end subroutine w_to_q
197 !-------------------------------------------------------------------------------------------
198 elemental subroutine q_to_w(specific_humidity, mixing_ratio)
199  implicit none
200  real (kind=kind_real), intent(in) :: specific_humidity
201  real (kind=kind_real), intent(out) :: mixing_ratio
202 
203  mixing_ratio = specific_humidity / (mpas_jedi_one_kr - specific_humidity)
204 end subroutine q_to_w
205 !-------------------------------------------------------------------------------------------
206 elemental subroutine q_to_w_tl(specific_humidity_tl, sh_traj, mixing_ratio_tl)
207  implicit none
208  real (kind=kind_real), intent(in) :: specific_humidity_tl
209  real (kind=kind_real), intent(in) :: sh_traj
210  real (kind=kind_real), intent(out) :: mixing_ratio_tl
211 
212  mixing_ratio_tl = specific_humidity_tl / (mpas_jedi_one_kr - sh_traj)**2
213 end subroutine q_to_w_tl
214 !-------------------------------------------------------------------------------------------
215 elemental subroutine q_to_w_ad(specific_humidity_ad, sh_traj, mixing_ratio_ad)
216  implicit none
217  real (kind=kind_real), intent(inout) :: specific_humidity_ad
218  real (kind=kind_real), intent(in) :: sh_traj
219  real (kind=kind_real), intent(in) :: mixing_ratio_ad
220 
221  specific_humidity_ad = specific_humidity_ad + &
222  mpas_jedi_one_kr / ( mpas_jedi_one_kr - sh_traj)**2 * mixing_ratio_ad
223 end subroutine q_to_w_ad
224 !-------------------------------------------------------------------------------------------
225 elemental subroutine tw_to_tv(temperature,mixing_ratio,virtual_temperature)
226  implicit none
227  real (kind=kind_real), intent(in) :: temperature
228  real (kind=kind_real), intent(in) :: mixing_ratio
229  real (kind=kind_real), intent(out) :: virtual_temperature
230 
231  virtual_temperature = temperature * &
232  ( mpas_jedi_one_kr + (rv/rgas - mpas_jedi_one_kr)*mixing_ratio )
233 end subroutine tw_to_tv
234 !-------------------------------------------------------------------------------------------
235 elemental subroutine tw_to_tv_tl(temperature_tl,mixing_ratio_tl,t_traj,m_traj,virtual_temperature_tl)
236  implicit none
237  real (kind=kind_real), intent(in) :: temperature_tl
238  real (kind=kind_real), intent(in) :: mixing_ratio_tl
239  real (kind=kind_real), intent(in) :: t_traj
240  real (kind=kind_real), intent(in) :: m_traj
241  real (kind=kind_real), intent(out) :: virtual_temperature_tl
242 
243  virtual_temperature_tl = temperature_tl * &
244  ( mpas_jedi_one_kr + (rv/rgas - mpas_jedi_one_kr)*m_traj ) + &
245  t_traj * (rv/rgas - mpas_jedi_one_kr)*mixing_ratio_tl
246 end subroutine tw_to_tv_tl
247 !-------------------------------------------------------------------------------------------
248 elemental subroutine tw_to_tv_ad(temperature_ad,mixing_ratio_ad,t_traj,m_traj,virtual_temperature_ad)
249  implicit none
250  real (kind=kind_real), intent(inout) :: temperature_ad
251  real (kind=kind_real), intent(inout) :: mixing_ratio_ad
252  real (kind=kind_real), intent(in) :: t_traj
253  real (kind=kind_real), intent(in) :: m_traj
254  real (kind=kind_real), intent(in) :: virtual_temperature_ad
255 
256  temperature_ad = temperature_ad + virtual_temperature_ad * &
257  ( mpas_jedi_one_kr + (rv/rgas - mpas_jedi_one_kr)*m_traj )
258  mixing_ratio_ad = mixing_ratio_ad + virtual_temperature_ad * &
259  t_traj * (rv/rgas - mpas_jedi_one_kr)
260 end subroutine tw_to_tv_ad
261 !-------------------------------------------------------------------------------------------
262 elemental subroutine theta_to_temp(theta,pressure,temperature)
263  implicit none
264  real (kind=kind_real), intent(in) :: theta
265  real (kind=kind_real), intent(in) :: pressure
266  real (kind=kind_real), intent(out) :: temperature
267  temperature = theta / &
268  ( mpas_jedi_p0_kr / pressure ) ** ( rgas / cp )
269  !TODO: Following formula would give the same result with the formular above,
270  ! but gives a slightly different precision. Need to check.
271  !temperature = theta * &
272  ! ( pressure / MPAS_JEDI_P0_kr ) ** ( rgas / cp )
273 end subroutine theta_to_temp
274 !-------------------------------------------------------------------------------------------
275 !elemental subroutine temp_to_theta(temperature,pressure,theta)
276 ! implicit none
277 ! real (kind=kind_real), intent(in) :: temperature
278 ! real (kind=kind_real), intent(in) :: pressure
279 ! real (kind=kind_real), intent(out) :: theta
280 ! theta = temperature * &
281 ! ( MPAS_JEDI_P0_kr / pressure ) ** ( rgas / cp )
282 !end subroutine temp_to_theta
283 !-------------------------------------------------------------------------------------------
284 !elemental subroutine twp_to_rho(temperature,mixing_ratio,pressure,rho)
285 ! implicit none
286 ! real (kind=kind_real), intent(in) :: temperature
287 ! real (kind=kind_real), intent(in) :: mixing_ratio
288 ! real (kind=kind_real), intent(in) :: pressure
289 ! real (kind=kind_real), intent(out) :: rho
290 ! rho = pressure / ( rgas * temperature * &
291 ! ( MPAS_JEDI_ONE_kr + (rv/rgas) * mixing_ratio ) )
292 !end subroutine twp_to_rho
293 !-------------------------------------------------------------------------------------------
294 subroutine pressure_half_to_full(pressure, zgrid, surface_pressure, nC, nV, pressure_f)
295  implicit none
296  real (kind=kind_real), dimension(nV,nC), intent(in) :: pressure
297  real (kind=kind_real), dimension(nV+1,nC), intent(in) :: zgrid
298  real (kind=kind_real), dimension(nC), intent(in) :: surface_pressure
299  integer, intent(in) :: nc, nv
300  real (kind=kind_real), dimension(nV+1,nC), intent(out) :: pressure_f
301 
302  real (kind=kind_real), dimension(nC,nV) :: fzm_p, fzp_p
303  real (kind=kind_real) :: tem1, z0, z1, z2, w1, w2
304  integer :: i, k, its, ite, kts, kte
305 
306  !-- ~/libs/MPAS-Release/src/core_atmosphere/physics/mpas_atmphys_manager.F >> dimension Line 644.
307  !-- ~/libs/MPAS-Release/src/core_atmosphere/physics/mpas_atmphys_interface.F >> formula Line 365.
308  !-- ~/libs/MPAS-Release/src/core_atmosphere/physics/mpas_atmphys_vars.F >> declarations
309  ! This routine needs to access GEOM (dimension, zgrid )
310  ! TODO: Check: ite = nCells?? nCellsSolve??? MPI consideration ???
311  ! Seems to be nCellsSolve
312  its=1 ; ite = nc
313  kts=1 ; kte = nv
314 
315  do k = kts+1,kte
316  do i = its,ite
317  tem1 = mpas_jedi_one_kr/(zgrid(k+1,i)- zgrid(k-1,i))
318  fzm_p(i,k) = ( zgrid(k,i)- zgrid(k-1,i)) * tem1
319  fzp_p(i,k) = ( zgrid(k+1,i)- zgrid(k,i)) * tem1
320  pressure_f(k,i) = fzm_p(i,k)*pressure(k,i) + fzp_p(i,k)*pressure(k-1,i)
321  enddo
322  enddo
323  k = kte+1
324  do i = its,ite
325  z0 = zgrid(k,i)
326  z1 = mpas_jedi_half_kr*(zgrid(k,i)+zgrid(k-1,i))
327  z2 = mpas_jedi_half_kr*(zgrid(k-1,i)+zgrid(k-2,i))
328  w1 = (z0-z2)/(z1-z2)
329  w2 = mpas_jedi_one_kr-w1
330  !use log of pressure to avoid occurrences of negative top-of-the-model pressure.
331  pressure_f(k,i) = exp( w1*log(pressure(k-1,i)) + w2*log(pressure(k-1,i)) )
332  enddo
333  k = kts
334  do i = its,ite
335  pressure_f(k,i) = surface_pressure(i)
336  enddo
337 
338 end subroutine pressure_half_to_full
339 !-------------------------------------------------------------------------------------------
340 subroutine hydrostatic_balance(ncells, nlevels, zw, t, qv, ps, p, rho, theta)
341 !---------------------------------------------------------------------------------------
342 ! Purpose:
343 ! Derive 3D pressure, dry air density, and dry potential temperature
344 ! from analyzed surface pressure, temperature, and water vapor mixing
345 ! ratio by applying hypsometric equation, equation of state, and
346 ! Poisson's equation from bottom to top.
347 ! Method:
348 ! 1. Vertical integral of pressure from half level k-1 to k is split
349 ! into two steps: step-1 does integral from half level k-1 to full
350 ! level k, followed by a step-2 integral from full level k to half level k.
351 ! Full-level Tv is derived using bilinear interpolation of half level Tv.
352 ! 2. Layer's virtual T: Tv = T * (1 + 0.608*Qv)
353 ! 3. Hypsometric Eq.: P(z2) = P(z1) * exp[-g*(z2-z1)/(Rd*Tv)]
354 ! 4. Eq. of State: rho_m = P/(Rd*Tv); rho_d = rho_m/(1+Qv). Add Qc/Qi/Qs/Qg?
355 ! 5. Poisson's Eq.: theta_d = T * (P0/P)^(Rd/cp)
356 ! References:
357 ! MPAS-A model user's guide version 7.0, Appendix C.2 for vertical grid.
358 !--------------------------------------------------------------------------
359  implicit none
360  integer, intent(in) :: ncells, nlevels
361  real (kind=kind_real), dimension(nlevels+1,ncells), intent(in) :: zw ! physical height m at w levels
362  real (kind=kind_real), dimension(nlevels,ncells), intent(in) :: t ! temperature, K
363  real (kind=kind_real), dimension(nlevels,ncells), intent(in) :: qv ! mixing ratio, kg/kg
364  real (kind=kind_real), dimension(ncells), intent(in) :: ps ! surface P, Pa
365  real (kind=kind_real), dimension(nlevels,ncells), intent(out) :: p ! 3D P, Pa
366  real (kind=kind_real), dimension(nlevels,ncells), intent(out) :: rho ! dry air density, kg/m^3
367  real (kind=kind_real), dimension(nlevels,ncells), intent(out) :: theta ! dry potential T, K
368 
369  integer :: icell, k
370  real (kind=kind_real) :: rvordm1 ! rv/rd - 1. = 461.6/287-1 ~= 0.60836
371  real (kind=kind_real), dimension(nlevels) :: tv_h ! half level virtual T
372  real (kind=kind_real), dimension(nlevels+1) :: pf ! full level pressure
373  real (kind=kind_real), dimension(nlevels) :: zu ! physical height at u level
374  real (kind=kind_real) :: tv_f, tv, w
375 
376  rvordm1 = rv/rgas - mpas_jedi_one_kr
377 
378  do icell=1,ncells
379 
380  k = 1 ! 1st half level
381  pf(k) = ps(icell) ! first full level P is at surface
382  zu(k) = mpas_jedi_half_kr * ( zw(k,icell) + zw(k+1,icell) )
383  tv_h(k) = t(k,icell) * ( mpas_jedi_one_kr + rvordm1*qv(k,icell) )
384 
385  ! integral from full level k to half level k
386  p(k,icell) = pf(k) * exp( -gravity * (zu(k)-zw(k,icell))/(rgas*tv_h(k)) )
387  rho(k,icell) = p(k,icell)/( rgas*tv_h(k)*(mpas_jedi_one_kr+qv(k,icell)) )
388  theta(k,icell) = t(k,icell) * ( mpas_jedi_p0_kr/p(k,icell) )**(rgas/cp)
389 
390  do k=2,nlevels ! loop over half levels
391 
392  ! half level physical height, zu(k-1) -> zw(k) -> zu(k)
393  zu(k) = mpas_jedi_half_kr * ( zw(k,icell) + zw(k+1,icell) )
394 
395  ! bilinear interpolation weight for value at the half level below the full level
396  w = ( zu(k) - zw(k,icell) )/( zu(k) - zu(k-1) )
397 
398  ! half level Tv
399  tv_h(k) = t(k, icell) * ( mpas_jedi_one_kr + rvordm1*qv(k, icell) )
400 
401  ! interpolate two half levels Tv to a full level Tv
402  tv_f = w * tv_h(k-1) + (mpas_jedi_one_kr - w) * tv_h(k)
403 
404  ! two-step integral from half level k-1 to k
405  !-----------------------------------------------------------
406 
407  ! step-1: tv used for integral from half level k-1 to full level k
408  tv = mpas_jedi_half_kr * ( tv_h(k-1) + tv_f )
409 
410  ! step-1: integral from half level k-1 to full level k, hypsometric Eq.
411  pf(k) = p(k-1,icell) * exp( -gravity * (zw(k,icell)-zu(k-1))/(rgas*tv) )
412 
413  ! step-2: tv used for integral from full level k to half level k
414  tv = mpas_jedi_half_kr * ( tv_h(k) + tv_f )
415 
416  ! step-2: integral from full level k to half level k
417  p(k,icell) = pf(k) * exp( -gravity * (zu(k)-zw(k,icell))/(rgas*tv) )
418 
419  !------------------------------------------------------------
420  ! dry air density at half level, equation of state
421  rho(k,icell) = p(k,icell)/( rgas*tv_h(k)*(mpas_jedi_one_kr+qv(k,icell)) )
422 
423  ! dry potential T at half level, Poisson's equation
424  theta(k,icell) = t(k,icell) * ( mpas_jedi_p0_kr/p(k,icell) )**(rgas/cp)
425 
426  end do
427  end do
428 
429 end subroutine hydrostatic_balance
430 !-------------------------------------------------------------------------------------------
431 subroutine geometricz_full_to_half(zgrid_f, nC, nV, zgrid)
432  implicit none
433  real (kind=kind_real), dimension(nV+1,nC), intent(in) :: zgrid_f
434  integer, intent(in) :: nc, nv
435  real (kind=kind_real), dimension(nV,nC), intent(out) :: zgrid
436  integer :: i, k
437 
438 ! calculate midpoint geometricZ:
439  do i=1,nc
440  do k=1,nv
441  zgrid(k,i) = ( zgrid_f(k,i) + zgrid_f(k+1,i) ) * mpas_jedi_half_kr
442  enddo
443  enddo
444 end subroutine geometricz_full_to_half
445 !-------------------------------------------------------------------------------------------
446 subroutine q_fields_forward(mqName, modelFields, qGeo, plevels, nCells, nVertLevels)
447 
448  implicit none
449 
450  character (len=*), intent(in) :: mqname
451  type (mpas_pool_type), pointer, intent(in) :: modelfields !< model state fields
452  type (field2dreal), pointer, intent(inout) :: qgeo !< geovar q field
453  real (kind=kind_real), intent(in) :: plevels(nvertlevels+1,ncells)
454  integer, intent(in) :: ncells !< number of grid cells
455  integer, intent(in) :: nvertlevels
456 
457  real (kind=kind_real), pointer :: qmodel(:,:)
458  real (kind=kind_real) :: kgkg_kgm2
459  integer :: i, k
460 
461  call mpas_pool_get_array(modelfields, mqname, qmodel) !- [kg/kg]
462  do i=1,ncells
463  do k=1,nvertlevels
464  kgkg_kgm2=( plevels(k,i)-plevels(k+1,i) ) / gravity !- Still bottom-to-top
465  qgeo % array(k,i) = qmodel(k,i) * kgkg_kgm2 !- [kg/kg] --> [kg/m**2]
466  enddo
467  enddo
468 
469  ! Ensure positive-definite mixing ratios
470  ! with respect to precision of crtm::CRTM_Parameters::ZERO.
471  ! Note: replacing MPAS_JEDI_GREATERZERO_kr with MPAS_JEDI_ZERO_kr
472  ! will cause some profiles to fail in CRTM.
473  ! TODO: this should be moved to the mpas_fields%read step
474  ! only other place it should be needed is add_incr (already there)
475  where(qgeo % array(:,1:ncells) < mpas_jedi_greaterzero_kr)
476  qgeo % array(:,1:ncells) = mpas_jedi_greaterzero_kr
477  end where
478 
479 end subroutine q_fields_forward
480 !-------------------------------------------------------------------------------------------
481 subroutine q_fields_tl(mqName, modelFields_tl, qGeo_tl, plevels, nCells, nVertLevels)
482 
483  implicit none
484 
485  character (len=*), intent(in) :: mqname
486  type (mpas_pool_type), pointer, intent(in) :: modelfields_tl !< model state fields
487  type (field2dreal), pointer, intent(inout) :: qgeo_tl !< geovar q field
488  real (kind=kind_real), intent(in) :: plevels(nvertlevels+1,ncells)
489  integer, intent(in) :: ncells !< number of grid cells
490  integer, intent(in) :: nvertlevels
491 
492  real (kind=kind_real), pointer :: qmodel_tl(:,:)
493  real (kind=kind_real) :: kgkg_kgm2
494  integer :: i, k
495 
496  call mpas_pool_get_array(modelfields_tl, mqname, qmodel_tl) !- [kg/kg]
497  do i=1,ncells
498  do k=1,nvertlevels
499  kgkg_kgm2=( plevels(k,i)-plevels(k+1,i) ) / gravity !- Still bottom-to-top
500  qgeo_tl%array(k,i) = qmodel_tl(k,i) * kgkg_kgm2
501  enddo
502  enddo
503 
504 end subroutine q_fields_tl
505 !-------------------------------------------------------------------------------------------
506 subroutine q_fields_ad(mqName, modelFields_ad, qGeo_ad, plevels, nCells, nVertLevels)
507 
508  implicit none
509 
510  character (len=*), intent(in) :: mqname
511  type (mpas_pool_type), pointer, intent(inout) :: modelfields_ad !< model state fields
512  type (field2dreal), pointer, intent(in) :: qgeo_ad !< geovar q field
513  real (kind=kind_real), intent(in) :: plevels(nvertlevels+1,ncells)
514  integer, intent(in) :: ncells !< number of grid cells
515  integer, intent(in) :: nvertlevels
516 
517  real (kind=kind_real), pointer :: qmodel_ad(:,:)
518  real (kind=kind_real) :: kgkg_kgm2
519  integer :: i, k
520 
521  call mpas_pool_get_array(modelfields_ad, mqname, qmodel_ad) !- [kg/kg]
522  do i=1,ncells
523  do k=1,nvertlevels
524  kgkg_kgm2=( plevels(k,i)-plevels(k+1,i) ) / gravity !- Still bottom-to-top
525  qmodel_ad(k,i) = qmodel_ad(k,i) + qgeo_ad % array(k,i) * kgkg_kgm2
526  enddo
527  enddo
528 
529 end subroutine q_fields_ad
530 !-------------------------------------------------------------------------------------------
531 real (kind=kind_real) function wgamma(y)
532 implicit none
533 real(kind=kind_real), intent(in) :: y
534 
535 wgamma = exp(gammln(y))
536 
537 end function wgamma
538 !-------------------------------------------------------------------------------------------
539 real (kind=kind_real) function gammln(xx)
540 implicit none
541 real(kind=kind_real), intent(in) :: xx
542 real(kind=kind_double), parameter :: stp = 2.5066282746310005_kind_double
543 real(kind=kind_double), parameter :: &
544  cof(6) = (/ 76.18009172947146_kind_double, -86.50532032941677_kind_double, &
545  24.01409824083091_kind_double, -1.231739572450155_kind_double, &
546  0.001208650973866179_kind_double, -0.000005395239384953_kind_double/)
547 real(kind=kind_double) :: ser,tmp,x,y
548 integer :: j
549 
550 x=real(xx,kind_double)
551 y=x
552 tmp=x+5.5_kind_double
553 tmp=(x+0.5_kind_double)*log(tmp)-tmp
554 ser=1.000000000190015_kind_double
555 do j=1,6
556  y=y+1.0_kind_double
557  ser=ser+cof(j)/y
558 end do
559 gammln=real(tmp+log(stp*ser/x),kind_real)
560 end function gammln
561 
562 !-------------------------------------------------------------------------------------------
563 subroutine effectrad_rainwater (qr, rho, nr, re_qr, mp_scheme, ngrid, nVertLevels)
564 !-----------------------------------------------------------------------
565 ! Compute radiation effective radii of rainwater for WSM6/Thompson microphysics.
566 ! These are consistent with microphysics equations.
567 ! References: WRF/phys/module_mp_wsm6.F
568 ! Lin, Y. L., Farley, R. D., & Orville, H. D. (1983). Bulk parameterization of the snow field in a cloud model. Journal of climate and applied meteorology, 22(6), 1065-1092.
569 ! WRF/phys/module_mp_thompson.F
570 ! Thompson, G., Rasmussen, R. M., & Manning, K. (2004). Explicit forecasts of winter precipitation using an improved bulk microphysics scheme. Part I: Description and sensitivity analysis. Monthly Weather Review, 132(2), 519-542.
571 ! Thompson, G., Field, P. R., Rasmussen, R. M., & Hall, W. D. (2008). Explicit forecasts of winter precipitation using an improved bulk microphysics scheme. Part II: Implementation of a new snow parameterization. Monthly Weather Review, 136(12), 5095-5115.
572 !-----------------------------------------------------------------------
573 
574 implicit none
575 
576 real(kind=kind_real), dimension( nVertLevels, ngrid ), intent(in) :: qr, rho
577 real(kind=kind_real), dimension( nVertLevels, ngrid ), intent(in) :: nr
578 integer, intent(in) :: ngrid, nvertlevels
579 character(len=StrKIND), intent(in) :: mp_scheme
580 real(kind=kind_real), dimension( nVertLevels, ngrid ), intent(out) :: re_qr
581 
582 !Local variables
583 ! constants
584 real(kind=kind_real), parameter :: denr = mpas_jedi_thousand_kr, n0r = 8.e6
585 real(kind=kind_real), parameter :: r1 = mpas_jedi_one_kr / &
588  r2 = mpas_jedi_one_kr / &
590 real(kind=kind_real), parameter :: mu_r = mpas_jedi_zero_kr
591 real(kind=kind_real), parameter :: am_r = mpas_jedi_pii_kr*denr/6.0_kind_real
592 real(kind=kind_real), parameter :: bm_r = mpas_jedi_three_kr
593 
594 real(kind=kind_double) :: lamdar
595 integer :: i, k
596 
597 real(kind=kind_real), dimension( nVertLevels, ngrid ) :: rqr, nr_rho
598 !For Thompson scheme
599 real(kind=kind_real) :: cre2,cre3,crg2,crg3,org2,obmr
600 !Generalized gamma distributions for rain
601 ! N(D) = N_0 * D**mu * exp(-lamda*D); mu=0 is exponential.
602 
603 !-----------------------------------------------------------------------
604 cre2 = mu_r + mpas_jedi_one_kr
605 cre3 = bm_r + mu_r + mpas_jedi_one_kr
606 crg2 = wgamma(cre2)
607 crg3 = wgamma(cre3)
608 org2 = mpas_jedi_one_kr/crg2
609 obmr = mpas_jedi_one_kr/bm_r
610 
611 do i = 1, ngrid
612  do k = 1, nvertlevels
613  rqr(k,i) = max(r1, qr(k,i)*rho(k,i))
614  enddo
615 enddo
616 
617 if (any(rqr > r1)) then
618  do i = 1, ngrid
619  do k = 1, nvertlevels
620  re_qr(k,i) = 99.e-6
621  if (rqr(k,i).le.r1) cycle
622  select case (trim(mp_scheme))
623  case ('mp_wsm6')
624  lamdar = sqrt(sqrt(mpas_jedi_pii_kr*denr*n0r/rqr(k,i)))
625  re_qr(k,i) = max(99.9d-6,min(1.5_kind_double/lamdar,1999.d-6))
626  case ('mp_thompson')
627  nr_rho(k,i) = max(r2, nr(k,i)*rho(k,i))
628  lamdar = (am_r*crg3*org2*nr_rho(k,i)/rqr(k,i))**obmr
629  re_qr(k,i) = max(99.9e-6, min(real(mpas_jedi_half_kr*(mpas_jedi_three_kr+mu_r),kind_double)/lamdar, 1999.e-6))
630  case default
631  re_qr(k,i) = 999.e-6
632  end select
633  enddo
634  enddo
635 endif
636 
637 end subroutine effectrad_rainwater
638 
639 !-------------------------------------------------------------------------------------------
640 subroutine effectrad_graupel (qg, rho, re_qg, mp_scheme, ngrid, nVertLevels)
641 
642 !-----------------------------------------------------------------------
643 ! Compute radiation effective radii of graupel for WSM6/Thompson microphysics.
644 ! These are consistent with microphysics equations.
645 ! References: WRF/phys/module_mp_wsm6.F
646 ! Lin, Y. L., Farley, R. D., & Orville, H. D. (1983). Bulk parameterization of the snow field in a cloud model. Journal of climate and applied meteorology, 22(6), 1065-1092.
647 ! WRF/phys/module_mp_thompson.F
648 ! Thompson, G., Rasmussen, R. M., & Manning, K. (2004). Explicit forecasts of winter precipitation using an improved bulk microphysics scheme. Part I: Description and sensitivity analysis. Monthly Weather Review, 132(2), 519-542.
649 ! Thompson, G., Field, P. R., Rasmussen, R. M., & Hall, W. D. (2008). Explicit forecasts of winter precipitation using an improved bulk microphysics scheme. Part II: Implementation of a new snow parameterization. Monthly Weather Review, 136(12), 5095-5115.
650 !-----------------------------------------------------------------------
651 
652 implicit none
653 
654 real(kind=kind_real), dimension( nVertLevels, ngrid ), intent(in) :: qg, rho
655 integer, intent(in) :: ngrid, nvertlevels
656 character (len=StrKIND), intent(in) :: mp_scheme
657 real(kind=kind_real), dimension( nVertLevels, ngrid ), intent(out):: re_qg
658 
659 !Local variables
660 integer :: i, k
661 real(kind=kind_double) :: lamdag, lam_exp, n0_exp
662 real(kind=kind_real) :: n0g, deng
663 real(kind=kind_real), parameter :: r1 = mpas_jedi_one_kr / &
666 real(kind=kind_real), dimension( nVertLevels, ngrid ):: rqg
667 !MPAS model set it as 0, WRF model set it through namelist
668 integer:: hail_opt = 0
669 ! for Thompson scheme
670 real(kind=kind_real) :: mu_g = mpas_jedi_zero_kr
671 real(kind=kind_real) :: obmg, cge1,cgg1,oge1,cge3,cgg3,ogg1,cge2,cgg2,ogg2
672 real(kind=kind_real) :: ygra1, zans1
673 real(kind=kind_real), parameter :: am_g = mpas_jedi_pii_kr*500.0_kind_real/6.0_kind_real
674 real(kind=kind_real), parameter :: bm_g = mpas_jedi_three_kr
675 
676 !-----------------------------------------------------------------------
677 obmg = mpas_jedi_one_kr/bm_g
678 cge1 = bm_g + mpas_jedi_one_kr
679 cgg1 = wgamma(cge1)
680 oge1 = mpas_jedi_one_kr/cge1
681 cge3 = bm_g + mu_g + mpas_jedi_one_kr
682 cgg3 = wgamma(cge3)
683 ogg1 = mpas_jedi_one_kr/cgg1
684 cge2 = mu_g + mpas_jedi_one_kr
685 cgg2 = wgamma(cge2)
686 ogg2 = mpas_jedi_one_kr/cgg2
687 
688 if (hail_opt .eq. 1) then
689  n0g = 4.e4
690  deng = 700.0_kind_real
691 else
692  n0g = 4.e6
693  deng = 500.0_kind_real
694 endif
695 
696 do i = 1, ngrid
697  do k = 1, nvertlevels
698  rqg(k,i) = max(r1, qg(k,i)*rho(k,i))
699  enddo
700 enddo
701 
702 if (any( rqg > r1 )) then
703  select case (trim(mp_scheme))
704  case ('mp_wsm6')
705  re_qg = 49.7e-6
706  do i = 1, ngrid
707  do k = 1, nvertlevels
708  if (rqg(k,i).le.r1) cycle
709  lamdag = sqrt(sqrt(mpas_jedi_pii_kr*deng*n0g/rqg(k,i)))
710  re_qg(k,i) = max(50.d-6,min(1.5_kind_double/lamdag,9999.d-6))
711  end do
712  end do
713  case ('mp_thompson')
714  re_qg = 99.5e-6
715  do i = 1, ngrid
716  do k = nvertlevels, 1, -1
717  if (rqg(k,i).le.r1) cycle
718  ygra1 = alog10(sngl(max(1.e-9, rqg(k,i))))
719  zans1 = (2.5_kind_real + 2.5_kind_real/7.0_kind_real * (ygra1+7.0_kind_real))
720  zans1 = max(mpas_jedi_two_kr, min(zans1, 7.0_kind_real)) ! new in WRF V4.2
721  n0_exp = 10.0_kind_real**(zans1)
722  lam_exp = (n0_exp*am_g*cgg1/rqg(k,i))**oge1
723  lamdag = lam_exp * (cgg3*ogg2*ogg1)**obmg ! we can simplify this without considering rainwater
724  re_qg(k,i) = max(99.9e-6, min(real(mpas_jedi_half_kr*(mpas_jedi_three_kr+mu_g),kind_double)/lamdag, 9999.e-6))
725  enddo
726  enddo
727  case default
728  re_qg = 600.e-6
729  end select
730 endif
731 
732 end subroutine effectrad_graupel
733 
734 !-------------------------------------------------------------------------------------------
735 
736 end module mpas2ufo_vars_mod
elemental subroutine, public q_to_w(specific_humidity, mixing_ratio)
integer function, public convert_type_soil(type_in)
subroutine, public pressure_half_to_full(pressure, zgrid, surface_pressure, nC, nV, pressure_f)
subroutine, public q_fields_tl(mqName, modelFields_tl, qGeo_tl, plevels, nCells, nVertLevels)
subroutine, public q_fields_ad(mqName, modelFields_ad, qGeo_ad, plevels, nCells, nVertLevels)
elemental subroutine, public q_to_w_tl(specific_humidity_tl, sh_traj, mixing_ratio_tl)
elemental subroutine, public q_to_w_ad(specific_humidity_ad, sh_traj, mixing_ratio_ad)
subroutine, public hydrostatic_balance(ncells, nlevels, zw, t, qv, ps, p, rho, theta)
real(kind=kind_real) function gammln(xx)
elemental subroutine, public tw_to_tv_tl(temperature_tl, mixing_ratio_tl, t_traj, m_traj, virtual_temperature_tl)
elemental subroutine, public tw_to_tv(temperature, mixing_ratio, virtual_temperature)
elemental subroutine, public w_to_q(mixing_ratio, specific_humidity)
subroutine, public geometricz_full_to_half(zgrid_f, nC, nV, zgrid)
subroutine, public effectrad_rainwater(qr, rho, nr, re_qr, mp_scheme, ngrid, nVertLevels)
integer, parameter max_string
integer function, public convert_type_veg(type_in)
elemental subroutine, public tw_to_tv_ad(temperature_ad, mixing_ratio_ad, t_traj, m_traj, virtual_temperature_ad)
subroutine, public effectrad_graupel(qg, rho, re_qg, mp_scheme, ngrid, nVertLevels)
subroutine, public q_fields_forward(mqName, modelFields, qGeo, plevels, nCells, nVertLevels)
elemental subroutine, public theta_to_temp(theta, pressure, temperature)
real(kind=kind_real) function wgamma(y)
character(max_string) message
real(kind=kind_real), parameter mpas_jedi_half_kr
real(kind=kind_real), parameter mpas_jedi_two_kr
real(kind=kind_real), parameter mpas_jedi_thousand_kr
real(kind=kind_real), parameter mpas_jedi_three_kr
real(kind=kind_real), parameter mpas_jedi_zero_kr
real(kind=kind_real), parameter mpas_jedi_p0_kr
real(kind=kind_real), parameter mpas_jedi_greaterzero_kr
real(kind=kind_real), parameter mpas_jedi_pii_kr
real(kind=kind_real), parameter mpas_jedi_million_kr
real(kind=kind_real), parameter mpas_jedi_one_kr
integer, parameter, public kind_double