SCALE-RM
Data Types | Functions/Subroutines | Variables
scale_atmos_hydrometeor Module Reference

module atmosphere / hydrometeor More...

Functions/Subroutines

subroutine, public atmos_hydrometeor_setup
 Setup. More...
 
subroutine, public atmos_hydrometeor_regist (NL, NI, NAME, DESC, UNIT, Q0, ADVC)
 ATMOS_HYDROMETEOR_regist Regist tracer. More...
 
subroutine atmos_hydrometeor_lhv_0d (temp, lhv)
 
subroutine atmos_hydrometeor_lhv_1d (KA, KS, KE, temp, lhv)
 
subroutine atmos_hydrometeor_lhs_1d (KA, KS, KE, temp, lhs)
 
subroutine atmos_hydrometeor_lhf_1d (KA, KS, KE, temp, lhf)
 
subroutine atmos_hydrometeor_entr_2d (IA, IS, IE, JA, JS, JE, TEMP, PRES, QV, QI, Qdry, Rtot, CPtot, entr)
 calc temp, pres, q -> entropy (2D) More...
 

Variables

logical, public atmos_hydrometeor_ice_phase
 
integer, public i_qv = -1
 
integer, parameter, public n_hyd = 6
 
integer, parameter, public i_hc = 1
 liquid water cloud More...
 
integer, parameter, public i_hr = 2
 liquid water rain More...
 
integer, parameter, public i_hi = 3
 ice water cloud More...
 
integer, parameter, public i_hs = 4
 snow More...
 
integer, parameter, public i_hg = 5
 graupel More...
 
integer, parameter, public i_hh = 6
 hail More...
 
character(len=h_short), dimension(n_hyd), parameter, public hyd_name = (/ "QC", "QR", "QI", "QS", "QG", "QH" /)
 
character(len=h_mid), dimension(n_hyd), parameter, public hyd_desc = (/ "cloud ", "rain ", "ice water", "snow ", "graupel ", "hail " /)
 
character(len=h_short), dimension(n_hyd), parameter, public num_name = (/ "NC", "NR", "NI", "NS", "NG", "NH" /)
 
real(rp), dimension(n_hyd), public hyd_dens
 
logical, public atmos_hydrometeor_dry = .true.
 
integer, public qha = 0
 
integer, public qhs = -1
 
integer, public qhe = -2
 
integer, public qla = 0
 
integer, public qls = -1
 
integer, public qle = -2
 
integer, public qia = 0
 
integer, public qis = -1
 
integer, public qie = -2
 
real(rp), public lhv
 latent heat of vaporization for use [J/kg] More...
 
real(rp), public lhs
 latent heat of sublimation for use [J/kg] More...
 
real(rp), public lhf
 latent heat of fusion for use [J/kg] More...
 
real(rp), public cv_vapor
 CV for vapor [J/kg/K]. More...
 
real(rp), public cp_vapor
 CP for vapor [J/kg/K]. More...
 
real(rp), public cv_water
 CV for water [J/kg/K]. More...
 
real(rp), public cp_water
 CP for water [J/kg/K]. More...
 
real(rp), public cv_ice
 CV for ice [J/kg/K]. More...
 
real(rp), public cp_ice
 CP for ice [J/kg/K]. More...
 

Detailed Description

module atmosphere / hydrometeor

Description
Hydrometeor module
Author
Team SCALE

Function/Subroutine Documentation

◆ atmos_hydrometeor_setup()

subroutine, public scale_atmos_hydrometeor::atmos_hydrometeor_setup ( )

Setup.

Definition at line 154 of file scale_atmos_hydrometeor.F90.

References scale_const::const_ci, scale_const::const_cl, scale_const::const_cpvap, scale_const::const_cvvap, scale_const::const_dice, scale_const::const_dwatr, scale_const::const_lhf0, scale_const::const_lhf00, scale_const::const_lhs0, scale_const::const_lhs00, scale_const::const_lhv0, scale_const::const_lhv00, scale_const::const_setup(), scale_const::const_thermodyn_type, cp_ice, cp_vapor, cp_water, cv_ice, cv_vapor, cv_water, hyd_dens, lhf, lhs, lhv, and scale_prc::prc_abort().

Referenced by scale_atmos_adiabat::atmos_adiabat_setup(), scale_atmos_saturation::atmos_saturation_setup(), mod_rm_driver::rm_driver(), and mod_rm_prep::rm_prep().

154  use scale_const, only: &
155  const_setup, &
156  cpvap => const_cpvap, &
157  cvvap => const_cvvap, &
158  cl => const_cl, &
159  ci => const_ci, &
160  lhv00 => const_lhv00, &
161  lhs00 => const_lhs00, &
162  lhf00 => const_lhf00, &
163  lhv0 => const_lhv0, &
164  lhs0 => const_lhs0, &
165  lhf0 => const_lhf0, &
166  dwatr => const_dwatr, &
167  dice => const_dice, &
168  thermodyn_type => const_thermodyn_type
169  use scale_prc, only: &
170  prc_abort
171  implicit none
172  !---------------------------------------------------------------------------
173 
174  if ( initialized ) return
175  initialized = .true.
176 
177  call const_setup
178 
179  log_newline
180  log_info("ATMOS_HYDROMETEOR_setup",*) 'Setup'
181 
182  if ( thermodyn_type == 'EXACT' ) then
183 
184  cv_vapor = cvvap
185  cp_vapor = cpvap
186  cv_water = cl
187  cp_water = cv_water
188  cv_ice = ci
189  cp_ice = cv_ice
190 
191  lhv = lhv00
192  lhs = lhs00
193  lhf = lhf00
194  thermodyn_emask = 1.0_rp
195 
196  elseif( thermodyn_type == 'SIMPLE' ) then
197 
198  cv_vapor = cvvap
199  cp_vapor = cpvap
200  cv_water = cvvap
201  cp_water = cv_water
202  cv_ice = cvvap
203  cp_ice = cv_ice
204 
205  lhv = lhv0
206  lhs = lhs0
207  lhf = lhf0
208  thermodyn_emask = 0.0_rp
209 
210  else
211  log_error("ATMOS_HYDROMETEOR_setup",*) 'Not appropriate ATMOS_THERMODYN_ENERGY_TYPE. Check!', trim(thermodyn_type)
212  call prc_abort
213  endif
214 
215  hyd_dens(:) = (/ dwatr, & ! HC
216  dwatr, & ! HR
217  dice, & ! HI
218  dice, & ! HS
219  dice, & ! HG
220  dice /) ! HH
221 
222  return
real(rp), parameter, public const_ci
specific heat (ice) [J/kg/K]
Definition: scale_const.F90:67
real(rp), parameter, public const_dwatr
density of water [kg/m3]
Definition: scale_const.F90:82
real(rp), parameter, public const_cl
specific heat (liquid water) [J/kg/K]
Definition: scale_const.F90:66
real(rp), public const_cvvap
specific heat (water vapor, constant volume) [J/kg/K]
Definition: scale_const.F90:65
real(rp), public const_lhf0
latent heat of fusion at 0C [J/kg]
Definition: scale_const.F90:79
real(rp), parameter, public const_dice
density of ice [kg/m3]
Definition: scale_const.F90:83
real(rp), parameter, public const_lhs0
latent heat of sublimation at 0C [J/kg]
Definition: scale_const.F90:77
real(rp), parameter, public const_lhv0
latent heat of vaporizaion at 0C [J/kg]
Definition: scale_const.F90:75
module PROCESS
Definition: scale_prc.F90:11
subroutine, public const_setup
Setup.
real(rp), public const_lhf00
latent heat of fusion at 0K [J/kg]
Definition: scale_const.F90:80
real(rp), public const_lhs00
latent heat of sublimation at 0K [J/kg]
Definition: scale_const.F90:78
real(rp), public const_lhv00
latent heat of vaporizaion at 0K [J/kg]
Definition: scale_const.F90:76
subroutine, public prc_abort
Abort Process.
Definition: scale_prc.F90:338
module CONSTANT
Definition: scale_const.F90:11
real(rp), parameter, public const_cpvap
specific heat (water vapor, constant pressure) [J/kg/K]
Definition: scale_const.F90:64
character(len=h_short), public const_thermodyn_type
internal energy type
Definition: scale_const.F90:96
Here is the call graph for this function:
Here is the caller graph for this function:

◆ atmos_hydrometeor_regist()

subroutine, public scale_atmos_hydrometeor::atmos_hydrometeor_regist ( integer, intent(in)  NL,
integer, intent(in)  NI,
character(len=*), dimension(1+nl+ni), intent(in)  NAME,
character(len=*), dimension(1+nl+ni), intent(in)  DESC,
character(len=*), dimension(1+nl+ni), intent(in)  UNIT,
integer, intent(out)  Q0,
logical, dimension(1+nl+ni), intent(in), optional  ADVC 
)

ATMOS_HYDROMETEOR_regist Regist tracer.

Parameters
[in]nlnumber of liquid water tracers
[in]ninumber of ice water tracers

Definition at line 237 of file scale_atmos_hydrometeor.F90.

References atmos_hydrometeor_dry, atmos_hydrometeor_ice_phase, scale_const::const_rvap, cp_ice, cp_vapor, cp_water, cv_ice, cv_vapor, cv_water, i_qv, scale_prc::prc_abort(), qha, qhe, qhs, qia, qie, qis, qla, qle, qls, and scale_tracer::tracer_regist().

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_tracer_setup().

237  use scale_prc, only: &
238  prc_abort
239  use scale_tracer, only: &
241  use scale_const, only: &
242  rvap => const_rvap
243  implicit none
244  integer, intent(in) :: nl
245  integer, intent(in) :: ni
246  character(len=*), intent(in) :: name(1+nl+ni)
247  character(len=*), intent(in) :: desc(1+nl+ni)
248  character(len=*), intent(in) :: unit(1+nl+ni)
249 
250  integer, intent(out) :: q0
251 
252  logical, intent(in), optional :: advc(1+nl+ni)
253 
254  real(RP) :: cv (1+nl+ni)
255  real(RP) :: cp (1+nl+ni)
256  real(RP) :: r (1+nl+ni)
257  logical :: mass (1+nl+ni)
258  logical :: advc_(1+nl+ni)
259 
260  integer :: nq
261  integer :: n
262  !---------------------------------------------------------------------------
263 
264  if ( .not. atmos_hydrometeor_dry ) then
265  log_error("ATMOS_HYDROMETEOR_regist",*) 'tracer for hydrometeor is already registerd'
266  call prc_abort
267  endif
268 
269  atmos_hydrometeor_dry = .false.
270 
271  nq = 0
272 
273  ! vapor
274  nq = nq + 1
275  cv(nq) = cv_vapor
276  cp(nq) = cp_vapor
277  r(nq) = rvap
278 
279  ! liquid
280  do n = 1, nl
281  nq = nq + 1
282  cv(nq) = cv_water
283  cp(nq) = cp_water
284  r(nq) = 0.0_rp
285  end do
286 
287  ! ice
288  do n = 1, ni
289  nq = nq + 1
290  cv(nq) = cv_ice
291  cp(nq) = cp_ice
292  r(nq) = 0.0_rp
293  end do
294 
295  ! NQ = 1 + NL + NI, vapor + liqid + ice
296 
297  if ( present(advc) ) then
298  advc_(:) = advc(:)
299  else
300  advc_(:) = .true.
301  endif
302 
303  do n = 1, nq
304  mass(n) = .true.
305  end do
306 
307  call tracer_regist( q0, & ! [OUT]
308  nq, & ! [IN]
309  name, & ! [IN]
310  desc, & ! [IN]
311  unit, & ! [IN]
312  cv, cp, r, & ! [IN], optional
313  advc_, mass ) ! [IN], optional
314 
315  i_qv = q0
316 
317  if ( nq > 1 ) then
318  qhs = q0 + 1
319  qha = nl + ni
320  qhe = qhs + qha - 1
321  endif
322 
323  if ( nl > 0 ) then
324  qls = q0 + 1
325  qla = nl
326  qle = qls + nl - 1
327  endif
328 
329  if ( ni > 0 ) then
330  qis = qle + 1
331  qia = ni
332  qie = qis + ni - 1
333  endif
334 
335  atmos_hydrometeor_ice_phase = qia > 0
336 
337  return
module TRACER
module PROCESS
Definition: scale_prc.F90:11
real(rp), parameter, public const_rvap
specific gas constant (water vapor) [J/kg/K]
Definition: scale_const.F90:63
subroutine, public prc_abort
Abort Process.
Definition: scale_prc.F90:338
module CONSTANT
Definition: scale_const.F90:11
subroutine, public tracer_regist(QS, NQ, NAME, DESC, UNIT, CV, CP, R, ADVC, MASS)
Regist tracer.
Here is the call graph for this function:
Here is the caller graph for this function:

◆ atmos_hydrometeor_lhv_0d()

subroutine scale_atmos_hydrometeor::atmos_hydrometeor_lhv_0d ( real(rp), intent(in)  temp,
real(rp), intent(out)  lhv 
)
Parameters
[in]temptemperature [K]
[out]lhvlatent heat of vaporization [J/kg]

Definition at line 344 of file scale_atmos_hydrometeor.F90.

References scale_const::const_lhv0, scale_const::const_tem00, cp_vapor, and cp_water.

Referenced by atmos_hydrometeor_lhv_1d().

344  use scale_const, only: &
345  tem00 => const_tem00, &
346  lhv0 => const_lhv0
347  implicit none
348  real(RP), intent(in) :: temp
349  real(RP), intent(out) :: lhv
350  !---------------------------------------------------------------------------
351 
352  lhv = lhv0 + ( cp_vapor - cp_water ) * ( temp - tem00 ) * thermodyn_emask
353 
354  return
real(rp), parameter, public const_tem00
temperature reference (0C) [K]
Definition: scale_const.F90:90
real(rp), parameter, public const_lhv0
latent heat of vaporizaion at 0C [J/kg]
Definition: scale_const.F90:75
module CONSTANT
Definition: scale_const.F90:11
Here is the caller graph for this function:

◆ atmos_hydrometeor_lhv_1d()

subroutine scale_atmos_hydrometeor::atmos_hydrometeor_lhv_1d ( integer, intent(in)  KA,
integer, intent(in)  KS,
integer, intent(in)  KE,
real(rp), dimension(ka), intent(in)  temp,
real(rp), dimension (ka), intent(out)  lhv 
)
Parameters
[in]temptemperature [K]
[out]lhvlatent heat of vaporization [J/kg]

Definition at line 363 of file scale_atmos_hydrometeor.F90.

References atmos_hydrometeor_lhv_0d(), scale_const::const_lhs0, scale_const::const_tem00, cp_ice, and cp_vapor.

363  implicit none
364  integer, intent(in) :: ka, ks, ke
365 
366  real(RP), intent(in) :: temp(ka)
367 
368  real(RP), intent(out) :: lhv (ka)
369 
370  integer :: k
371  !---------------------------------------------------------------------------
372 
373  do k = ks, ke
374  call atmos_hydrometeor_lhv_0d( temp(k), lhv(k) )
375  enddo
376 
377  return
integer, public ke
end point of inner domain: z, local
integer, public ks
start point of inner domain: z, local
integer, public ka
of whole cells: z, local, with HALO
Here is the call graph for this function:

◆ atmos_hydrometeor_lhs_1d()

subroutine scale_atmos_hydrometeor::atmos_hydrometeor_lhs_1d ( integer, intent(in)  KA,
integer, intent(in)  KS,
integer, intent(in)  KE,
real(rp), dimension(ka), intent(in)  temp,
real(rp), dimension (ka), intent(out)  lhs 
)
Parameters
[in]temptemperature [K]
[out]lhslatent heat of sublimation [J/kg]

Definition at line 457 of file scale_atmos_hydrometeor.F90.

References scale_const::const_lhf0, scale_const::const_tem00, cp_ice, and cp_water.

457  implicit none
458  integer, intent(in) :: ka, ks, ke
459 
460  real(RP), intent(in) :: temp(ka)
461 
462  real(RP), intent(out) :: lhs (ka)
463 
464  integer :: k
465  !---------------------------------------------------------------------------
466 
467  do k = ks, ke
468  call atmos_hydrometeor_lhs( temp(k), lhs(k) )
469  enddo
470 
471  return
integer, public ke
end point of inner domain: z, local
integer, public ks
start point of inner domain: z, local
integer, public ka
of whole cells: z, local, with HALO

◆ atmos_hydrometeor_lhf_1d()

subroutine scale_atmos_hydrometeor::atmos_hydrometeor_lhf_1d ( integer, intent(in)  KA,
integer, intent(in)  KS,
integer, intent(in)  KE,
real(rp), dimension(ka), intent(in)  temp,
real(rp), dimension (ka), intent(out)  lhf 
)
Parameters
[in]temptemperature [K]
[out]lhflatent heat of fusion [J/kg]

Definition at line 551 of file scale_atmos_hydrometeor.F90.

References scale_const::const_lhf0, scale_const::const_lhv0, scale_const::const_pre00, scale_const::const_psat0, scale_const::const_rdry, scale_const::const_rvap, and scale_const::const_tem00.

551  implicit none
552  integer, intent(in) :: ka, ks, ke
553 
554  real(RP), intent(in) :: temp(ka)
555  real(RP), intent(out) :: lhf (ka)
556 
557  integer :: k
558  !---------------------------------------------------------------------------
559 
560  do k = ks, ke
561  call atmos_hydrometeor_lhf( temp(k), lhf(k) )
562  enddo
563 
564  return
integer, public ke
end point of inner domain: z, local
integer, public ks
start point of inner domain: z, local
integer, public ka
of whole cells: z, local, with HALO

◆ atmos_hydrometeor_entr_2d()

subroutine scale_atmos_hydrometeor::atmos_hydrometeor_entr_2d ( integer, intent(in)  IA,
integer, intent(in)  IS,
integer, intent(in)  IE,
integer, intent(in)  JA,
integer, intent(in)  JS,
integer, intent(in)  JE,
real(rp), dimension (ia,ja), intent(in)  TEMP,
real(rp), dimension (ia,ja), intent(in)  PRES,
real(rp), dimension (ia,ja), intent(in)  QV,
real(rp), dimension (ia,ja), intent(in)  QI,
real(rp), dimension (ia,ja), intent(in)  Qdry,
real(rp), dimension (ia,ja), intent(in)  Rtot,
real(rp), dimension(ia,ja), intent(in)  CPtot,
real(rp), dimension(ia,ja), intent(out)  entr 
)

calc temp, pres, q -> entropy (2D)

Parameters
[in]temptemperature [K]
[in]prespressure [Pa]
[in]qvwater vapor mass concentration [kg/kg]
[in]qiice water mass concentration [kg/kg]
[in]qdrydry air mass concentration [kg/kg]
[in]rtotgas constant
[in]cptotspecific heat
[out]entrentropy [J/K]

Definition at line 671 of file scale_atmos_hydrometeor.F90.

References scale_const::const_lhf0, scale_const::const_lhv0, scale_const::const_pre00, scale_const::const_psat0, scale_const::const_rdry, scale_const::const_rvap, and scale_const::const_tem00.

671  implicit none
672  integer, intent(in) :: ia, is, ie
673  integer, intent(in) :: ja, js, je
674 
675  real(RP), intent(in) :: temp (ia,ja)
676  real(RP), intent(in) :: pres (ia,ja)
677  real(RP), intent(in) :: qv (ia,ja)
678  real(RP), intent(in) :: qi (ia,ja)
679  real(RP), intent(in) :: qdry (ia,ja)
680  real(RP), intent(in) :: rtot (ia,ja)
681  real(RP), intent(in) :: cptot(ia,ja)
682 
683  real(RP), intent(out) :: entr(ia,ja)
684 
685  integer :: i, j
686  !---------------------------------------------------------------------------
687 
688  !$omp parallel do OMP_SCHEDULE_ collapse(2)
689  do j = js, je
690  do i = is, ie
691  call atmos_hydrometeor_entr_0d( &
692  temp(i,j), pres(i,j), & ! [IN]
693  qv(i,j), qi(i,j), qdry(i,j), & ! [IN]
694  rtot(i,j), cptot(i,j), & ! [IN]
695  entr(i,j) ) ! [OUT]
696  enddo
697  enddo
698 
699  return
integer, public ia
of whole cells: x, local, with HALO
integer, public ja
of whole cells: y, local, with HALO
integer, public is
start point of inner domain: x, local
integer, public ie
end point of inner domain: x, local
integer, public je
end point of inner domain: y, local
integer, public js
start point of inner domain: y, local

Variable Documentation

◆ atmos_hydrometeor_ice_phase

logical, public scale_atmos_hydrometeor::atmos_hydrometeor_ice_phase

Definition at line 74 of file scale_atmos_hydrometeor.F90.

Referenced by atmos_hydrometeor_regist(), and mod_atmos_phy_cp_driver::atmos_phy_cp_driver_setup().

74  logical, public :: atmos_hydrometeor_ice_phase

◆ i_qv

integer, public scale_atmos_hydrometeor::i_qv = -1

◆ n_hyd

integer, parameter, public scale_atmos_hydrometeor::n_hyd = 6

Definition at line 79 of file scale_atmos_hydrometeor.F90.

Referenced by mod_atmos_bnd_driver::atmos_boundary_driver_update(), mod_atmos_bnd_driver::atmos_boundary_set_online(), mod_atmos_phy_cp_driver::atmos_phy_cp_driver_calc_tendency(), scale_atmos_phy_cp_kf::atmos_phy_cp_kf_tendency(), mod_atmos_phy_cp_vars::atmos_phy_cp_vars_checktotal(), mod_atmos_phy_cp_vars::atmos_phy_cp_vars_fillhalo(), mod_atmos_phy_cp_vars::atmos_phy_cp_vars_restart_def_var(), mod_atmos_phy_cp_vars::atmos_phy_cp_vars_restart_read(), mod_atmos_phy_cp_vars::atmos_phy_cp_vars_restart_write(), mod_atmos_phy_cp_vars::atmos_phy_cp_vars_setup(), mod_atmos_phy_mp_driver::atmos_phy_mp_driver_calc_tendency(), mod_atmos_phy_mp_driver::atmos_phy_mp_driver_qhyd2qtrc(), scale_atmos_phy_mp_kessler::atmos_phy_mp_kessler_effective_radius(), scale_atmos_phy_mp_kessler::atmos_phy_mp_kessler_qhyd2qtrc(), scale_atmos_phy_mp_kessler::atmos_phy_mp_kessler_qtrc2qhyd(), scale_atmos_phy_mp_sn14::atmos_phy_mp_sn14_effective_radius(), scale_atmos_phy_mp_sn14::atmos_phy_mp_sn14_qhyd2qtrc(), scale_atmos_phy_mp_sn14::atmos_phy_mp_sn14_qtrc2nhyd(), scale_atmos_phy_mp_sn14::atmos_phy_mp_sn14_qtrc2qhyd(), scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_effective_radius(), scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_qhyd2qtrc(), scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_qtrc2nhyd(), scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_qtrc2qhyd(), scale_atmos_phy_mp_tomita08::atmos_phy_mp_tomita08_effective_radius(), scale_atmos_phy_mp_tomita08::atmos_phy_mp_tomita08_qhyd2qtrc(), scale_atmos_phy_mp_tomita08::atmos_phy_mp_tomita08_qtrc2qhyd(), mod_atmos_phy_mp_vars::atmos_phy_mp_vars_get_diagnostic(), mod_atmos_phy_mp_vars::atmos_phy_mp_vars_history(), mod_atmos_phy_mp_vars::atmos_phy_mp_vars_setup(), mod_atmos_phy_rd_driver::atmos_phy_rd_driver_calc_tendency(), scale_atmos_phy_rd_mstrnx::atmos_phy_rd_mstrnx_flux(), scale_atmos_phy_rd_mstrnx::atmos_phy_rd_mstrnx_setup(), mod_atmos_vars::atmos_vars_calc_diagnostics(), mod_atmos_vars::atmos_vars_setup(), scale_comm_cartesc_nest::comm_cartesc_nest_domain_shape(), mod_mkinit::mkinit(), mod_realinput_grads::parentatmosinputgrads(), mod_realinput_scale::parentatmosinputscale(), mod_realinput_wrfarw::parentatmosinputwrfarw(), and mod_realinput::realinput_surface().

79  integer, public, parameter :: n_hyd = 6

◆ i_hc

integer, parameter, public scale_atmos_hydrometeor::i_hc = 1

◆ i_hr

integer, parameter, public scale_atmos_hydrometeor::i_hr = 2

◆ i_hi

integer, parameter, public scale_atmos_hydrometeor::i_hi = 3

◆ i_hs

integer, parameter, public scale_atmos_hydrometeor::i_hs = 4

◆ i_hg

integer, parameter, public scale_atmos_hydrometeor::i_hg = 5

◆ i_hh

integer, parameter, public scale_atmos_hydrometeor::i_hh = 6

◆ hyd_name

character(len=h_short), dimension(n_hyd), parameter, public scale_atmos_hydrometeor::hyd_name = (/ "QC", "QR", "QI", "QS", "QG", "QH" /)

Definition at line 88 of file scale_atmos_hydrometeor.F90.

Referenced by mod_atmos_phy_cp_driver::atmos_phy_cp_driver_calc_tendency(), mod_atmos_phy_cp_vars::atmos_phy_cp_vars_setup(), mod_atmos_phy_mp_vars::atmos_phy_mp_vars_setup(), and mod_realinput_scale::parentatmosinputscale().

88  character(len=H_SHORT), public, parameter :: hyd_name(n_hyd) = &
89  (/ "QC", "QR", "QI", "QS", "QG", "QH" /)

◆ hyd_desc

character(len=h_mid), dimension(n_hyd), parameter, public scale_atmos_hydrometeor::hyd_desc = (/ "cloud ", "rain ", "ice water", "snow ", "graupel ", "hail " /)

Definition at line 90 of file scale_atmos_hydrometeor.F90.

Referenced by mod_atmos_phy_mp_vars::atmos_phy_mp_vars_setup().

90  character(len=H_MID), public, parameter :: hyd_desc(n_hyd) = &
91  (/ "cloud ", "rain ", "ice water", "snow ", "graupel ", "hail " /)

◆ num_name

character(len=h_short), dimension(n_hyd), parameter, public scale_atmos_hydrometeor::num_name = (/ "NC", "NR", "NI", "NS", "NG", "NH" /)

Definition at line 92 of file scale_atmos_hydrometeor.F90.

Referenced by mod_atmos_phy_mp_vars::atmos_phy_mp_vars_setup(), and mod_realinput_scale::parentatmosinputscale().

92  character(len=H_SHORT), public, parameter :: num_name(n_hyd) = &
93  (/ "NC", "NR", "NI", "NS", "NG", "NH" /)

◆ hyd_dens

real(rp), dimension(n_hyd), public scale_atmos_hydrometeor::hyd_dens

Definition at line 95 of file scale_atmos_hydrometeor.F90.

Referenced by atmos_hydrometeor_setup(), and scale_atmos_phy_rd_mstrnx::atmos_phy_rd_mstrnx_flux().

95  real(RP), public :: hyd_dens(n_hyd)

◆ atmos_hydrometeor_dry

logical, public scale_atmos_hydrometeor::atmos_hydrometeor_dry = .true.

◆ qha

integer, public scale_atmos_hydrometeor::qha = 0

◆ qhs

integer, public scale_atmos_hydrometeor::qhs = -1

◆ qhe

integer, public scale_atmos_hydrometeor::qhe = -2

◆ qla

integer, public scale_atmos_hydrometeor::qla = 0

◆ qls

integer, public scale_atmos_hydrometeor::qls = -1

Definition at line 119 of file scale_atmos_hydrometeor.F90.

Referenced by atmos_hydrometeor_regist(), and mod_realinput::realinput_surface().

119  integer, public :: qls = -1

◆ qle

integer, public scale_atmos_hydrometeor::qle = -2

Definition at line 120 of file scale_atmos_hydrometeor.F90.

Referenced by atmos_hydrometeor_regist(), and mod_realinput::realinput_surface().

120  integer, public :: qle = -2

◆ qia

integer, public scale_atmos_hydrometeor::qia = 0

◆ qis

integer, public scale_atmos_hydrometeor::qis = -1

Definition at line 123 of file scale_atmos_hydrometeor.F90.

Referenced by atmos_hydrometeor_regist().

123  integer, public :: qis = -1

◆ qie

integer, public scale_atmos_hydrometeor::qie = -2

Definition at line 124 of file scale_atmos_hydrometeor.F90.

Referenced by atmos_hydrometeor_regist().

124  integer, public :: qie = -2

◆ lhv

real(rp), public scale_atmos_hydrometeor::lhv

◆ lhs

real(rp), public scale_atmos_hydrometeor::lhs

latent heat of sublimation for use [J/kg]

Definition at line 127 of file scale_atmos_hydrometeor.F90.

Referenced by atmos_hydrometeor_setup().

127  real(RP), public :: lhs

◆ lhf

real(rp), public scale_atmos_hydrometeor::lhf

◆ cv_vapor

real(rp), public scale_atmos_hydrometeor::cv_vapor

◆ cp_vapor

real(rp), public scale_atmos_hydrometeor::cp_vapor

◆ cv_water

real(rp), public scale_atmos_hydrometeor::cv_water

◆ cp_water

real(rp), public scale_atmos_hydrometeor::cp_water

CP for water [J/kg/K].

Definition at line 133 of file scale_atmos_hydrometeor.F90.

Referenced by scale_atmos_adiabat::atmos_adiabat_liftparcel_1d(), atmos_hydrometeor_lhs_1d(), atmos_hydrometeor_lhv_0d(), atmos_hydrometeor_regist(), atmos_hydrometeor_setup(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_1d(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_atmos_0d(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_atmos_1d(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_atmos_rev_1d(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_bytemp_3d(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_bytemp_atmos_rev_1d(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_real_3d(), scale_atmos_phy_cp_kf::atmos_phy_cp_kf_tendency(), scale_atmos_phy_mp_kessler::atmos_phy_mp_kessler_adjustment(), scale_atmos_phy_mp_common::atmos_phy_mp_negative_fixer(), scale_atmos_phy_mp_common::atmos_phy_mp_precipitation_semilag(), scale_atmos_phy_mp_common::atmos_phy_mp_precipitation_upwind(), scale_atmos_phy_mp_common::atmos_phy_mp_saturation_adjustment_3d(), scale_atmos_phy_mp_sn14::atmos_phy_mp_sn14_qhyd2qtrc(), scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_qhyd2qtrc(), scale_atmos_phy_mp_tomita08::atmos_phy_mp_tomita08_adjustment(), scale_atmos_saturation::atmos_saturation_moist_conversion_dens_all_0d(), scale_atmos_saturation::atmos_saturation_moist_conversion_pres_liq_0d(), scale_atmos_saturation::atmos_saturation_pote_1d(), and scale_atmos_phy_mp_sn14::update_by_phase_change_kij().

133  real(RP), public :: cp_water

◆ cv_ice

real(rp), public scale_atmos_hydrometeor::cv_ice

◆ cp_ice

real(rp), public scale_atmos_hydrometeor::cp_ice