FE-Project
Loading...
Searching...
No Matches
Functions/Subroutines | Variables
scale_atm_phy_tb_dgm_common Module Reference

module FElib / Fluid dyn solver / Atmosphere / Physics turbulence / Common More...

Functions/Subroutines

subroutine, public atm_phy_tb_dgm_common_setup_variables (tends, auxvars, diagvars, tends_manager, auxvar_manager, diagvar_manager, tends_num_tot, mesh3d)
 
subroutine, public atm_phy_tb_dgm_common_calc_lambda (lambda, cs, filter_fac, lmesh, elem, lmesh2d, elem2d)
 
subroutine, public atm_phy_tb_dgm_common_cal_grad_qtrc (dfq1, dfq2, dfq3, drdx, drdy, drdz, kh, qtrc, ddens, dens_hyd, dx, dy, dz, sx, sy, sz, lift, lmesh, elem, lmesh2d, elem2d, is_bound, cal_grad_dens)
 Calculate parameterized diffusive mass flux of tracer with turbulent model.
 
subroutine, public atm_phy_tb_dgm_common_cal_tend (momx_t, momy_t, momz_t, rhot_t, t11, t12, t13, t21, t22, t23, t31, t32, t33, df1, df2, df3, nu, kh, ddens_, momx_, momy_, momz_, drhot_, dens_hyd, pres_hyd, pres_, pt_, dx, dy, dz, sx, sy, sz, lift, lmesh, elem, lmesh2d, elem2d, is_bound)
 Calculate tendecies with turbulent model.
 
subroutine, public atm_phy_tb_dgm_common_cal_tend_qtrc (rhoq_t, dfq1, dfq2, dfq3, kh, ddens_, dens_hyd, dx, dy, dz, sx, sy, sz, lift, lmesh, elem, lmesh2d, elem2d, is_bound)
 Calculate tendecies of tracer density with turbulent model.
 

Variables

integer, parameter, public atmos_phy_tb_aux_t13_id = 1
 
integer, parameter, public atmos_phy_tb_aux_t23_id = 2
 
integer, parameter, public atmos_phy_tb_aux_t33_id = 3
 
integer, parameter, public atmos_phy_tb_aux_diffflx3_id = 4
 
integer, parameter, public atmos_phy_tb_aux_t31_id = 5
 
integer, parameter, public atmos_phy_tb_aux_t32_id = 6
 
integer, parameter, public atmos_phy_tb_aux_diffflx1_id = 7
 
integer, parameter, public atmos_phy_tb_aux_diffflx2_id = 8
 
integer, parameter, public atmos_phy_tb_aux_t11_id = 9
 
integer, parameter, public atmos_phy_tb_aux_t12_id = 10
 
integer, parameter, public atmos_phy_tb_aux_t21_id = 11
 
integer, parameter, public atmos_phy_tb_aux_t22_id = 12
 
integer, parameter, public atmos_phy_tb_aux_scalar_num = 4
 
integer, parameter, public atmos_phy_tb_aux_hvec_num = 2
 
integer, parameter, public atmos_phy_tb_aux_htensor_num = 1
 
integer, parameter, public atmos_phy_tb_aux_num = 12
 
integer, parameter, public atmos_phy_tb_diag_tke_id = 1
 
integer, parameter, public atmos_phy_tb_diag_nu_id = 2
 
integer, parameter, public atmos_phy_tb_diag_kh_id = 3
 
integer, parameter, public atmos_phy_tb_diag_num = 3
 
integer, parameter, public atmos_phy_tb_momx_t_id = 1
 
integer, parameter, public atmos_phy_tb_momy_t_id = 2
 
integer, parameter, public atmos_phy_tb_momz_t_id = 3
 
integer, parameter, public atmos_phy_tb_rhot_t_id = 4
 
integer, parameter, public atmos_phy_tb_tends_num1 = 4
 

Detailed Description

module FElib / Fluid dyn solver / Atmosphere / Physics turbulence / Common

Description
A coomon modules for atmospheric turbulent parameterization
Author
Yuta Kawai, Team SCALE
NAMELIST
  • No namelist group
History Output
namedescriptionunitvariable
TB_T13 stress tensor (T13) kg.m-3.m2.s-2 TB_T13
TB_T23 stress tensor (T23) kg.m-3.m2.s-2 TB_T23
TB_T33 stress tensor (T33) kg.m-3.m2.s-2 TB_T33
DIFF_FLX3 diffusive heat flux (z) / density m2/s.K/m DIFF_FLX3
TB_T31 stress tensor (T31) kg.m-3.m2.s-2 TB_T31
TB_T32 stress tensor (T32) kg.m-3.m2.s-2 TB_T32
DIFF_FLX1 diffusive heat flux (x) / density m2/s.K/m DIFF_FLX1
DIFF_FLX2 diffusive heat flux (y) / density m2/s.K/m DIFF_FLX2
TB_T11 stress tensor (T11) kg.m-3.m2.s-2 TB_T11
TB_T12 stress tensor (T12) kg.m-3.m2.s-2 TB_T12
TB_T21 stress tensor (T21) kg.m-3.m2.s-2 TB_T21
TB_T22 stress tensor (T22) kg.m-3.m2.s-2 TB_T22
TKE SGS turbluence kinetic energy m2/s2 TKE
NU eddy viscosity m2/s NU
KH eddy diffusion m2/s KH
TB_MOMX_t tendency of x-momentum in TB process kg/m2/s2 TB_MOMX_t
TB_MOMY_t tendency of y-momentum in TB process kg/m2/s2 TB_MOMY_t
TB_MOMZ_t tendency of z-momentum in TB process kg/m2/s2 TB_MOMZ_t
TB_RHOT_t tendency of rho*PT in TB process kg/m3.K/s TB_RHOT_t
TB_{TRACER_NAME}_t tendency of {TRACER_NAME} in TB process;
{TRACER_NAME} depends on the physics schemes, e.g., QV, QC, QR.
TRACER_UNIT TRACER_NAME

Function/Subroutine Documentation

◆ atm_phy_tb_dgm_common_setup_variables()

subroutine, public scale_atm_phy_tb_dgm_common::atm_phy_tb_dgm_common_setup_variables ( type(meshfield3d), dimension(tends_num_tot), intent(inout) tends,
type(meshfield3d), dimension(atmos_phy_tb_aux_num), intent(inout) auxvars,
type(meshfield3d), dimension(atmos_phy_tb_diag_num), intent(inout) diagvars,
type(modelvarmanager), intent(inout) tends_manager,
type(modelvarmanager), intent(inout) auxvar_manager,
type(modelvarmanager), intent(inout) diagvar_manager,
integer, intent(in) tends_num_tot,
class(meshbase3d), intent(in) mesh3d )

Definition at line 93 of file scale_atm_phy_tb_dgm_common.F90.

97 use scale_tracer, only: &
98 qa, tracer_name, tracer_desc, tracer_unit
101 implicit none
102 integer, intent(in) :: TENDS_NUM_TOT
103 type(MeshField3D), intent(inout) :: tends(TENDS_NUM_TOT)
104 type(MeshField3D), intent(inout) :: auxvars(ATMOS_PHY_TB_AUX_NUM)
105 type(MeshField3D), intent(inout) :: diagvars(ATMOS_PHY_TB_DIAG_NUM)
106 type(ModelVarManager), intent(inout) :: tends_manager
107 type(ModelVarManager), intent(inout) :: auxvar_manager
108 type(ModelVarManager), intent(inout) :: diagvar_manager
109 class(MeshBase3D), intent(in) :: mesh3D
110
111 ! type(VariableInfo), intent(out) :: auxvar_info(ATMOS_PHY_TB_AUX_NUM)
112 ! type(VariableInfo), intent(out) :: diagvar_info(ATMOS_PHY_TB_DIAG_NUM)
113 ! type(VariableInfo), intent(out) :: tend_info(ATMOS_PHY_TB_TENDS_NUM1)
114
115 type(VariableInfo) :: ATMOS_PHY_TB_AUX_VINFO(ATMOS_PHY_TB_AUX_NUM)
116 DATA atmos_phy_tb_aux_vinfo / &
117 variableinfo( atmos_phy_tb_aux_t13_id, 'TB_T13', 'stress tensor (T13)', & ! rho x nu x S : [kg/m3] x [m2/s] x [s-1]
118 'kg.m-3.m2.s-2', 3, 'XYZ', '' ), &
119 variableinfo( atmos_phy_tb_aux_t23_id, 'TB_T23', 'stress tensor (T23)', &
120 'kg.m-3.m2.s-2', 3, 'XYZ', '' ), &
121 variableinfo( atmos_phy_tb_aux_t33_id, 'TB_T33', 'stress tensor (T33)', &
122 'kg.m-3.m2.s-2', 3, 'XYZ', '' ), &
123 variableinfo( atmos_phy_tb_aux_diffflx3_id, 'DIFF_FLX3', 'diffusive heat flux (z) / density', &
124 'm2/s.K/m', 3, 'XYZ', '' ), &
125 variableinfo( atmos_phy_tb_aux_t31_id, 'TB_T31', 'stress tensor (T31)', &
126 'kg.m-3.m2.s-2', 3, 'XYZ', '' ), &
127 variableinfo( atmos_phy_tb_aux_t32_id, 'TB_T32', 'stress tensor (T32)', &
128 'kg.m-3.m2.s-2', 3, 'XYZ', '' ), &
129 variableinfo( atmos_phy_tb_aux_diffflx1_id, 'DIFF_FLX1', 'diffusive heat flux (x) / density', &
130 'm2/s.K/m', 3, 'XYZ', '' ), &
131 variableinfo( atmos_phy_tb_aux_diffflx2_id, 'DIFF_FLX2', 'diffusive heat flux (y) / density', &
132 'm2/s.K/m', 3, 'XYZ', '' ), &
133 variableinfo( atmos_phy_tb_aux_t11_id, 'TB_T11', 'stress tensor (T11)', &
134 'kg.m-3.m2.s-2', 3, 'XYZ', '' ), &
135 variableinfo( atmos_phy_tb_aux_t12_id, 'TB_T12', 'stress tensor (T12)', &
136 'kg.m-3.m2.s-2', 3, 'XYZ', '' ), &
137 variableinfo( atmos_phy_tb_aux_t21_id, 'TB_T21', 'stress tensor (T21)', &
138 'kg.m-3.m2.s-2', 3, 'XYZ', '' ), &
139 variableinfo( atmos_phy_tb_aux_t22_id, 'TB_T22', 'stress tensor (T22)', &
140 'kg.m-3.m2.s-2', 3, 'XYZ', '' ) /
141
142 type(VariableInfo) :: ATMOS_PHY_TB_DIAG_VINFO(ATMOS_PHY_TB_DIAG_NUM)
143 DATA atmos_phy_tb_diag_vinfo / &
144 variableinfo( atmos_phy_tb_diag_tke_id, 'TKE', 'SGS turbluence kinetic energy', &
145 'm2/s2', 3, 'XYZ', '' ), &
146 variableinfo( atmos_phy_tb_diag_nu_id, 'NU', 'eddy viscosity', &
147 'm2/s', 3, 'XYZ', '' ), &
148 variableinfo( atmos_phy_tb_diag_kh_id, 'KH', 'eddy diffusion', &
149 'm2/s', 3, 'XYZ', '' ) /
150
151 type(VariableInfo) :: ATMOS_PHY_TB_TEND_VINFO(ATMOS_PHY_TB_TENDS_NUM1)
152 DATA atmos_phy_tb_tend_vinfo / &
153 variableinfo( atmos_phy_tb_momx_t_id, 'TB_MOMX_t', 'tendency of x-momentum in TB process', &
154 'kg/m2/s2', 3, 'XYZ', '' ), &
155 variableinfo( atmos_phy_tb_momy_t_id, 'TB_MOMY_t', 'tendency of y-momentum in TB process', &
156 'kg/m2/s2', 3, 'XYZ', '' ), &
157 variableinfo( atmos_phy_tb_momz_t_id, 'TB_MOMZ_t', 'tendency of z-momentum in TB process', &
158 'kg/m2/s2', 3, 'XYZ', '' ), &
159 variableinfo( atmos_phy_tb_rhot_t_id, 'TB_RHOT_t', 'tendency of rho*PT in TB process', &
160 'kg/m3.K/s', 3, 'XYZ', '' ) /
161
162 type(VariableInfo) :: qtrc_vinfo_tmp
163
164 integer :: iv
165 integer :: iq
166 logical :: reg_file_hist
167 !----------------------------------------------------------
168
169 ! auxvar_info(:) = ATMOS_PHY_TB_AUX_VINFO
170 ! diagvar_info(:) = ATMOS_PHY_TB_DIAG_VINFO
171 ! tend_info(:) = ATMOS_PHY_TB_TEND_VINFO
172
173 !- Initialize an object to manage tendencies with turbulent model
174
175 reg_file_hist = .true.
176 do iv = 1, atmos_phy_tb_tends_num1
177 call tends_manager%Regist( &
178 atmos_phy_tb_tend_vinfo(iv), mesh3d, & ! (in)
179 tends(iv), reg_file_hist, & ! (out)
180 fill_zero=.true. )
181 end do
182
183 qtrc_vinfo_tmp%ndims = 3
184 qtrc_vinfo_tmp%dim_type = 'XYZ'
185 qtrc_vinfo_tmp%STDNAME = ''
186
187 do iq = 1, qa
188 iv = atmos_phy_tb_tends_num1 + iq
189 qtrc_vinfo_tmp%keyID = iv
190 qtrc_vinfo_tmp%NAME = 'TB_'//trim(tracer_name(iq))//'_t'
191 qtrc_vinfo_tmp%DESC = 'tendency of '//trim(tracer_desc(iq))//' in TB process'
192 qtrc_vinfo_tmp%UNIT = trim(tracer_unit(iq))//'/s'
193
194 call tends_manager%Regist( &
195 qtrc_vinfo_tmp, mesh3d, & ! (in)
196 tends(iv), reg_file_hist, & ! (out)
197 fill_zero=.true. )
198 end do
199
200 !- Initialize an object to manage auxiliary variables with turbulent model
201
202 reg_file_hist = .true.
203 do iv = 1, atmos_phy_tb_aux_num
204 call auxvar_manager%Regist( &
205 atmos_phy_tb_aux_vinfo(iv), mesh3d, & ! (in)
206 auxvars(iv), reg_file_hist, & ! (out)
207 fill_zero=.true. )
208 end do
209
210 !- Initialize an object to manage diagnostic variables with turbulent model
211
212 reg_file_hist = .true.
213 do iv = 1, atmos_phy_tb_diag_num
214 call diagvar_manager%Regist( &
215 atmos_phy_tb_diag_vinfo(iv), mesh3d, & ! (in)
216 diagvars(iv), reg_file_hist, & ! (out)
217 fill_zero=.true. )
218 end do
219
220 return
module FElib / Mesh / Base 3D
module FElib / Data / base

References atmos_phy_tb_aux_diffflx1_id, atmos_phy_tb_aux_diffflx2_id, atmos_phy_tb_aux_diffflx3_id, atmos_phy_tb_aux_num, atmos_phy_tb_aux_t11_id, atmos_phy_tb_aux_t12_id, atmos_phy_tb_aux_t13_id, atmos_phy_tb_aux_t21_id, atmos_phy_tb_aux_t22_id, atmos_phy_tb_aux_t23_id, atmos_phy_tb_aux_t31_id, atmos_phy_tb_aux_t32_id, atmos_phy_tb_aux_t33_id, atmos_phy_tb_diag_kh_id, atmos_phy_tb_diag_nu_id, atmos_phy_tb_diag_num, atmos_phy_tb_diag_tke_id, atmos_phy_tb_momx_t_id, atmos_phy_tb_momy_t_id, atmos_phy_tb_momz_t_id, atmos_phy_tb_rhot_t_id, and atmos_phy_tb_tends_num1.

Referenced by mod_atmos_phy_tb_vars::atmosphytbvars_init().

◆ atm_phy_tb_dgm_common_calc_lambda()

subroutine, public scale_atm_phy_tb_dgm_common::atm_phy_tb_dgm_common_calc_lambda ( real(rp), dimension(elem%np,lmesh%ne), intent(out) lambda,
real(rp), intent(in) cs,
real(rp), intent(in) filter_fac,
class(localmesh3d), intent(in) lmesh,
class(elementbase3d), intent(in) elem,
class(localmesh2d), intent(in) lmesh2d,
class(elementbase2d), intent(in) elem2d )

Definition at line 224 of file scale_atm_phy_tb_dgm_common.F90.

226
227 use scale_const, only: &
228 karman => const_karman
229 implicit none
230
231 class(LocalMesh3D), intent(in) :: lmesh
232 class(ElementBase3D), intent(in) :: elem
233 class(LocalMesh2D), intent(in) :: lmesh2D
234 class(ElementBase2D), intent(in) :: elem2D
235 real(RP), intent(out) :: lambda(elem%Np,lmesh%Ne)
236 real(RP), intent(in) :: Cs
237 real(RP), intent(in) :: filter_fac
238
239 integer :: ke
240
241 real(RP) :: vol
242 real(RP) :: he
243 real(RP) :: lambda0
244 real(RP) :: Zs(elem2D%Np)
245 real(RP) :: Z1(elem2D%Np)
246 real(RP) :: dz(elem %Np)
247 real(RP) :: FZ
248 real(RP) :: elem_aspect_eff
249
250 real(RP), parameter :: OneOverThree = 1.0_rp / 3.0_rp
251 !--------------------------------------------------------------------
252
253 !$omp parallel do private( &
254 !$omp vol, lambda0, Zs, Z1, dz, he, FZ, elem_aspect_eff )
255 do ke=lmesh%NeS, lmesh%NeE
256 vol = sum( elem%IntWeight_lgl(:) * lmesh%J(:,ke) * lmesh%Gsqrt(:,ke) )
257 he = ( vol / ( dble(elem%PolyOrder_h+1)**2 * dble(elem%PolyOrder_v+1) ) )**oneoverthree
258
259 fz = lmesh%zlev(elem%Colmask(elem%Nnode_v,1),ke) - lmesh%zlev(elem%Colmask(1,1),ke)
260 elem_aspect_eff = fact( fz/dble(elem%PolyOrder_v+1), sqrt(vol/fz)/dble(elem%PolyOrder_h+1), sqrt(vol/fz)/dble(elem%PolyOrder_h+1) )
261 lambda0 = elem_aspect_eff * cs * filter_fac * he
262
263 zs(:) = lmesh%zlev(elem%Hslice(:,1),lmesh%EMap3Dto2D(ke))
264 z1(:) = lmesh%zlev(elem%Hslice(:,2),lmesh%EMap3Dto2D(ke))
265 dz(:) = max( lmesh%zlev(:,ke) - zs(elem%IndexH2Dto3D(:)), he )
266
267 !lambda(:,ke) = sqrt( 1.0_RP / (1.0_RP / lambda0**2 + 1.0_RP / ( KARMAN * max( dz(:), EPS ) )**2 ) )
268 lambda(:,ke) = sqrt( 1.0_rp / (1.0_rp / lambda0**2 + 1.0_rp / ( karman * ( dz(:) + 1.0e-4_rp ) )**2 ) )
269 end do
270
271 return

Referenced by scale_atm_phy_tb_dgm_globalsmg::atm_phy_tb_dgm_globalsmg_cal_grad(), and scale_atm_phy_tb_dgm_smg::atm_phy_tb_dgm_smg_cal_grad().

◆ atm_phy_tb_dgm_common_cal_grad_qtrc()

subroutine, public scale_atm_phy_tb_dgm_common::atm_phy_tb_dgm_common_cal_grad_qtrc ( real(rp), dimension(elem%np,lmesh%nea), intent(out) dfq1,
real(rp), dimension(elem%np,lmesh%nea), intent(out) dfq2,
real(rp), dimension(elem%np,lmesh%nea), intent(out) dfq3,
real(rp), dimension(elem%np,lmesh%nea), intent(inout) drdx,
real(rp), dimension(elem%np,lmesh%nea), intent(inout) drdy,
real(rp), dimension(elem%np,lmesh%nea), intent(inout) drdz,
real(rp), dimension(elem%np,lmesh%nea), intent(in) kh,
real(rp), dimension(elem%np,lmesh%nea), intent(in) qtrc,
real(rp), dimension(elem%np,lmesh%nea), intent(in) ddens,
real(rp), dimension(elem%np,lmesh%nea), intent(in) dens_hyd,
type(sparsemat), intent(in) dx,
type(sparsemat), intent(in) dy,
type(sparsemat), intent(in) dz,
type(sparsemat), intent(in) sx,
type(sparsemat), intent(in) sy,
type(sparsemat), intent(in) sz,
type(sparsemat), intent(in) lift,
class(localmesh3d), intent(in) lmesh,
class(elementbase3d), intent(in) elem,
class(localmesh2d), intent(in) lmesh2d,
class(elementbase2d), intent(in) elem2d,
logical, dimension(elem%nfptot,lmesh%ne), intent(in) is_bound,
logical, intent(in) cal_grad_dens )

Calculate parameterized diffusive mass flux of tracer with turbulent model.

Parameters
[out]dfq1Diffusive mass flux in x1 direction / density (Kh dq/dx1)
[out]dfq2Diffusive mass flux in x2 direction / density (Kh dq/dx2)
[out]dfq3Diffusive mass flux in x3 direction / density (Kh dq/dx3)
[in,out]drdxSpatial gradient of density in x1 direction
[in,out]drdySpatial gradient of density in x2 direction
[in,out]drdzSpatial gradient of density in x3 direction
[in]khEddy diffusivity
[in]qtrcMass faction of tracer
[in]ddensDensity perturbation
[in]dens_hydReference desity in hydrostatic state
[in]dzDifferential matrix managed by sparse matrix type
[in]szStiffness matrix managed by sparse matrix type
[in]liftLifting matrix managed by sparse matrix type
[in]is_boundFlag whether nodes are located at domain boundaries
[in]cal_grad_densFlag whether spatial gradients of density are calcuated

Definition at line 278 of file scale_atm_phy_tb_dgm_common.F90.

284
285 implicit none
286
287 class(LocalMesh3D), intent(in) :: lmesh
288 class(ElementBase3D), intent(in) :: elem
289 class(LocalMesh2D), intent(in) :: lmesh2D
290 class(ElementBase2D), intent(in) :: elem2D
291 real(RP), intent(out) :: DFQ1(elem%Np,lmesh%NeA)
292 real(RP), intent(out) :: DFQ2(elem%Np,lmesh%NeA)
293 real(RP), intent(out) :: DFQ3(elem%Np,lmesh%NeA)
294 real(RP), intent(inout) :: dRdx(elem%Np,lmesh%NeA)
295 real(RP), intent(inout) :: dRdy(elem%Np,lmesh%NeA)
296 real(RP), intent(inout) :: dRdz(elem%Np,lmesh%NeA)
297 real(RP), intent(in) :: Kh(elem%Np,lmesh%NeA)
298 real(RP), intent(in) :: QTRC(elem%Np,lmesh%NeA)
299 real(RP), intent(in) :: DDENS(elem%Np,lmesh%NeA)
300 real(RP), intent(in) :: DENS_hyd(elem%Np,lmesh%NeA)
301 type(SparseMat), intent(in) :: Dx, Dy, Dz
302 type(SparseMat), intent(in) :: Sx, Sy, Sz
303 type(SparseMat), intent(in) :: Lift
304 logical, intent(in) :: is_bound(elem%NfpTot,lmesh%Ne)
305 logical, intent(in) :: cal_grad_dens
306
307 real(RP) :: Fx(elem%Np), Fy(elem%Np), Fz(elem%Np), LiftDelFlx(elem%Np)
308 real(RP) :: bnd_flux(elem%NfpTot,lmesh%Ne,3)
309 real(RP) :: bnd_flux_rho (elem%NfpTot,lmesh%Ne,3)
310
311 real(RP) :: DENS(elem%Np), RDENS(elem%Np)
312 real(RP) :: RHOxQTRC(elem%Np)
313
314 integer :: ke
315 integer :: p
316 !--------------------------------------------------------------------
317
318 call cal_bnd_flux_grad_qtrc( bnd_flux, bnd_flux_rho, & ! (out)
319 qtrc, ddens, dens_hyd, & ! (in)
320 lmesh%normal_fn(:,:,1), lmesh%normal_fn(:,:,2), lmesh%normal_fn(:,:,3), & ! (in)
321 lmesh%vmapM, lmesh%vmapP, & ! (in)
322 lmesh, elem, is_bound, cal_grad_dens ) ! (in)
323
324 !$omp parallel private( ke, Fx, Fy, Fz, LiftDelFlx, RHOxQTRC, DENS, RDENS )
325
326 ! Calculate gradient of density
327 if ( cal_grad_dens ) then
328 !$omp do
329 do ke=lmesh%NeS, lmesh%NeE
330 dens(:) = dens_hyd(:,ke) + ddens(:,ke)
331
332 call sparsemat_matmul( dx, dens, fx )
333 call sparsemat_matmul( lift, lmesh%Fscale(:,ke) * bnd_flux_rho(:,ke,1), liftdelflx )
334 drdx(:,ke) = lmesh%Escale(:,ke,1,1) * fx(:) + liftdelflx(:)
335
336 call sparsemat_matmul( dy, dens, fy )
337 call sparsemat_matmul( lift, lmesh%Fscale(:,ke) * bnd_flux_rho(:,ke,2), liftdelflx )
338 drdy(:,ke) = lmesh%Escale(:,ke,2,2) * fy(:) + liftdelflx(:)
339
340 call sparsemat_matmul( dz, dens, fz )
341 call sparsemat_matmul( lift, lmesh%Fscale(:,ke) * bnd_flux_rho(:,ke,3), liftdelflx )
342 drdz(:,ke) = lmesh%Escale(:,ke,3,3) * fz(:) + liftdelflx(:)
343 end do
344 end if
345
346 ! Calculate gradient of tracer
347 !$omp do
348 do ke=lmesh%NeS, lmesh%NeE
349 dens(:) = dens_hyd(:,ke) + ddens(:,ke)
350 rdens(:) = 1.0_rp / dens(:)
351 rhoxqtrc(:) = dens(:) * qtrc(:,ke)
352
353 !---
354 call sparsemat_matmul( dx, rhoxqtrc(:), fx )
355 call sparsemat_matmul( lift, lmesh%Fscale(:,ke) * bnd_flux(:,ke,1), liftdelflx )
356 dfq1(:,ke) = kh(:,ke) * ( lmesh%Escale(:,ke,1,1) * fx(:) + liftdelflx(:) - qtrc(:,ke) * drdx(:,ke) ) * rdens(:)
357
358 call sparsemat_matmul( dy, rhoxqtrc(:), fy )
359 call sparsemat_matmul( lift, lmesh%Fscale(:,ke) * bnd_flux(:,ke,2), liftdelflx )
360 dfq2(:,ke) = kh(:,ke) * ( lmesh%Escale(:,ke,2,2) * fy(:) + liftdelflx(:) - qtrc(:,ke) * drdy(:,ke) ) * rdens(:)
361
362 call sparsemat_matmul( dz, rhoxqtrc(:), fz )
363 call sparsemat_matmul( lift, lmesh%Fscale(:,ke) * bnd_flux(:,ke,3), liftdelflx )
364 dfq3(:,ke) = kh(:,ke) * ( lmesh%Escale(:,ke,3,3) * fz(:) + liftdelflx(:) - qtrc(:,ke) * drdz(:,ke) ) * rdens(:)
365 end do
366
367 !$omp end parallel
368
369 return

◆ atm_phy_tb_dgm_common_cal_tend()

subroutine, public scale_atm_phy_tb_dgm_common::atm_phy_tb_dgm_common_cal_tend ( real(rp), dimension(elem%np,lmesh%nea), intent(out) momx_t,
real(rp), dimension(elem%np,lmesh%nea), intent(out) momy_t,
real(rp), dimension(elem%np,lmesh%nea), intent(out) momz_t,
real(rp), dimension(elem%np,lmesh%nea), intent(out) rhot_t,
real(rp), dimension(elem%np,lmesh%nea), intent(in) t11,
real(rp), dimension(elem%np,lmesh%nea), intent(in) t12,
real(rp), dimension(elem%np,lmesh%nea), intent(in) t13,
real(rp), dimension(elem%np,lmesh%nea), intent(in) t21,
real(rp), dimension(elem%np,lmesh%nea), intent(in) t22,
real(rp), dimension(elem%np,lmesh%nea), intent(in) t23,
real(rp), dimension(elem%np,lmesh%nea), intent(in) t31,
real(rp), dimension(elem%np,lmesh%nea), intent(in) t32,
real(rp), dimension(elem%np,lmesh%nea), intent(in) t33,
real(rp), dimension(elem%np,lmesh%nea), intent(in) df1,
real(rp), dimension(elem%np,lmesh%nea), intent(in) df2,
real(rp), dimension(elem%np,lmesh%nea), intent(in) df3,
real(rp), dimension (elem%np,lmesh%nea), intent(in) nu,
real(rp), dimension (elem%np,lmesh%nea), intent(in) kh,
real(rp), dimension(elem%np,lmesh%nea), intent(in) ddens_,
real(rp), dimension (elem%np,lmesh%nea), intent(in) momx_,
real(rp), dimension (elem%np,lmesh%nea), intent(in) momy_,
real(rp), dimension (elem%np,lmesh%nea), intent(in) momz_,
real(rp), dimension(elem%np,lmesh%nea), intent(in) drhot_,
real(rp), dimension(elem%np,lmesh%nea), intent(in) dens_hyd,
real(rp), dimension(elem%np,lmesh%nea), intent(in) pres_hyd,
real(rp), dimension(elem%np,lmesh%nea), intent(in) pres_,
real(rp), dimension (elem%np,lmesh%nea), intent(in) pt_,
type(sparsemat), intent(in) dx,
type(sparsemat), intent(in) dy,
type(sparsemat), intent(in) dz,
type(sparsemat), intent(in) sx,
type(sparsemat), intent(in) sy,
type(sparsemat), intent(in) sz,
type(sparsemat), intent(in) lift,
class(localmesh3d), intent(in) lmesh,
class(elementbase3d), intent(in) elem,
class(localmesh2d), intent(in) lmesh2d,
class(elementbase2d), intent(in) elem2d,
logical, dimension(elem%nfptot,lmesh%ne), intent(in) is_bound )

Calculate tendecies with turbulent model.

Parameters
[out]momx_tTendency of momentum in x1 direction with turbulent model
[out]momy_tTendency of momentum in x2 direction with turbulent model
[out]momz_tTendency of momentum in x3 direction with turbulent model
[out]rhot_tTendency of density x potential temperature with turbulent model
[in]t11(1,1) component of stress tensor
[in]t12(1,2) component of stress tensor
[in]t13(1,3) component of stress tensor
[in]t21(2,1) component of stress tensor
[in]t22(2,2) component of stress tensor
[in]t23(2,3) component of stress tensor
[in]t31(3,1) component of stress tensor
[in]t32(3,2) component of stress tensor
[in]t33(3,3) component of stress tensor
[in]df1Diffusive heat flux in x1 direction / density
[in]df2Diffusive heat flux in x2 direction / density
[in]df3Diffusive heat flux in x3 direction / density
[in]nuEddy viscosity
[in]khEddy diffusivity
[in]ddens_Density perturbation
[in]momx_Momentum in x1 direction
[in]momy_Momentum in x2 direction
[in]momz_Momentum in x3 direction
[in]drhot_Density x potential temperature perturbation
[in]dens_hydReference pressure in hydrostatic balance
[in]pres_hydReference density in hydrostatic balance
[in]pres_Pressure
[in]pt_Potential temperature
[in]dzDifferential matrix managed by sparse matrix type
[in]szStiffness matrix managed by sparse matrix type
[in]liftLifting matrix managed by sparse matrix type
[in]is_boundFlag whether nodes are located at domain boundaries

Definition at line 375 of file scale_atm_phy_tb_dgm_common.F90.

384
385 implicit none
386
387 class(LocalMesh3D), intent(in) :: lmesh
388 class(ElementBase3D), intent(in) :: elem
389 class(LocalMesh2D), intent(in) :: lmesh2D
390 class(ElementBase2D), intent(in) :: elem2D
391 real(RP), intent(out) :: MOMX_t(elem%Np,lmesh%NeA)
392 real(RP), intent(out) :: MOMY_t(elem%Np,lmesh%NeA)
393 real(RP), intent(out) :: MOMZ_t(elem%Np,lmesh%NeA)
394 real(RP), intent(out) :: RHOT_t(elem%Np,lmesh%NeA)
395 real(RP), intent(in) :: T11(elem%Np,lmesh%NeA)
396 real(RP), intent(in) :: T12(elem%Np,lmesh%NeA)
397 real(RP), intent(in) :: T13(elem%Np,lmesh%NeA)
398 real(RP), intent(in) :: T21(elem%Np,lmesh%NeA)
399 real(RP), intent(in) :: T22(elem%Np,lmesh%NeA)
400 real(RP), intent(in) :: T23(elem%Np,lmesh%NeA)
401 real(RP), intent(in) :: T31(elem%Np,lmesh%NeA)
402 real(RP), intent(in) :: T32(elem%Np,lmesh%NeA)
403 real(RP), intent(in) :: T33(elem%Np,lmesh%NeA)
404 real(RP), intent(in) :: DF1(elem%Np,lmesh%NeA)
405 real(RP), intent(in) :: DF2(elem%Np,lmesh%NeA)
406 real(RP), intent(in) :: DF3(elem%Np,lmesh%NeA)
407 real(RP), intent(in) :: Nu (elem%Np,lmesh%NeA)
408 real(RP), intent(in) :: Kh (elem%Np,lmesh%NeA)
409 real(RP), intent(in) :: DDENS_(elem%Np,lmesh%NeA)
410 real(RP), intent(in) :: MOMX_ (elem%Np,lmesh%NeA)
411 real(RP), intent(in) :: MOMY_ (elem%Np,lmesh%NeA)
412 real(RP), intent(in) :: MOMZ_ (elem%Np,lmesh%NeA)
413 real(RP), intent(in) :: DRHOT_(elem%Np,lmesh%NeA)
414 real(RP), intent(in) :: DENS_hyd(elem%Np,lmesh%NeA)
415 real(RP), intent(in) :: PRES_hyd(elem%Np,lmesh%NeA)
416 real(RP), intent(in) :: PRES_(elem%Np,lmesh%NeA)
417 real(RP), intent(in) :: PT_ (elem%Np,lmesh%NeA)
418 type(SparseMat), intent(in) :: Dx, Dy, Dz
419 type(SparseMat), intent(in) :: Sx, Sy, Sz
420 type(SparseMat), intent(in) :: Lift
421 logical, intent(in) :: is_bound(elem%NfpTot,lmesh%Ne)
422
423 integer :: ke
424
425 real(RP) :: Fx(elem%Np), Fy(elem%Np), Fz(elem%Np), LiftDelFlx(elem%Np)
426 real(RP) :: DENS(elem%Np)
427 real(RP) :: bnd_flux_mom(elem%NfpTot,lmesh%Ne,3)
428 real(RP) :: bnd_flux_rhot(elem%NfpTot,lmesh%Ne)
429 !--------------------------------------------------------------------
430
431 call cal_bnd_flux( bnd_flux_mom, bnd_flux_rhot, & ! (out)
432 t11, t12, t13, t21, t22, t23, t31, t32, t33, & ! (in)
433 df1, df2, df3, & ! (in)
434 nu, kh, & ! (in)
435 ddens_, momx_, momy_, momz_, drhot_, dens_hyd, pres_hyd, & ! (in)
436 lmesh%normal_fn(:,:,1), lmesh%normal_fn(:,:,2), lmesh%normal_fn(:,:,3), & ! (in)
437 lmesh%vmapM, lmesh%vmapP, lmesh, elem, is_bound ) ! (in)
438
439 !$omp parallel do private( &
440 !$omp Fx, Fy, Fz, LiftDelFlx, &
441 !$omp DENS )
442 do ke=lmesh%NeS, lmesh%NeE
443 dens(:) = dens_hyd(:,ke) + ddens_(:,ke)
444
445 ! MOMX
446 call sparsemat_matmul( dx, t11(:,ke), fx )
447 call sparsemat_matmul( dy, t12(:,ke), fy )
448 call sparsemat_matmul( dz, t13(:,ke), fz )
449 call sparsemat_matmul( lift, lmesh%Fscale(:,ke) * bnd_flux_mom(:,ke,1), liftdelflx )
450
451 momx_t(:,ke) = lmesh%Escale(:,ke,1,1) * fx(:) + lmesh%Escale(:,ke,2,2) * fy(:) &
452 + lmesh%Escale(:,ke,3,3) * fz(:) + liftdelflx(:)
453
454 ! MOMY
455 call sparsemat_matmul( dx, t21(:,ke), fx )
456 call sparsemat_matmul( dy, t22(:,ke), fy )
457 call sparsemat_matmul( dz, t23(:,ke), fz )
458 call sparsemat_matmul( lift, lmesh%Fscale(:,ke) * bnd_flux_mom(:,ke,2), liftdelflx )
459
460 momy_t(:,ke) = lmesh%Escale(:,ke,1,1) * fx(:) + lmesh%Escale(:,ke,2,2) * fy(:) &
461 + lmesh%Escale(:,ke,3,3) * fz(:) + liftdelflx(:)
462
463 ! MOMZ
464 call sparsemat_matmul( dx, t31(:,ke), fx )
465 call sparsemat_matmul( dy, t32(:,ke), fy )
466 call sparsemat_matmul( dz, t33(:,ke), fz )
467 call sparsemat_matmul( lift, lmesh%Fscale(:,ke) * bnd_flux_mom(:,ke,3), liftdelflx )
468
469 momz_t(:,ke) = lmesh%Escale(:,ke,1,1) * fx(:) + lmesh%Escale(:,ke,2,2) * fy(:) &
470 + lmesh%Escale(:,ke,3,3) * fz(:) + liftdelflx(:)
471
472 ! RHOT
473 call sparsemat_matmul( dx, dens(:) * df1(:,ke), fx )
474 call sparsemat_matmul( dy, dens(:) * df2(:,ke), fy )
475 call sparsemat_matmul( dz, dens(:) * df3(:,ke), fz )
476 call sparsemat_matmul( lift, lmesh%Fscale(:,ke) * bnd_flux_rhot(:,ke), liftdelflx )
477
478 rhot_t(:,ke) = ( lmesh%Escale(:,ke,1,1) * fx(:) &
479 + lmesh%Escale(:,ke,2,2) * fy(:) &
480 + lmesh%Escale(:,ke,3,3) * fz(:) &
481 + liftdelflx(:) ) / lmesh%Gsqrt(:,ke)
482
483 end do
484
485 return

◆ atm_phy_tb_dgm_common_cal_tend_qtrc()

subroutine, public scale_atm_phy_tb_dgm_common::atm_phy_tb_dgm_common_cal_tend_qtrc ( real(rp), dimension(elem%np,lmesh%nea), intent(out) rhoq_t,
real(rp), dimension(elem%np,lmesh%nea), intent(in) dfq1,
real(rp), dimension(elem%np,lmesh%nea), intent(in) dfq2,
real(rp), dimension(elem%np,lmesh%nea), intent(in) dfq3,
real(rp), dimension (elem%np,lmesh%nea), intent(in) kh,
real(rp), dimension(elem%np,lmesh%nea), intent(in) ddens_,
real(rp), dimension(elem%np,lmesh%nea), intent(in) dens_hyd,
type(sparsemat), intent(in) dx,
type(sparsemat), intent(in) dy,
type(sparsemat), intent(in) dz,
type(sparsemat), intent(in) sx,
type(sparsemat), intent(in) sy,
type(sparsemat), intent(in) sz,
type(sparsemat), intent(in) lift,
class(localmesh3d), intent(in) lmesh,
class(elementbase3d), intent(in) elem,
class(localmesh2d), intent(in) lmesh2d,
class(elementbase2d), intent(in) elem2d,
logical, dimension(elem%nfptot,lmesh%ne), intent(in) is_bound )

Calculate tendecies of tracer density with turbulent model.

Parameters
[out]rhoq_tTendency of tracer mass fraction
[in]dfq1Diffusive mass flux in x1 direction / density (Kh dq/dx1)
[in]dfq2Diffusive mass flux in x2 direction / density (Kh dq/dx2)
[in]dfq3Diffusive mass flux in x3 direction / density (Kh dq/dx3)
[in]khEddy diffusivity
[in]ddens_Density perturbation
[in]dens_hydReference pressure in hydrostatic state
[in]dzDifferential matrix managed by sparse matrix type
[in]szStiffness matrix managed by sparse matrix type
[in]liftLifting matrix managed by sparse matrix type
[in]is_boundFlag whether nodes are located at domain boundaries

Definition at line 491 of file scale_atm_phy_tb_dgm_common.F90.

497
498 implicit none
499
500 class(LocalMesh3D), intent(in) :: lmesh
501 class(ElementBase3D), intent(in) :: elem
502 class(LocalMesh2D), intent(in) :: lmesh2D
503 class(ElementBase2D), intent(in) :: elem2D
504 real(RP), intent(out) :: RHOQ_t(elem%Np,lmesh%NeA)
505 real(RP), intent(in) :: DFQ1(elem%Np,lmesh%NeA)
506 real(RP), intent(in) :: DFQ2(elem%Np,lmesh%NeA)
507 real(RP), intent(in) :: DFQ3(elem%Np,lmesh%NeA)
508 real(RP), intent(in) :: Kh (elem%Np,lmesh%NeA)
509 real(RP), intent(in) :: DDENS_(elem%Np,lmesh%NeA)
510 real(RP), intent(in) :: DENS_hyd(elem%Np,lmesh%NeA)
511 type(SparseMat), intent(in) :: Dx, Dy, Dz
512 type(SparseMat), intent(in) :: Sx, Sy, Sz
513 type(SparseMat), intent(in) :: Lift
514 logical, intent(in) :: is_bound(elem%NfpTot,lmesh%Ne)
515
516 integer :: ke
517
518 real(RP) :: Fx(elem%Np), Fy(elem%Np), Fz(elem%Np), LiftDelFlx(elem%Np)
519 real(RP) :: DENS(elem%Np), RHOT(elem%Np)
520 real(RP) :: del_flux(elem%NfpTot,lmesh%Ne)
521 !--------------------------------------------------------------------
522
523 call cal_bnd_flux_qtrc( del_flux, & ! (out)
524 dfq1, dfq2, dfq3, & ! (in)
525 kh, ddens_, dens_hyd, & ! (in)
526 lmesh%normal_fn(:,:,1), lmesh%normal_fn(:,:,2), lmesh%normal_fn(:,:,3), & ! (in)
527 lmesh%vmapM, lmesh%vmapP, & ! (in)
528 lmesh, elem, is_bound ) ! (in)
529
530 !$omp parallel do private( &
531 !$omp Fx, Fy, Fz, LiftDelFlx, &
532 !$omp DENS )
533 do ke=lmesh%NeS, lmesh%NeE
534 dens(:) = dens_hyd(:,ke) + ddens_(:,ke)
535
536 ! RHOQ
537 call sparsemat_matmul( dx, dens(:) * dfq1(:,ke), fx )
538 call sparsemat_matmul( dy, dens(:) * dfq2(:,ke), fy )
539 call sparsemat_matmul( dz, dens(:) * dfq3(:,ke), fz )
540 call sparsemat_matmul( lift, lmesh%Fscale(:,ke) * del_flux(:,ke), liftdelflx )
541
542 rhoq_t(:,ke) = lmesh%Escale(:,ke,1,1) * fx(:) + lmesh%Escale(:,ke,2,2) * fy(:) &
543 + lmesh%Escale(:,ke,3,3) * fz(:) + liftdelflx(:)
544 end do
545
546 return

Variable Documentation

◆ atmos_phy_tb_aux_t13_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_t13_id = 1

Definition at line 50 of file scale_atm_phy_tb_dgm_common.F90.

50 integer, public, parameter :: ATMOS_PHY_TB_AUX_T13_ID = 1

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_aux_t23_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_t23_id = 2

Definition at line 51 of file scale_atm_phy_tb_dgm_common.F90.

51 integer, public, parameter :: ATMOS_PHY_TB_AUX_T23_ID = 2

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_aux_t33_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_t33_id = 3

Definition at line 52 of file scale_atm_phy_tb_dgm_common.F90.

52 integer, public, parameter :: ATMOS_PHY_TB_AUX_T33_ID = 3

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_aux_diffflx3_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_diffflx3_id = 4

Definition at line 53 of file scale_atm_phy_tb_dgm_common.F90.

53 integer, public, parameter :: ATMOS_PHY_TB_AUX_DIFFFLX3_ID = 4

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_aux_t31_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_t31_id = 5

Definition at line 54 of file scale_atm_phy_tb_dgm_common.F90.

54 integer, public, parameter :: ATMOS_PHY_TB_AUX_T31_ID = 5

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_aux_t32_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_t32_id = 6

Definition at line 55 of file scale_atm_phy_tb_dgm_common.F90.

55 integer, public, parameter :: ATMOS_PHY_TB_AUX_T32_ID = 6

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_aux_diffflx1_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_diffflx1_id = 7

Definition at line 56 of file scale_atm_phy_tb_dgm_common.F90.

56 integer, public, parameter :: ATMOS_PHY_TB_AUX_DIFFFLX1_ID = 7

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_aux_diffflx2_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_diffflx2_id = 8

Definition at line 57 of file scale_atm_phy_tb_dgm_common.F90.

57 integer, public, parameter :: ATMOS_PHY_TB_AUX_DIFFFLX2_ID = 8

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_aux_t11_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_t11_id = 9

Definition at line 58 of file scale_atm_phy_tb_dgm_common.F90.

58 integer, public, parameter :: ATMOS_PHY_TB_AUX_T11_ID = 9

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_aux_t12_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_t12_id = 10

Definition at line 59 of file scale_atm_phy_tb_dgm_common.F90.

59 integer, public, parameter :: ATMOS_PHY_TB_AUX_T12_ID = 10

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_aux_t21_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_t21_id = 11

Definition at line 60 of file scale_atm_phy_tb_dgm_common.F90.

60 integer, public, parameter :: ATMOS_PHY_TB_AUX_T21_ID = 11

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_aux_t22_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_t22_id = 12

Definition at line 61 of file scale_atm_phy_tb_dgm_common.F90.

61 integer, public, parameter :: ATMOS_PHY_TB_AUX_T22_ID = 12

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_aux_scalar_num

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_scalar_num = 4

Definition at line 62 of file scale_atm_phy_tb_dgm_common.F90.

62 integer, public, parameter :: ATMOS_PHY_TB_AUX_SCALAR_NUM = 4

Referenced by mod_atmos_phy_tb_vars::atmosphytbvars_init().

◆ atmos_phy_tb_aux_hvec_num

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_hvec_num = 2

Definition at line 63 of file scale_atm_phy_tb_dgm_common.F90.

63 integer, public, parameter :: ATMOS_PHY_TB_AUX_HVEC_NUM = 2

Referenced by mod_atmos_phy_tb_vars::atmosphytbvars_init().

◆ atmos_phy_tb_aux_htensor_num

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_htensor_num = 1

Definition at line 64 of file scale_atm_phy_tb_dgm_common.F90.

64 integer, public, parameter :: ATMOS_PHY_TB_AUX_HTENSOR_NUM = 1

Referenced by mod_atmos_phy_tb_vars::atmosphytbvars_init().

◆ atmos_phy_tb_aux_num

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_aux_num = 12

Definition at line 65 of file scale_atm_phy_tb_dgm_common.F90.

65 integer, public, parameter :: ATMOS_PHY_TB_AUX_NUM = 12

Referenced by atm_phy_tb_dgm_common_setup_variables(), and mod_atmos_phy_tb_vars::atmosphytbvars_init().

◆ atmos_phy_tb_diag_tke_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_diag_tke_id = 1

Definition at line 67 of file scale_atm_phy_tb_dgm_common.F90.

67 integer, public, parameter :: ATMOS_PHY_TB_DIAG_TKE_ID = 1

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_diag_nu_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_diag_nu_id = 2

Definition at line 68 of file scale_atm_phy_tb_dgm_common.F90.

68 integer, public, parameter :: ATMOS_PHY_TB_DIAG_NU_ID = 2

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_diag_kh_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_diag_kh_id = 3

Definition at line 69 of file scale_atm_phy_tb_dgm_common.F90.

69 integer, public, parameter :: ATMOS_PHY_TB_DIAG_KH_ID = 3

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_diag_num

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_diag_num = 3

Definition at line 70 of file scale_atm_phy_tb_dgm_common.F90.

70 integer, public, parameter :: ATMOS_PHY_TB_DIAG_NUM = 3

Referenced by atm_phy_tb_dgm_common_setup_variables(), and mod_atmos_phy_tb_vars::atmosphytbvars_init().

◆ atmos_phy_tb_momx_t_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_momx_t_id = 1

Definition at line 72 of file scale_atm_phy_tb_dgm_common.F90.

72 integer, public, parameter :: ATMOS_PHY_TB_MOMX_t_ID = 1

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_momy_t_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_momy_t_id = 2

Definition at line 73 of file scale_atm_phy_tb_dgm_common.F90.

73 integer, public, parameter :: ATMOS_PHY_TB_MOMY_t_ID = 2

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_momz_t_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_momz_t_id = 3

Definition at line 74 of file scale_atm_phy_tb_dgm_common.F90.

74 integer, public, parameter :: ATMOS_PHY_TB_MOMZ_t_ID = 3

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_rhot_t_id

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_rhot_t_id = 4

Definition at line 75 of file scale_atm_phy_tb_dgm_common.F90.

75 integer, public, parameter :: ATMOS_PHY_TB_RHOT_t_ID = 4

Referenced by atm_phy_tb_dgm_common_setup_variables().

◆ atmos_phy_tb_tends_num1

integer, parameter, public scale_atm_phy_tb_dgm_common::atmos_phy_tb_tends_num1 = 4

Definition at line 76 of file scale_atm_phy_tb_dgm_common.F90.

76 integer, public, parameter :: ATMOS_PHY_TB_TENDS_NUM1 = 4

Referenced by atm_phy_tb_dgm_common_setup_variables(), and mod_atmos_phy_tb_vars::atmosphytbvars_init().