SCALE-RM
Functions/Subroutines
scale_atmos_phy_tb_dns Module Reference

module ATMOSPHERE / Physics Turbulence More...

Functions/Subroutines

subroutine, public atmos_phy_tb_dns_config (TYPE_TB, I_TKE_out)
 Config. More...
 
subroutine, public atmos_phy_tb_dns_setup (CDZ, CDX, CDY, CZ)
 
subroutine, public atmos_phy_tb_dns (qflx_sgs_MOMZ, qflx_sgs_MOMX, qflx_sgs_MOMY, qflx_sgs_rhot, qflx_sgs_rhoq, RHOQ_t, nu, Ri, Pr, MOMZ, MOMX, MOMY, POTT, DENS, QTRC, N2, SFLX_MW, SFLX_MU, SFLX_MV, SFLX_SH, SFLX_Q, FZ, FDZ, RCDZ, RFDZ, CDX, FDX, CDY, FDY, GSQRT, J13G, J23G, J33G, MAPF, dt)
 

Detailed Description

module ATMOSPHERE / Physics Turbulence

Description
Sub-grid scale turbulent process for DNS
Author
Team SCALE
NAMELIST
  • PARAM_ATMOS_PHY_TB_DNS
    nametypedefault valuecomment
    ATMOS_PHY_TB_DNS_NU real(RP) 1.512E-5_RP [m2/s] kinematic viscosity coefficient for air at 20degC
    ATMOS_PHY_TB_DNS_MU real(RP) 1.512E-5_RP same as NU (needed based on hyposes. see Mellado 2010)

History Output
No history output

Function/Subroutine Documentation

◆ atmos_phy_tb_dns_config()

subroutine, public scale_atmos_phy_tb_dns::atmos_phy_tb_dns_config ( character(len=*), intent(in)  TYPE_TB,
integer, intent(out)  I_TKE_out 
)

Config.

Definition at line 69 of file scale_atmos_phy_tb_dns.F90.

69  use scale_prc, only: &
70  prc_abort
71  implicit none
72 
73  character(len=*), intent(in) :: TYPE_TB
74  integer, intent(out) :: I_TKE_out
75  !---------------------------------------------------------------------------
76 
77  log_newline
78  log_info("ATMOS_PHY_TB_dns_config",*) 'Setup'
79  log_info("ATMOS_PHY_TB_dns_config",*) 'Tracers for Deardorff (1980) 1.5th TKE Model'
80 
81  if ( type_tb /= 'DNS' ) then
82  log_error("ATMOS_PHY_TB_dns_config",*) 'ATMOS_PHY_TB_TYPE is not DNS. Check!'
83  call prc_abort
84  endif
85 
86  i_tke_out = -1
87 
88  return

References scale_prc::prc_abort().

Referenced by mod_atmos_phy_tb_driver::atmos_phy_tb_driver_tracer_setup().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ atmos_phy_tb_dns_setup()

subroutine, public scale_atmos_phy_tb_dns::atmos_phy_tb_dns_setup ( real(rp), dimension(ka), intent(in)  CDZ,
real(rp), dimension(ia), intent(in)  CDX,
real(rp), dimension(ja), intent(in)  CDY,
real(rp), dimension (ka,ia,ja), intent(in)  CZ 
)

Definition at line 93 of file scale_atmos_phy_tb_dns.F90.

93  use scale_prc, only: &
94  prc_abort
95  implicit none
96 
97  real(RP), intent(in) :: CDZ(KA)
98  real(RP), intent(in) :: CDX(IA)
99  real(RP), intent(in) :: CDY(JA)
100  real(RP), intent(in) :: CZ (KA,IA,JA)
101 
102  namelist / param_atmos_phy_tb_dns / &
103  atmos_phy_tb_dns_nu, &
104  atmos_phy_tb_dns_mu
105 
106  integer :: ierr
107  !---------------------------------------------------------------------------
108 
109  log_newline
110  log_info("ATMOS_PHY_TB_dns_setup",*) 'Setup'
111  log_info("ATMOS_PHY_TB_dns_setup",*) 'Eddy Viscocity Model for DNS'
112 
113  !--- read namelist
114  rewind(io_fid_conf)
115  read(io_fid_conf,nml=param_atmos_phy_tb_dns,iostat=ierr)
116  if( ierr < 0 ) then !--- missing
117  log_info("ATMOS_PHY_TB_dns_setup",*) 'Not found namelist. Default used.'
118  elseif( ierr > 0 ) then !--- fatal error
119  log_error("ATMOS_PHY_TB_dns_setup",*) 'Not appropriate names in namelist PARAM_ATMOS_PHY_TB_DNS. Check!'
120  call prc_abort
121  endif
122  log_nml(param_atmos_phy_tb_dns)
123 
124  twod = ( ia == 1 )
125  if ( twod ) then
126  isn = 1
127  iep = 1
128  else
129  isn = is - 1
130  iep = ie + 1
131  end if
132 
133  return

References scale_atmos_grid_cartesc_index::ia, scale_atmos_grid_cartesc_index::ie, scale_io::io_fid_conf, scale_atmos_grid_cartesc_index::is, and scale_prc::prc_abort().

Referenced by mod_atmos_phy_tb_driver::atmos_phy_tb_driver_setup().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ atmos_phy_tb_dns()

subroutine, public scale_atmos_phy_tb_dns::atmos_phy_tb_dns ( real(rp), dimension(ka,ia,ja,3), intent(out)  qflx_sgs_MOMZ,
real(rp), dimension(ka,ia,ja,3), intent(out)  qflx_sgs_MOMX,
real(rp), dimension(ka,ia,ja,3), intent(out)  qflx_sgs_MOMY,
real(rp), dimension(ka,ia,ja,3), intent(out)  qflx_sgs_rhot,
real(rp), dimension(ka,ia,ja,3,qa), intent(out)  qflx_sgs_rhoq,
real(rp), dimension(ka,ia,ja,qa), intent(inout)  RHOQ_t,
real(rp), dimension(ka,ia,ja), intent(out)  nu,
real(rp), dimension(ka,ia,ja), intent(out)  Ri,
real(rp), dimension(ka,ia,ja), intent(out)  Pr,
real(rp), dimension(ka,ia,ja), intent(in)  MOMZ,
real(rp), dimension(ka,ia,ja), intent(in)  MOMX,
real(rp), dimension(ka,ia,ja), intent(in)  MOMY,
real(rp), dimension(ka,ia,ja), intent(in)  POTT,
real(rp), dimension(ka,ia,ja), intent(in)  DENS,
real(rp), dimension(ka,ia,ja,qa), intent(in)  QTRC,
real(rp), dimension(ka,ia,ja), intent(in)  N2,
real(rp), dimension(ia,ja), intent(in)  SFLX_MW,
real(rp), dimension(ia,ja), intent(in)  SFLX_MU,
real(rp), dimension(ia,ja), intent(in)  SFLX_MV,
real(rp), dimension(ia,ja), intent(in)  SFLX_SH,
real(rp), dimension (ia,ja,qa), intent(in)  SFLX_Q,
real(rp), dimension (0:ka,ia,ja), intent(in)  FZ,
real(rp), dimension (ka-1), intent(in)  FDZ,
real(rp), dimension (ka), intent(in)  RCDZ,
real(rp), dimension (ka-1), intent(in)  RFDZ,
real(rp), dimension (ia), intent(in)  CDX,
real(rp), dimension (ia-1), intent(in)  FDX,
real(rp), dimension (ja), intent(in)  CDY,
real(rp), dimension (ja-1), intent(in)  FDY,
real(rp), dimension (ka,ia,ja,7), intent(in)  GSQRT,
real(rp), dimension (ka,ia,ja,7), intent(in)  J13G,
real(rp), dimension (ka,ia,ja,7), intent(in)  J23G,
real(rp), intent(in)  J33G,
real(rp), dimension (ia,ja,2,4), intent(in)  MAPF,
real(dp), intent(in)  dt 
)
Parameters
[in]gsqrtvertical metrics {G}^1/2
[in]j13g(1,3) element of Jacobian matrix
[in]j23g(1,3) element of Jacobian matrix
[in]j33g(3,3) element of Jacobian matrix
[in]mapfmap factor

Definition at line 145 of file scale_atmos_phy_tb_dns.F90.

146  use scale_tracer
147  use scale_const, only: &
148  grav => const_grav
149  use scale_atmos_phy_tb_common, only: &
150  calc_strain_tensor => atmos_phy_tb_calc_strain_tensor, &
151  calc_flux_phi => atmos_phy_tb_calc_flux_phi
152  implicit none
153 
154  ! SGS flux
155  real(RP), intent(out) :: qflx_sgs_MOMZ(KA,IA,JA,3)
156  real(RP), intent(out) :: qflx_sgs_MOMX(KA,IA,JA,3)
157  real(RP), intent(out) :: qflx_sgs_MOMY(KA,IA,JA,3)
158  real(RP), intent(out) :: qflx_sgs_rhot(KA,IA,JA,3)
159  real(RP), intent(out) :: qflx_sgs_rhoq(KA,IA,JA,3,QA)
160 
161  real(RP), intent(inout) :: RHOQ_t(KA,IA,JA,QA) ! tendency of rho * QTRC
162 
163  real(RP), intent(out) :: nu(KA,IA,JA) ! eddy viscosity (center)
164  real(RP), intent(out) :: Ri(KA,IA,JA) ! Richardson number
165  real(RP), intent(out) :: Pr(KA,IA,JA) ! Prantle number
166 
167  real(RP), intent(in) :: MOMZ(KA,IA,JA)
168  real(RP), intent(in) :: MOMX(KA,IA,JA)
169  real(RP), intent(in) :: MOMY(KA,IA,JA)
170  real(RP), intent(in) :: POTT(KA,IA,JA)
171  real(RP), intent(in) :: DENS(KA,IA,JA)
172  real(RP), intent(in) :: QTRC(KA,IA,JA,QA)
173  real(RP), intent(in) :: N2(KA,IA,JA)
174 
175  real(RP), intent(in) :: SFLX_MW(IA,JA)
176  real(RP), intent(in) :: SFLX_MU(IA,JA)
177  real(RP), intent(in) :: SFLX_MV(IA,JA)
178  real(RP), intent(in) :: SFLX_SH(IA,JA)
179  real(RP), intent(in) :: SFLX_Q (IA,JA,QA)
180 
181  real(RP), intent(in) :: FZ (0:KA,IA,JA)
182  real(RP), intent(in) :: FDZ (KA-1)
183  real(RP), intent(in) :: RCDZ (KA)
184  real(RP), intent(in) :: RFDZ (KA-1)
185  real(RP), intent(in) :: CDX (IA)
186  real(RP), intent(in) :: FDX (IA-1)
187  real(RP), intent(in) :: CDY (JA)
188  real(RP), intent(in) :: FDY (JA-1)
189 
190  real(RP), intent(in) :: GSQRT (KA,IA,JA,7)
191  real(RP), intent(in) :: J13G (KA,IA,JA,7)
192  real(RP), intent(in) :: J23G (KA,IA,JA,7)
193  real(RP), intent(in) :: J33G
194  real(RP), intent(in) :: MAPF (IA,JA,2,4)
195  real(DP), intent(in) :: dt
196 
197  ! deformation rate tensor
198  real(RP) :: S33_C(KA,IA,JA) ! (cell center)
199  real(RP) :: S11_C(KA,IA,JA)
200  real(RP) :: S22_C(KA,IA,JA)
201  real(RP) :: S31_C(KA,IA,JA)
202  real(RP) :: S12_C(KA,IA,JA)
203  real(RP) :: S23_C(KA,IA,JA)
204  real(RP) :: S12_Z(KA,IA,JA) ! (z edge or x-y plane)
205  real(RP) :: S23_X(KA,IA,JA) ! (x edge or y-z plane)
206  real(RP) :: S31_Y(KA,IA,JA) ! (y edge or z-x plane)
207  real(RP) :: S2 (KA,IA,JA) ! |S|^2
208 
209  real(RP) :: Kh(KA,IA,JA) ! eddy diffusion
210 
211  ! implicit scheme (dummy)
212  real(RP) :: a (KA,IA,JA)
213  real(RP) :: b (KA,IA,JA)
214  real(RP) :: c (KA,IA,JA)
215 
216  integer :: IIS, IIE
217  integer :: JJS, JJE
218 
219  integer :: k, i, j, iq
220  !---------------------------------------------------------------------------
221 
222 
223  !$acc data copyout(qflx_sgs_MOMZ, qflx_sgs_MOMX, qflx_sgs_MOMY, qflx_sgs_rhot, qflx_sgs_rhoq, &
224  !$acc RHOQ_t, &
225  !$acc nu, Ri, Pr) &
226  !$acc copyin(MOMZ, MOMX, MOMY, POTT, DENS, QTRC, &
227  !$acc FZ, FDZ, RCDZ, RFDZ, CDX, FDX, CDY, FDY, GSQRT, J13G, J23G, MAPF) &
228  !$acc create(S33_C, S11_C, S22_C, S31_C, S12_C, S23_C, S12_Z, S23_X, S31_Y, S2, &
229  !$acc Kh, a, b, c)
230 
231  log_progress(*) 'atmosphere / physics / turbulence / DNS'
232 
233 #ifdef DEBUG
234  !$acc kernels
235  qflx_sgs_momz(:,:,:,:) = undef
236  qflx_sgs_momx(:,:,:,:) = undef
237  qflx_sgs_momy(:,:,:,:) = undef
238  qflx_sgs_rhot(:,:,:,:) = undef
239  qflx_sgs_rhoq(:,:,:,:,:) = undef
240 
241  nu(:,:,:) = undef
242  ri(:,:,:) = undef
243  pr(:,:,:) = undef
244  ri(:,:,:) = undef
245  kh(:,:,:) = undef
246  !$acc end kernels
247 #endif
248 
249  !$omp parallel workshare
250  !$acc kernels
251  nu(:,:,:) = 0.0_rp
252  ri(:,:,:) = 0.0_rp
253  pr(:,:,:) = 1.0_rp
254  kh(:,:,:) = atmos_phy_tb_dns_mu
255  !$acc end kernels
256  !$omp end parallel workshare
257 
258  !##### Start Upadate #####
259 
260  call calc_strain_tensor( &
261  s33_c, s11_c, s22_c, & ! (out)
262  s31_c, s12_c, s23_c, & ! (out)
263  s12_z, s23_x, s31_y, & ! (out)
264  s2 , & ! (out)
265  dens, momz, momx, momy, & ! (in)
266  gsqrt, j13g, j23g, j33g, mapf ) ! (in)
267 ! GSQRT, J13G, J23G, J33G, MAPF, & ! (in)
268 ! twoD ) ! (in)
269 
270  do jjs = js, je, jblock
271  jje = jjs+jblock-1
272  do iis = is, ie, iblock
273  iie = iis+iblock-1
274 
275  !##### momentum equation (z) #####
276 
277  !$omp parallel private(i,j,k)
278  ! (cell center)
279 
280  if ( twod ) then
281  i = iis
282  !$omp do
283  !$acc kernels
284  do j = jjs, jje
285  do k = ks+1, ke-1
286  qflx_sgs_momz(k,i,j,zdir) = dens(k,i,j) * ( &
287  - 2.0_rp * atmos_phy_tb_dns_nu &
288  * ( s33_c(k,i,j) - ( s22_c(k,i,j) + s33_c(k,i,j) ) * oneoverthree ) )
289  enddo
290  enddo
291  !$acc end kernels
292  else
293  !$omp do collapse(2)
294  !$acc kernels
295  do j = jjs, jje
296  do i = iis, iie
297  do k = ks+1, ke-1
298  qflx_sgs_momz(k,i,j,zdir) = dens(k,i,j) * ( &
299  - 2.0_rp * atmos_phy_tb_dns_nu &
300  * ( s33_c(k,i,j) - ( s11_c(k,i,j) + s22_c(k,i,j) + s33_c(k,i,j) ) * oneoverthree ) )
301  enddo
302  enddo
303  enddo
304  !$acc end kernels
305  end if
306 
307  !$omp do
308  !$acc kernels
309  do j = jjs, jje
310  do i = iis, iie
311  qflx_sgs_momz(ks,i,j,zdir) = 0.0_rp ! bottom boundary
312  qflx_sgs_momz(ke,i,j,zdir) = 0.0_rp ! top boundary
313  enddo
314  enddo
315  !$acc end kernels
316  !$omp end do nowait
317 
318  ! (y edge)
319  if ( .not. twod ) then
320  !$omp do collapse(2)
321  !$acc kernels
322  do j = jjs, jje
323  do i = iis-1, iie
324  do k = ks, ke-1
325  qflx_sgs_momz(k,i,j,xdir) = - 0.5_rp & ! 2/4
326  * ( dens(k,i,j)+dens(k+1,i,j)+dens(k,i+1,j)+dens(k+1,i+1,j) ) &
327  * atmos_phy_tb_dns_nu &
328  * s31_y(k,i,j)
329  enddo
330  enddo
331  enddo
332  !$acc end kernels
333  !$omp end do nowait
334  end if
335 
336  ! (x edge)
337  !$omp do collapse(2)
338  !$acc kernels
339  do j = jjs-1, jje
340  do i = iis, iie
341  do k = ks, ke-1
342  qflx_sgs_momz(k,i,j,ydir) = - 0.5_rp & ! 2/4
343  * ( dens(k,i,j)+dens(k+1,i,j)+dens(k,i,j+1)+dens(k+1,i,j+1) ) &
344  * atmos_phy_tb_dns_nu &
345  * s23_x(k,i,j)
346  enddo
347  enddo
348  enddo
349  !$acc end kernels
350  !$omp end do nowait
351 
352  !$omp end parallel
353 
354  !##### momentum equation (x) #####
355 
356  if ( .not. twod ) then
357 
358  !$omp parallel private(i,j,k)
359 
360  ! (y edge)
361 
362  !$omp do collapse(2)
363  !$acc kernels
364  do j = jjs, jje
365  do i = iis, iie
366  do k = ks, ke-1
367  qflx_sgs_momx(k,i,j,zdir) = - 0.5_rp & ! 2/4
368  * ( dens(k,i,j)+dens(k+1,i,j)+dens(k,i+1,j)+dens(k+1,i+1,j) ) &
369  * atmos_phy_tb_dns_nu &
370  * s31_y(k,i,j)
371  enddo
372  enddo
373  enddo
374  !$acc end kernels
375  !$omp end do nowait
376 
377  !$omp do
378  !$acc kernels
379  do j = jjs, jje
380  do i = iis, iie
381  qflx_sgs_momx(ks-1,i,j,zdir) = 0.0_rp ! bottom boundary
382  qflx_sgs_momx(ke ,i,j,zdir) = 0.0_rp ! top boundary
383  enddo
384  enddo
385  !$acc end kernels
386  !$omp end do nowait
387 
388  ! (cell center)
389  !$omp do collapse(2)
390  !$acc kernels
391  do j = jjs, jje
392  do i = iis, iie+1
393  do k = ks, ke
394  qflx_sgs_momx(k,i,j,xdir) = dens(k,i,j) * ( &
395  - 2.0_rp * atmos_phy_tb_dns_nu &
396  * ( s11_c(k,i,j) - ( s11_c(k,i,j) + s22_c(k,i,j) + s33_c(k,i,j) ) * oneoverthree ) )
397  enddo
398  enddo
399  enddo
400  !$acc end kernels
401  !$omp end do nowait
402 
403  ! (z edge)
404  !$omp do collapse(2)
405  !$acc kernels
406  do j = jjs-1, jje
407  do i = iis, iie
408  do k = ks, ke
409  qflx_sgs_momx(k,i,j,ydir) = - 0.5_rp & ! 2/4
410  * ( dens(k,i,j)+dens(k,i+1,j)+dens(k,i,j+1)+dens(k,i+1,j+1) ) &
411  * atmos_phy_tb_dns_nu &
412  * s12_z(k,i,j)
413  enddo
414  enddo
415  enddo
416  !$acc end kernels
417  !$omp end do nowait
418 
419  !$omp end parallel
420 
421  end if ! twoD
422 
423  !##### momentum equation (y) #####
424 
425  !$omp parallel private(i,j,k)
426 
427  ! (x edge)
428  !$omp do collapse(2)
429  !$acc kernels
430  do j = jjs, jje
431  do i = iis, iie
432  do k = ks, ke-1
433  qflx_sgs_momy(k,i,j,zdir) = - 0.5_rp & ! 2/4
434  * ( dens(k,i,j)+dens(k+1,i,j)+dens(k,i,j+1)+dens(k+1,i,j+1) ) &
435  * atmos_phy_tb_dns_nu &
436  * s23_x(k,i,j)
437  enddo
438  enddo
439  enddo
440  !$acc end kernels
441  !$omp end do nowait
442 
443  !$omp do
444  !$acc kernels
445  do j = jjs, jje
446  do i = iis, iie
447  qflx_sgs_momy(ks-1,i,j,zdir) = 0.0_rp ! bottom boundary
448  qflx_sgs_momy(ke ,i,j,zdir) = 0.0_rp ! top boundary
449  enddo
450  enddo
451  !$acc end kernels
452  !$omp end do nowait
453 
454  ! (z edge)
455  if ( .not. twod ) then
456  !$omp do collapse(2)
457  !$acc kernels
458  do j = jjs, jje
459  do i = iis-1, iie
460  do k = ks, ke
461  qflx_sgs_momy(k,i,j,xdir) = - 0.5_rp & ! 2/4
462  * ( dens(k,i,j)+dens(k,i+1,j)+dens(k,i,j+1)+dens(k,i+1,j+1) ) &
463  * atmos_phy_tb_dns_nu &
464  * s12_z(k,i,j)
465  enddo
466  enddo
467  enddo
468  !$acc end kernels
469  !$omp end do nowait
470  end if
471 
472  ! (z-x plane)
473  if ( twod ) then
474  i = iis
475  !$omp do
476  !$acc kernels
477  do j = jjs, jje+1
478  do k = ks, ke
479  qflx_sgs_momy(k,i,j,ydir) = dens(k,i,j) * ( &
480  - 2.0_rp * atmos_phy_tb_dns_nu &
481  * ( s22_c(k,i,j) - ( s22_c(k,i,j) + s33_c(k,i,j) ) * oneoverthree ) )
482  enddo
483  enddo
484  !$acc end kernels
485  !$omp end do nowait
486  else
487  !$omp do collapse(2)
488  !$acc kernels
489  do j = jjs, jje+1
490  do i = iis, iie
491  do k = ks, ke
492  qflx_sgs_momy(k,i,j,ydir) = dens(k,i,j) * ( &
493  - 2.0_rp * atmos_phy_tb_dns_nu &
494  * ( s22_c(k,i,j) - ( s11_c(k,i,j) + s22_c(k,i,j) + s33_c(k,i,j) ) * oneoverthree ) )
495  enddo
496  enddo
497  enddo
498  !$acc end kernels
499  !$omp end do nowait
500  end if
501 
502  !$omp end parallel
503 
504  !##### Thermodynamic Equation #####
505 
506  call calc_flux_phi( &
507  qflx_sgs_rhot, & ! [inout]
508  dens, pott, kh, 1.0_rp, & ! [in]
509  gsqrt, j13g, j23g, j33g, mapf, & ! [in]
510  .false., .false., & ! horizontal, implicit
511  a, b, c, dt, & ! [in, dummy]
512  iis, iie, jjs, jje )
513 ! IIS, IIE, JJS, JJE, &
514 ! twoD )
515  enddo
516  enddo
517 
518  !##### Tracers #####
519  do iq = 1, qa
520 
521  if ( .not. tracer_advc(iq) ) cycle
522 
523  do jjs = js, je, jblock
524  jje = jjs+jblock-1
525  do iis = is, ie, iblock
526  iie = iis+iblock-1
527 
528  call calc_flux_phi( &
529  qflx_sgs_rhoq(:,:,:,:,iq), & ! [inout]
530  dens, qtrc(:,:,:,iq), kh, 1.0_rp, & ! [in]
531  gsqrt, j13g, j23g, j33g, mapf, & ! [in]
532  .false., .false., & ! horizontal, implicit
533  a, b, c, dt, & ! [in, dummy]
534  iis, iie, jjs, jje )
535 ! IIS, IIE, JJS, JJE, &
536 ! twoD )
537 
538  enddo
539  enddo
540 
541  enddo ! scalar quantities loop
542 
543  !$acc end data
544 
545  return

References scale_atmos_phy_tb_common::atmos_phy_tb_calc_flux_phi(), scale_atmos_phy_tb_common::atmos_phy_tb_calc_strain_tensor(), scale_const::const_grav, scale_atmos_grid_cartesc_index::iblock, scale_atmos_grid_cartesc_index::ie, scale_atmos_grid_cartesc_index::is, scale_atmos_grid_cartesc_index::jblock, scale_atmos_grid_cartesc_index::je, scale_atmos_grid_cartesc_index::js, scale_tracer::k, scale_atmos_grid_cartesc_index::ke, scale_atmos_grid_cartesc_index::ks, scale_tracer::qa, scale_tracer::tracer_advc, scale_atmos_grid_cartesc_index::xdir, scale_atmos_grid_cartesc_index::ydir, and scale_atmos_grid_cartesc_index::zdir.

Referenced by mod_atmos_phy_tb_driver::atmos_phy_tb_driver_calc_tendency().

Here is the call graph for this function:
Here is the caller graph for this function:
scale_const::const_grav
real(rp), public const_grav
standard acceleration of gravity [m/s2]
Definition: scale_const.F90:49
scale_prc::prc_abort
subroutine, public prc_abort
Abort Process.
Definition: scale_prc.F90:350
scale_atmos_phy_tb_common::atmos_phy_tb_calc_strain_tensor
subroutine, public atmos_phy_tb_calc_strain_tensor(S33_C, S11_C, S22_C, S31_C, S12_C, S23_C, S12_Z, S23_X, S31_Y, S2, DENS, MOMZ, MOMX, MOMY, GSQRT, J13G, J23G, J33G, MAPF)
Definition: scale_atmos_phy_tb_common.F90:66
scale_atmos_grid_cartesc_index::jblock
integer, public jblock
block size for cache blocking: y
Definition: scale_atmos_grid_cartesC_index.F90:41
scale_tracer::tracer_advc
logical, dimension(qa_max), public tracer_advc
Definition: scale_tracer.F90:46
scale_atmos_grid_cartesc_index::iblock
integer, public iblock
block size for cache blocking: x
Definition: scale_atmos_grid_cartesC_index.F90:40
scale_prc
module PROCESS
Definition: scale_prc.F90:11
scale_atmos_grid_cartesc_index
module atmosphere / grid / cartesC index
Definition: scale_atmos_grid_cartesC_index.F90:12
scale_const
module CONSTANT
Definition: scale_const.F90:11
scale_atmos_grid_cartesc_index::zdir
integer, parameter, public zdir
Definition: scale_atmos_grid_cartesC_index.F90:32
scale_atmos_phy_tb_common::atmos_phy_tb_calc_flux_phi
subroutine, public atmos_phy_tb_calc_flux_phi(qflx_phi, DENS, PHI, Kh, FACT, GSQRT, J13G, J23G, J33G, MAPF, horizontal, implicit, a, b, c, dt, IIS, IIE, JJS, JJE)
Definition: scale_atmos_phy_tb_common.F90:1337
scale_tracer
module TRACER
Definition: scale_tracer.F90:12
scale_atmos_grid_cartesc_index::xdir
integer, parameter, public xdir
Definition: scale_atmos_grid_cartesC_index.F90:33
scale_atmos_phy_tb_common
module ATMOSPHERE / Physics Turbulence
Definition: scale_atmos_phy_tb_common.F90:12
scale_atmos_grid_cartesc_index::ydir
integer, parameter, public ydir
Definition: scale_atmos_grid_cartesC_index.F90:34