SCALE-RM
Functions/Subroutines | Variables
scale_atmos_phy_mp_suzuki10 Module Reference

module Spectran Bin Microphysics More...

Functions/Subroutines

subroutine, public atmos_phy_mp_suzuki10_tracer_setup
 Config. More...
 
subroutine, public atmos_phy_mp_suzuki10_setup (KA, IA, JA)
 Setup. More...
 
subroutine, public atmos_phy_mp_suzuki10_tendency (KA, KS, KE, IA, IS, IE, JA, JS, JE, KIJMAX, dt, DENS, PRES, TEMP, QTRC, QDRY, CPtot, CVtot, CCN, RHOQ_t, RHOE_t, CPtot_t, CVtot_t, EVAPORATE)
 Cloud Microphysics. More...
 
subroutine, public atmos_phy_mp_suzuki10_terminal_velocity (KA, vterm_o)
 get terminal velocity More...
 
subroutine, public atmos_phy_mp_suzuki10_cloud_fraction (KA, KS, KE, IA, IS, IE, JA, JS, JE, QTRC0, mask_criterion, cldfrac)
 Calculate Cloud Fraction. More...
 
subroutine, public atmos_phy_mp_suzuki10_effective_radius (KA, KS, KE, IA, IS, IE, JA, JS, JE, DENS0, TEMP0, QTRC0, Re)
 Calculate Effective Radius. More...
 
subroutine, public atmos_phy_mp_suzuki10_qtrc2qhyd (KA, KS, KE, IA, IS, IE, JA, JS, JE, QTRC0, Qe)
 Calculate mass ratio of each category. More...
 
subroutine, public atmos_phy_mp_suzuki10_qtrc2nhyd (KA, KS, KE, IA, IS, IE, JA, JS, JE, DENS, QTRC0, Ne)
 Calculate number concentration of each category. More...
 
subroutine, public atmos_phy_mp_suzuki10_qhyd2qtrc (KA, KS, KE, IA, IS, IE, JA, JS, JE, Qe, QTRC, QNUM)
 get mass ratio of each category More...
 

Variables

integer, public atmos_phy_mp_suzuki10_ntracers
 
integer, public atmos_phy_mp_suzuki10_nwaters
 
integer, public atmos_phy_mp_suzuki10_nices
 
integer, public atmos_phy_mp_suzuki10_nccn
 
character(len=h_short), dimension(:), allocatable, public atmos_phy_mp_suzuki10_tracer_names
 
character(len=h_mid), dimension(:), allocatable, public atmos_phy_mp_suzuki10_tracer_descriptions
 
character(len=h_short), dimension(:), allocatable, public atmos_phy_mp_suzuki10_tracer_units
 
integer, public nbin = 33
 
integer, public nccn = 0
 

Detailed Description

module Spectran Bin Microphysics

Description:
This module contains subroutines for the Spectral Bin Model
Author
: Team SCALE
NAMELIST
  • PARAM_ATMOS_PHY_MP_SUZUKI10_bin
    nametypedefault valuecomment
    NBIN integer 33 tentatively public
    NCCN integer 0 tentatively public
    ICEFLG integer 1
    KPHASE integer 0

  • PARAM_ATMOS_PHY_MP_SUZUKI10
    nametypedefault valuecomment
    MP_DOAUTOCONVERSION logical .true. apply collision process ?
    MP_COUPLE_AEROSOL logical .false. apply CCN effect?
    RHO_AERO real(RP) — density of aerosol
    R_MIN real(RP) — minimum radius of aerosol (um)
    R_MAX real(RP) — maximum radius of aerosol (um)
    R0_AERO real(RP) — center radius of aerosol (um)
    S10_EMAER real(RP) — moleculer weight of aerosol
    S10_FLAG_REGENE logical — flag of regeneration
    S10_FLAG_NUCLEAT logical — flag of regeneration
    S10_FLAG_ICENUCLEAT logical — flag of regeneration
    S10_FLAG_SFAERO logical — flag of surface flux of aeorol
    S10_RNDM_FLGP integer — flag of surface flux of aeorol
    S10_RNDM_MSPC integer
    S10_RNDM_MBIN integer
    C_CCN real(RP) 100.E+6_RP N0 of Nc = N0*s^kappa
    KAPPA real(RP) 0.462_RP kappa of Nc = N0*s^kappa
    SIGMA real(RP) 7.5E-02_RP water surface tension N/m2
    VHFCT real(RP) 2.0_RP van't hoff factor (i in eq.(A.11) of Suzuki (2004))

History Output
No history output

Function/Subroutine Documentation

◆ atmos_phy_mp_suzuki10_tracer_setup()

subroutine, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_tracer_setup ( )

Config.

Definition at line 287 of file scale_atmos_phy_mp_suzuki10.F90.

References atmos_phy_mp_suzuki10_nccn, atmos_phy_mp_suzuki10_nices, atmos_phy_mp_suzuki10_ntracers, atmos_phy_mp_suzuki10_nwaters, atmos_phy_mp_suzuki10_tracer_descriptions, atmos_phy_mp_suzuki10_tracer_names, atmos_phy_mp_suzuki10_tracer_units, scale_io::io_fid_conf, nbin, nccn, and scale_prc::prc_abort().

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_tracer_setup().

287  use scale_prc, only: &
288  prc_abort
289  implicit none
290 
291  namelist / param_atmos_phy_mp_suzuki10_bin / &
292  nbin, &
293  nccn, &
294  iceflg, &
295  kphase
296 
297  integer :: m, n, ierr
298  !---------------------------------------------------------------------------
299 
300  log_newline
301  log_info("ATMOS_PHY_MP_suzuki10_tracer_setup",*) 'Setup'
302  log_info("ATMOS_PHY_MP_suzuki10_tracer_setup",*) 'Tracers setup for Suzuki (2010) Spectral BIN model'
303 
304  log_newline
305  log_info("ATMOS_PHY_MP_suzuki10_tracer_setup",*) 'READ BIN NUMBER'
306 
307  rewind(io_fid_conf)
308  read(io_fid_conf,nml=param_atmos_phy_mp_suzuki10_bin,iostat=ierr)
309 
310  if( ierr < 0 ) then !--- missing
311  log_info("ATMOS_PHY_MP_suzuki10_tracer_setup",*) 'Not found namelist. Default used.'
312  elseif( ierr > 0 ) then !--- fatal error
313  log_error("ATMOS_PHY_MP_suzuki10_tracer_setup",*) 'Not appropriate names in namelist PARAM_ATMOS_PHY_MP_SUZUKI10_bin, Check!'
314  call prc_abort
315  end if
316 
317  log_nml(param_atmos_phy_mp_suzuki10_bin)
318 
319  if( iceflg == 0 ) then
320  nspc = 1
321  elseif( iceflg == 1 ) then
322  nspc = 7
323  else
324  log_error("ATMOS_PHY_MP_suzuki10_tracer_setup",*) "ICEFLG should be 0 (warm rain) or 1 (mixed rain) check!!"
325  call prc_abort
326  endif
327 
328  atmos_phy_mp_suzuki10_ntracers = 1 + nbin*nspc + nccn ! number of total tracers
329  atmos_phy_mp_suzuki10_nwaters = nbin ! number of liquid water
330  atmos_phy_mp_suzuki10_nices = nbin * ( nspc - 1 ) ! number of ice water
331  atmos_phy_mp_suzuki10_nccn = nccn ! number of ccn
332 
333  num_start_waters = i_qv + 1
334  num_end_waters = i_qv + atmos_phy_mp_suzuki10_nwaters
335  num_start_ices = num_end_waters + 1
336  num_end_ices = num_end_waters + atmos_phy_mp_suzuki10_nices
337 
338  qa = atmos_phy_mp_suzuki10_ntracers
339 
340  allocate( atmos_phy_mp_suzuki10_tracer_names(qa) )
341  allocate( atmos_phy_mp_suzuki10_tracer_descriptions(qa) )
342  allocate( atmos_phy_mp_suzuki10_tracer_units(qa) )
343 
344  !---------------------------------------------------------------------------
345  !
346  !++ calculate each category and aerosol
347  !
348  !---------------------------------------------------------------------------
349 
350  do n = 1, qa
351  write(atmos_phy_mp_suzuki10_tracer_units(n),'(a)') 'kg/kg'
352  enddo
353 
354  write(atmos_phy_mp_suzuki10_tracer_names(1),'(a)') 'QV'
355  write(atmos_phy_mp_suzuki10_tracer_descriptions(1),'(a)') 'Water Vapor mixing ratio'
356 
357  do m = 1, nspc
358  do n = 1, nbin
359  write(atmos_phy_mp_suzuki10_tracer_names(1+nbin*(m-1)+n),'(a,i0)') trim(namspc(m)), n
360  write(atmos_phy_mp_suzuki10_tracer_descriptions(1+nbin*(m-1)+n),'(a,i0)') trim(lnamspc(m)), n
361  enddo
362  enddo
363 
364  do n = 1, nccn
365  write(atmos_phy_mp_suzuki10_tracer_names(1+nbin*nspc+n),'(a,i0)') trim(namspc(8)), n
366  write(atmos_phy_mp_suzuki10_tracer_descriptions(1+nbin*nspc+n),'(a,i0)') trim(lnamspc(8)), n
367  enddo
368 
369  return
integer, public io_fid_conf
Config file ID.
Definition: scale_io.F90:55
module PROCESS
Definition: scale_prc.F90:11
subroutine, public prc_abort
Abort Process.
Definition: scale_prc.F90:338
Here is the call graph for this function:
Here is the caller graph for this function:

◆ atmos_phy_mp_suzuki10_setup()

subroutine, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_setup ( integer, intent(in)  KA,
integer, intent(in)  IA,
integer, intent(in)  JA 
)

Setup.

Definition at line 376 of file scale_atmos_phy_mp_suzuki10.F90.

References scale_comm_cartesc::comm_datatype, scale_comm_cartesc::comm_world, scale_const::const_dice, scale_const::const_dwatr, scale_const::const_pi, scale_atmos_hydrometeor::i_hc, scale_atmos_hydrometeor::i_hg, scale_atmos_hydrometeor::i_hh, scale_atmos_hydrometeor::i_hi, scale_atmos_hydrometeor::i_hr, scale_atmos_hydrometeor::i_hs, scale_io::io_fid_conf, scale_io::io_get_available_fid(), nbin, nccn, scale_prc::prc_abort(), scale_prc::prc_ismaster, and scale_prc::prc_masterrank.

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_setup().

376  use scale_prc, only: &
377  prc_abort, &
378  prc_masterrank, &
380  use scale_const, only: &
381  pi => const_pi, &
382  dwatr => const_dwatr, &
383  dice => const_dice
384  use scale_comm_cartesc, only: &
385  comm_world, &
387  use scale_atmos_hydrometeor, only: &
388  i_hc, &
389  i_hr, &
390  i_hi, &
391  i_hs, &
392  i_hg, &
393  i_hh
394  implicit none
395 
396  integer, intent(in) :: ka
397  integer, intent(in) :: ia
398  integer, intent(in) :: ja
399 
400  real(RP) :: rho_aero !--- density of aerosol
401  real(RP) :: r0_aero !--- center radius of aerosol (um)
402  real(RP) :: r_min !--- minimum radius of aerosol (um)
403  real(RP) :: r_max !--- maximum radius of aerosol (um)
404  real(RP) :: s10_emaer !--- moleculer weight of aerosol
405 
406  logical :: s10_flag_regene !--- flag of regeneration
407  logical :: s10_flag_nucleat !--- flag of regeneration
408  logical :: s10_flag_icenucleat !--- flag of regeneration
409  logical :: s10_flag_sfaero !--- flag of surface flux of aeorol
410  integer :: s10_rndm_flgp !--- flag of surface flux of aeorol
411  integer :: s10_rndm_mspc
412  integer :: s10_rndm_mbin
413 
414  namelist / param_atmos_phy_mp_suzuki10 / &
415  mp_doautoconversion, &
416  mp_couple_aerosol, &
417  rho_aero, &
418  r_min, &
419  r_max, &
420  r0_aero, &
421  s10_emaer, &
422  s10_flag_regene, &
423  s10_flag_nucleat, &
424  s10_flag_icenucleat, &
425  s10_flag_sfaero, &
426  s10_rndm_flgp, &
427  s10_rndm_mspc, &
428  s10_rndm_mbin, &
429  c_ccn, kappa, &
430  sigma, vhfct
431 
432  real(RP), parameter :: max_term_vel = 10.0_rp !-- terminal velocity for calculate dt of sedimentation
433 
434  integer :: nnspc, nnbin
435  integer :: nn, mm, mmyu, nnyu
436  integer :: myu, nyu, i, j, k, n, ierr
437  !---------------------------------------------------------------------------
438 
439  log_newline
440  log_info("ATMOS_PHY_MP_suzuki10_setup",*) 'Setup'
441  log_info("ATMOS_PHY_MP_suzuki10_setup",*) 'Suzuki (2010) Spectral BIN model'
442 
443  !--- allocation
444  allocate( xctr( nbin ) )
445  allocate( xbnd( nbin+1 ) )
446  allocate( radc( nbin ) )
447  allocate( cctr( nbin,nspc_mk ) )
448  allocate( cbnd( nbin+1,nspc_mk ) )
449  allocate( ck( nspc_mk,nspc_mk,nbin,nbin ) )
450  allocate( vt( nspc_mk,nbin ) )
451  allocate( br( nspc_mk,nbin ) )
452  allocate( ifrsl( 2,nspc_mk,nspc_mk ) )
453  allocate( expxctr( nbin ) )
454  allocate( expxbnd( nbin+1 ) )
455  allocate( rexpxctr( nbin ) )
456  allocate( rexpxbnd( nbin+1 ) )
457  if ( nccn /= 0 ) then
458  allocate( xactr( nccn ) )
459  allocate( xabnd( nccn+1 ) )
460  allocate( rada( nccn ) )
461  allocate( expxactr( nccn ) )
462  allocate( expxabnd( nccn+1 ) )
463  allocate( rexpxactr( nccn ) )
464  allocate( rexpxabnd( nccn+1 ) )
465  endif
466 
467  mbin = nbin/2
468  mspc = nspc_mk*nspc_mk
469 
470  rho_aero = rhoa
471  s10_emaer = emaer
472  r_min = rasta
473  r_max = raend
474  r0_aero = r0a
475  s10_flag_regene = flg_regeneration
476  s10_flag_nucleat = flg_nucl
477  s10_flag_icenucleat = flg_icenucl
478  s10_flag_sfaero = flg_sf_aero
479  s10_rndm_flgp = rndm_flgp
480  s10_rndm_mspc = mspc
481  s10_rndm_mbin = mbin
482 
483  rewind(io_fid_conf)
484  read(io_fid_conf,nml=param_atmos_phy_mp_suzuki10,iostat=ierr)
485 
486  if ( ierr < 0 ) then !--- missing
487  log_info("ATMOS_PHY_MP_suzuki10_setup",*) 'Not found namelist. Default used.'
488  elseif( ierr > 0 ) then !--- fatal error
489  log_error("ATMOS_PHY_MP_suzuki10_setup",*) 'Not appropriate names in namelist PARAM_ATMOS_PHY_MP_SUZUKI10, Check!'
490  call prc_abort
491  endif
492  log_nml(param_atmos_phy_mp_suzuki10)
493 
494  if ( nspc /= 1 .AND. nspc /= 7 ) then
495  log_error("ATMOS_PHY_MP_suzuki10_setup",*) 'nspc should be set as 1 (warm rain) or 7 (mixed phase) check!'
496  call prc_abort
497  endif
498 
499  rhoa = rho_aero
500  emaer = s10_emaer
501  rasta = r_min
502  raend = r_max
503  r0a = r0_aero
504  flg_regeneration = s10_flag_regene
505  flg_nucl = s10_flag_nucleat
506  flg_icenucl = s10_flag_icenucleat
507  flg_sf_aero = s10_flag_sfaero
508  rndm_flgp = s10_rndm_flgp
509  mspc = s10_rndm_mspc
510  mbin = s10_rndm_mbin
511 
512  !--- read micpara.dat (microphysical parameter) and broad cast
513  if ( prc_ismaster ) then
514 
515  fid_micpara = io_get_available_fid()
516  !--- open parameter of cloud microphysics
517  open ( fid_micpara, file = fname_micpara, form = 'formatted', status = 'old', iostat=ierr )
518 
519  !--- micpara.dat does not exist
520  if ( ierr == 0 ) then
521 
522  read( fid_micpara,* ) nnspc, nnbin
523 
524  if ( nnbin /= nbin ) then
525  log_error("ATMOS_PHY_MP_suzuki10_setup",*) 'nbin in namelist and nbin in micpara.dat is different check!'
526  call prc_abort
527  endif
528 
529  ! grid parameter
530  log_info("ATMOS_PHY_MP_suzuki10_setup",*) 'Radius of cloud *'
531  do n = 1, nbin
532  read( fid_micpara,* ) nn, xctr( n ), radc( n )
533  log_info("ATMOS_PHY_MP_suzuki10_setup",'(A,1x,I3,1x,A,1x,ES15.7,1x,A)') &
534  "Radius of ", n, "th cloud bin (bin center)= ", radc( n ) , "[m]"
535  enddo
536  do n = 1, nbin+1
537  read( fid_micpara,* ) nn, xbnd( n )
538  enddo
539  read( fid_micpara,* ) dxmic
540  log_info("ATMOS_PHY_MP_suzuki10_setup",*) 'Width of Cloud SDF= ', dxmic
541 
542  ! capacity
543  do myu = 1, nspc_mk
544  do n = 1, nbin
545 ! read( fid_micpara,* ) mmyu, nn, cctr( myu,n )
546  read( fid_micpara,* ) mmyu, nn, cctr( n,myu )
547  enddo
548  do n = 1, nbin+1
549 ! read( fid_micpara,* ) mmyu, nn, cbnd( myu,n )
550  read( fid_micpara,* ) mmyu, nn, cbnd( n,myu )
551  enddo
552  enddo
553 
554  ! collection kernel
555  do myu = 1, nspc_mk
556  do nyu = 1, nspc_mk
557  do i = 1, nbin
558  do j = 1, nbin
559  read( fid_micpara,* ) mmyu, nnyu, mm, nn, ck( myu,nyu,i,j )
560  enddo
561  enddo
562  enddo
563  enddo
564 
565  ! terminal velocity
566  do myu = 1, nspc_mk
567  do n = 1, nbin
568  read( fid_micpara,* ) mmyu, nn, vt( myu,n )
569  enddo
570  enddo
571 
572  ! bulk density
573  do myu = 1, nspc_mk
574  do n = 1, nbin
575  read( fid_micpara,* ) mmyu, nn, br( myu,n )
576  enddo
577  enddo
578 
579  close ( fid_micpara )
580 
581  !--- micpara.dat does not exist
582  else
583 
584  log_info("ATMOS_PHY_MP_suzuki10_setup",*) 'micpara.dat is created'
585  call mkpara
586 
587  fid_micpara = io_get_available_fid()
588  !--- open parameter of cloud microphysics
589  open ( fid_micpara, file = fname_micpara, form = 'formatted', status = 'old', iostat=ierr )
590 
591  read( fid_micpara,* ) nnspc, nnbin
592 
593  if ( nnbin /= nbin ) then
594  log_error("ATMOS_PHY_MP_suzuki10_setup",*) 'nbin in inc_tracer and nbin in micpara.dat is different check!'
595  call prc_abort
596  endif
597 
598  ! grid parameter
599  log_info("ATMOS_PHY_MP_suzuki10_setup",*) 'Radius of cloud *'
600  do n = 1, nbin
601  read( fid_micpara,* ) nn, xctr( n ), radc( n )
602  log_info("ATMOS_PHY_MP_suzuki10_setup",'(A,1x,I3,1x,A,1x,ES15.7,1x,A)') &
603  "Radius of ", n, "th cloud bin (bin center)= ", radc( n ) , "[m]"
604  enddo
605  do n = 1, nbin+1
606  read( fid_micpara,* ) nn, xbnd( n )
607  enddo
608  read( fid_micpara,* ) dxmic
609  log_info("ATMOS_PHY_MP_suzuki10_setup",*) 'Width of Cloud SDF= ', dxmic
610 
611  ! capacity
612  do myu = 1, nspc_mk
613  do n = 1, nbin
614 ! read( fid_micpara,* ) mmyu, nn, cctr( myu,n )
615  read( fid_micpara,* ) mmyu, nn, cctr( n,myu )
616  enddo
617  do n = 1, nbin+1
618 ! read( fid_micpara,* ) mmyu, nn, cbnd( myu,n )
619  read( fid_micpara,* ) mmyu, nn, cbnd( n,myu )
620  enddo
621  enddo
622 
623  ! collection kernel
624  do myu = 1, nspc_mk
625  do nyu = 1, nspc_mk
626  do i = 1, nbin
627  do j = 1, nbin
628  read( fid_micpara,* ) mmyu, nnyu, mm, nn, ck( myu,nyu,i,j )
629  enddo
630  enddo
631  enddo
632  enddo
633 
634  ! terminal velocity
635  do myu = 1, nspc_mk
636  do n = 1, nbin
637  read( fid_micpara,* ) mmyu, nn, vt( myu,n )
638  enddo
639  enddo
640 
641  ! bulk density
642  do myu = 1, nspc_mk
643  do n = 1, nbin
644  read( fid_micpara,* ) mmyu, nn, br( myu,n )
645  enddo
646  enddo
647 
648  close ( fid_micpara )
649 
650  endif
651 
652  endif
653 
654  call mpi_bcast( radc, nbin, comm_datatype, prc_masterrank, comm_world, ierr )
655  call mpi_bcast( xctr, nbin, comm_datatype, prc_masterrank, comm_world, ierr )
656  call mpi_bcast( dxmic,1, comm_datatype, prc_masterrank, comm_world, ierr )
657  call mpi_bcast( xbnd, nbin+1, comm_datatype, prc_masterrank, comm_world, ierr )
658  call mpi_bcast( cctr, nbin*nspc_mk, comm_datatype, prc_masterrank, comm_world, ierr )
659  call mpi_bcast( cbnd, (nbin+1)*nspc_mk, comm_datatype, prc_masterrank, comm_world, ierr )
660  call mpi_bcast( ck, nspc_mk*nspc_mk*nbin*nbin, comm_datatype, prc_masterrank, comm_world, ierr )
661  call mpi_bcast( br, nbin*nspc_mk, comm_datatype, prc_masterrank, comm_world, ierr )
662  call mpi_bcast( vt, nbin*nspc_mk, comm_datatype, prc_masterrank, comm_world, ierr )
663 
664  !--- aerosol ( CCN ) (not supported)
665  if ( nccn /= 0 ) then
666 
667  allocate ( ncld( 1:nccn ) )
668  xasta = log( rhoa*4.0_rp/3.0_rp*pi * ( rasta )**3 )
669  xaend = log( rhoa*4.0_rp/3.0_rp*pi * ( raend )**3 )
670 
671  dxaer = ( xaend-xasta )/nccn
672 
673  do n = 1, nccn+1
674  xabnd( n ) = xasta + dxaer*( n-1 )
675  enddo
676  do n = 1, nccn
677  xactr( n ) = ( xabnd( n )+xabnd( n+1 ) )*0.50_rp
678  rada( n ) = ( exp( xactr( n ) )*thirdovforth/pi/rhoa )**( oneovthird )
679  log_info("ATMOS_PHY_MP_suzuki10_setup",'(A,1x,I3,1x,A,1x,ES15.7,1x,A)') &
680  "Radius of ", n, "th aerosol bin (bin center)= ", rada( n ) , "[m]"
681  enddo
682 
683  if ( flg_sf_aero ) then
684  log_error("ATMOS_PHY_MP_suzuki10_setup",*) "flg_sf_aero=true is not supported stop!! "
685  call prc_abort
686 ! if ( CZ(KS) >= 10.0_RP ) then
687 ! R10M1 = 10.0_RP / CZ(KS) * 0.50_RP ! scale with height
688 ! R10M2 = 10.0_RP / CZ(KS) * 0.50_RP ! scale with height
689 ! R10H1 = 1.0_RP * 0.50_RP
690 ! R10H2 = 1.0_RP * 0.0_RP
691 ! R10E1 = 1.0_RP * 0.50_RP
692 ! R10E2 = 1.0_RP * 0.50_RP
693 ! K10_1 = KS
694 ! K10_2 = KS
695 ! else
696 ! k = 1
697 ! do while ( CZ(k) < 10.0_RP )
698 ! k = k + 1
699 ! K10_1 = k
700 ! K10_2 = k + 1
701 ! R10M1 = ( CZ(k+1) - 10.0_RP ) / CDZ(k)
702 ! R10M2 = ( 10.0_RP - CZ(k) ) / CDZ(k)
703 ! R10H1 = ( CZ(k+1) - 10.0_RP ) / CDZ(k)
704 ! R10H2 = ( 10.0_RP - CZ(k) ) / CDZ(k)
705 ! R10E1 = ( CZ(k+1) - 10.0_RP ) / CDZ(k)
706 ! R10E2 = ( 10.0_RP - CZ(k) ) / CDZ(k)
707 ! enddo
708 ! endif
709  endif
710 
711  endif
712 
713  !--- determine nbnd
714  do n = 1, nbin
715  if( radc( n ) > rbnd ) then
716  nbnd = n
717  exit
718  endif
719  enddo
720  log_info("ATMOS_PHY_MP_suzuki10_setup",'(A,ES15.7,A)') 'Radius between cloud and rain is ', radc(nbnd), '[m]'
721 
722  !--- random number setup for stochastic method
723  if ( rndm_flgp > 0 ) then
724  call random_setup( ia*ja*ka )
725  endif
726 
727  if ( mp_couple_aerosol .AND. nccn /=0 ) then
728  log_error("ATMOS_PHY_MP_suzuki10_setup",*) 'nccn should be 0 when MP_couple_aerosol = .true. !! stop'
729  call prc_abort
730  endif
731 
732  if ( nccn /= 0 ) then
733  do n = 1, nccn
734  expxactr( n ) = exp( xactr( n ) )
735  rexpxactr( n ) = 1.0_rp / exp( xactr( n ) )
736  enddo
737  do n = 1, nccn+1
738  expxabnd( n ) = exp( xabnd( n ) )
739  rexpxabnd( n ) = 1.0_rp / exp( xabnd( n ) )
740  enddo
741  endif
742 
743  allocate( vterm(qa-1) )
744  vterm(:) = 0.0_rp
745  do myu = 1, nspc
746  do n = 1, nbin
747  vterm((myu-1)*nbin+n) = -vt( myu,n )
748  enddo
749  enddo
750  do n = 1, nbin
751  expxctr( n ) = exp( xctr( n ) )
752  rexpxctr( n ) = 1.0_rp / exp( xctr( n ) )
753  enddo
754  do n = 1, nbin+1
755  expxbnd( n ) = exp( xbnd( n ) )
756  rexpxbnd( n ) = 1.0_rp / exp( xbnd( n ) )
757  enddo
758 
759  allocate( kindx(nbin,nbin) )
760  call getrule( ifrsl,kindx )
761 
762  !--- determine the parameters for interpolating SDF from qxx, Nxx of parent domain
763  sigma_sdf(1) = 0.2_rp
764  sigma_sdf(2) = 0.35_rp
765  sigma_sdf(3) = 0.35_rp
766  sigma_sdf(4) = 0.35_rp
767  sigma_sdf(5) = 0.35_rp
768  r0_sdf(1) = 5.e-6_rp
769  r0_sdf(2) = 2.61e-6_rp
770  r0_sdf(3) = 5.e-6_rp
771  r0_sdf(4) = 2.61e-6_rp
772  r0_sdf(5) = 2.61e-6_rp ! to be corrected
773  n0_sdf(1) = 8.0e+6_rp
774  n0_sdf(2) = 0.0_rp
775  n0_sdf(3) = 3.0e+6_rp
776  n0_sdf(4) = 4.0e+6_rp
777  n0_sdf(5) = 4.0e+6_rp ! to be corrected
778  rho_sdf(1) = dwatr
779  rho_sdf(2) = dice
780  rho_sdf(3) = 100.0_rp
781  rho_sdf(4) = 400.0_rp
782  rho_sdf(5) = 400.0_rp ! to be corrected
783 
784  !--- determine the parameters for interpolating SDF from qxx, Nxx of parent domain
785  sigma_sdf(1) = 0.2_rp
786  sigma_sdf(2) = 0.35_rp
787  sigma_sdf(3) = 0.35_rp
788  sigma_sdf(4) = 0.35_rp
789  sigma_sdf(5) = 0.35_rp
790  r0_sdf(1) = 5.e-6_rp
791  r0_sdf(2) = 2.61e-6_rp
792  r0_sdf(3) = 5.e-6_rp
793  r0_sdf(4) = 2.61e-6_rp
794  r0_sdf(5) = 2.61e-6_rp ! to be corrected
795  n0_sdf(1) = 8.0e+6_rp
796  n0_sdf(2) = 0.0_rp
797  n0_sdf(3) = 3.0e+6_rp
798  n0_sdf(4) = 4.0e+6_rp
799  n0_sdf(5) = 4.0e+6_rp ! to be corrected
800  rho_sdf(1) = dwatr
801  rho_sdf(2) = dice
802  rho_sdf(3) = 100.0_rp
803  rho_sdf(4) = 400.0_rp
804  rho_sdf(5) = 400.0_rp ! to be corrected
805 
806  return
integer, public comm_world
communication world ID
real(rp), parameter, public const_dwatr
density of water [kg/m3]
Definition: scale_const.F90:82
integer, public ia
of whole cells: x, local, with HALO
integer, parameter, public i_hs
snow
subroutine, public random_setup
Setup.
integer, public comm_datatype
datatype of variable
integer, parameter, public i_hr
liquid water rain
integer, parameter, public i_hi
ice water cloud
integer, public ja
of whole cells: y, local, with HALO
integer, public io_fid_conf
Config file ID.
Definition: scale_io.F90:55
integer, parameter, public i_hh
hail
real(rp), parameter, public const_dice
density of ice [kg/m3]
Definition: scale_const.F90:83
module COMMUNICATION
module atmosphere / hydrometeor
integer function, public io_get_available_fid()
search & get available file ID
Definition: scale_io.F90:313
module PROCESS
Definition: scale_prc.F90:11
integer, parameter, public prc_masterrank
master process in each communicator
Definition: scale_prc.F90:65
subroutine, public prc_abort
Abort Process.
Definition: scale_prc.F90:338
module CONSTANT
Definition: scale_const.F90:11
integer, parameter, public i_hc
liquid water cloud
logical, public prc_ismaster
master process in local communicator?
Definition: scale_prc.F90:90
integer, public ka
of whole cells: z, local, with HALO
real(rp), public const_pi
pi
Definition: scale_const.F90:31
integer, parameter, public i_hg
graupel
Here is the call graph for this function:
Here is the caller graph for this function:

◆ atmos_phy_mp_suzuki10_tendency()

subroutine, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_tendency ( integer, intent(in)  KA,
integer, intent(in)  KS,
integer, intent(in)  KE,
integer, intent(in)  IA,
integer, intent(in)  IS,
integer, intent(in)  IE,
integer, intent(in)  JA,
integer, intent(in)  JS,
integer, intent(in)  JE,
integer, intent(in)  KIJMAX,
real(dp), intent(in)  dt,
real(rp), dimension (ka,ia,ja), intent(in)  DENS,
real(rp), dimension (ka,ia,ja), intent(in)  PRES,
real(rp), dimension (ka,ia,ja), intent(in)  TEMP,
real(rp), dimension (ka,ia,ja,qa), intent(in)  QTRC,
real(rp), dimension (ka,ia,ja), intent(in)  QDRY,
real(rp), dimension(ka,ia,ja), intent(in)  CPtot,
real(rp), dimension(ka,ia,ja), intent(in)  CVtot,
real(rp), dimension (ka,ia,ja), intent(in)  CCN,
real(rp), dimension (ka,ia,ja,qa), intent(out)  RHOQ_t,
real(rp), dimension (ka,ia,ja), intent(out)  RHOE_t,
real(rp), dimension(ka,ia,ja), intent(out)  CPtot_t,
real(rp), dimension(ka,ia,ja), intent(out)  CVtot_t,
real(rp), dimension(ka,ia,ja), intent(out)  EVAPORATE 
)

Cloud Microphysics.

Definition at line 822 of file scale_atmos_phy_mp_suzuki10.F90.

References scale_const::const_tem00, nbin, nccn, scale_prof::prof_rapend(), and scale_prof::prof_rapstart().

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_calc_tendency().

822  use scale_const, only: &
823  tem00 => const_tem00
824  use scale_atmos_saturation, only: &
825  atmos_saturation_pres2qsat_liq, &
826  atmos_saturation_pres2qsat_ice
827  implicit none
828 
829  integer, intent(in) :: ka, ks, ke
830  integer, intent(in) :: ia, is, ie
831  integer, intent(in) :: ja, js, je
832  integer, intent(in) :: kijmax
833 
834  real(DP), intent(in) :: dt
835  real(RP), intent(in) :: dens (ka,ia,ja)
836  real(RP), intent(in) :: pres (ka,ia,ja)
837  real(RP), intent(in) :: temp (ka,ia,ja)
838  real(RP), intent(in) :: qtrc (ka,ia,ja,qa)
839  real(RP), intent(in) :: qdry (ka,ia,ja)
840  real(RP), intent(in) :: cptot(ka,ia,ja)
841  real(RP), intent(in) :: cvtot(ka,ia,ja)
842  real(RP), intent(in) :: ccn (ka,ia,ja)
843 
844  real(RP), intent(out) :: rhoq_t (ka,ia,ja,qa)
845  real(RP), intent(out) :: rhoe_t (ka,ia,ja)
846  real(RP), intent(out) :: cptot_t(ka,ia,ja)
847  real(RP), intent(out) :: cvtot_t(ka,ia,ja)
848  real(RP), intent(out) :: evaporate(ka,ia,ja) !--- number of evaporated cloud [/m3]
849 
850  real(RP) :: qsat_l(ka,ia,ja)
851  real(RP) :: qsat_i(ka,ia,ja)
852  real(RP) :: ssliq(ka,ia,ja)
853  real(RP) :: ssice(ka,ia,ja)
854 
855  integer :: ijk_index (kijmax,3)
856  integer :: index_cld (kijmax)
857  integer :: index_cold(kijmax)
858  integer :: index_warm(kijmax)
859  integer :: ijkcount, ijkcount_cold, ijkcount_warm
860  integer :: ijk, indirect
861 
862  real(RP) :: dens_ijk(kijmax)
863  real(RP) :: pres_ijk(kijmax)
864  real(RP) :: temp_ijk(kijmax)
865  real(RP) :: qdry_ijk(kijmax)
866  real(RP) :: qvap_ijk(kijmax)
867  real(RP) :: ccn_ijk(kijmax)
868  real(RP) :: cp_ijk(kijmax)
869  real(RP) :: cv_ijk(kijmax)
870  real(RP) :: evaporate_ijk(kijmax)
871  real(RP) :: ghyd_ijk(nbin,nspc,kijmax)
872  real(RP) :: gaer_ijk(max(nccn,1),kijmax)
873  real(RP) :: cldsum
874  integer :: countbin
875  real(RP) :: rhoq_new
876 
877  integer :: step
878  integer :: k, i, j, m, n, iq
879  !---------------------------------------------------------------------------
880 
881  if ( nspc == 1 ) then
882  log_progress(*) 'atmosphere / physics / microphysics / SBM (Liquid water only)'
883  elseif( nspc > 1 ) then
884  log_progress(*) 'atmosphere / physics / microphysics / SBM (Mixed phase)'
885  endif
886 
887  call atmos_saturation_pres2qsat_liq( ka, ks, ke, & ! [IN]
888  ia, is, ie, & ! [IN]
889  ja, js, je, & ! [IN]
890  temp(:,:,:), pres(:,:,:), qdry(:,:,:), & ! [IN]
891  qsat_l(:,:,:) ) ! [OUT]
892 
893  call atmos_saturation_pres2qsat_ice( ka, ks, ke, & ! [IN]
894  ia, is, ie, & ! [IN]
895  ja, js, je, & ! [IN]
896  temp(:,:,:), pres(:,:,:), qdry(:,:,:), & ! [IN]
897  qsat_i(:,:,:) ) ! [OUT]
898 
899  do j = js, je
900  do i = is, ie
901  do k = ks, ke
902  ssliq(k,i,j) = qtrc(k,i,j,i_qv) / qsat_l(k,i,j) - 1.0_rp
903  ssice(k,i,j) = qtrc(k,i,j,i_qv) / qsat_i(k,i,j) - 1.0_rp
904  enddo
905  enddo
906  enddo
907 
908  if ( nspc == 1 ) then
909  ssice(:,:,:) = 0.0_rp
910  endif
911 
912 !--- store initial SDF of aerosol
913 !--- this option is not supported
914 ! if ( ofirst_sdfa ) then
915 ! allocate( marate( nccn ) )
916 ! do j = JS, JE
917 ! do i = IS, IE
918 ! do k = KS, KE
919 ! sum2 = 0.0_RP
920 ! do n = 1, nccn
921 ! marate( n ) = gdga(k,i,j,n)*rexpxactr( n )
922 ! sum2 = sum2 + gdga(k,i,j,n)*rexpxactr( n )
923 ! enddo
924 ! enddo
925 ! enddo
926 ! enddo
927 ! if ( sum2 /= 0.0_RP ) then
928 ! marate( 1:nccn ) = marate( 1:nccn )/sum2
929 ! ofirst_sdfa = .false.
930 ! endif
931 ! endif
932 
933  !--- Arrange array for microphysics
934 
935  call prof_rapstart('MP_ijkconvert', 3)
936 
937  ijk = 0
938  do j = js, je
939  do i = is, ie
940  do k = ks, ke
941  ijk = ijk + 1
942  ijk_index(ijk,1) = i
943  ijk_index(ijk,2) = j
944  ijk_index(ijk,3) = k
945  enddo
946  enddo
947  enddo
948 
949  ijkcount = 0
950  ijkcount_cold = 0
951  ijkcount_warm = 0
952 
953  ijk = 0
954  do j = js, je
955  do i = is, ie
956  do k = ks, ke
957  ijk = ijk + 1
958 
959  ! calc total hydrometeors
960  cldsum = 0.0_rp
961  countbin = i_qv + 1
962  do m = 1, nspc
963  do n = 1, nbin
964  cldsum = cldsum + qtrc(k,i,j,countbin) * dens(k,i,j) / dxmic
965  countbin = countbin + 1
966  enddo
967  enddo
968 
969  if ( cldsum > cldmin &
970  .OR. ssliq(k,i,j) > 0.0_rp &
971  .OR. ssice(k,i,j) > 0.0_rp ) then
972 
973  ijkcount = ijkcount + 1
974 
975  index_cld(ijkcount) = ijk
976 
977  dens_ijk(ijkcount) = dens(k,i,j)
978  pres_ijk(ijkcount) = pres(k,i,j)
979  temp_ijk(ijkcount) = temp(k,i,j)
980  qdry_ijk(ijkcount) = qdry(k,i,j)
981  cp_ijk(ijkcount) = cptot(k,i,j)
982  cv_ijk(ijkcount) = cvtot(k,i,j)
983  ccn_ijk(ijkcount) = ccn(k,i,j)
984  qvap_ijk(ijkcount) = qtrc(k,i,j,i_qv)
985 
986  countbin = i_qv + 1
987  do m = 1, nspc
988  do n = 1, nbin
989  ghyd_ijk(n,m,ijkcount) = qtrc(k,i,j,countbin) * dens(k,i,j) / dxmic
990  countbin = countbin + 1
991  enddo
992  enddo
993 
994  do n = 1, nccn
995  gaer_ijk(n,ijkcount) = qtrc(k,i,j,countbin) * dens(k,i,j) / dxaer
996  countbin = countbin + 1
997  enddo
998 
999  if ( temp(k,i,j) < tem00 .AND. nspc > 1 ) then ! cold
1000  ijkcount_cold = ijkcount_cold + 1
1001  index_cold(ijkcount_cold) = ijkcount
1002  else ! warm
1003  ijkcount_warm = ijkcount_warm + 1
1004  index_warm(ijkcount_warm) = ijkcount
1005  endif
1006 
1007  else
1008 
1009  ! no hudrometeors and undersaturation (no microphysical process occcurs)
1010  do iq = 1, qa
1011  rhoq_t(k,i,j,iq) = 0.0_rp
1012  end do
1013  rhoe_t(k,i,j) = 0.0_rp
1014  cptot_t(k,i,j) = 0.0_rp
1015  cvtot_t(k,i,j) = 0.0_rp
1016  evaporate(k,i,j) = 0.0_rp
1017 
1018  endif
1019 
1020  enddo
1021  enddo
1022  enddo
1023 
1024  call prof_rapend ('MP_ijkconvert', 3)
1025 
1026  ! tentative timername registration
1027  call prof_rapstart('MP_suzuki10', 3)
1028  call prof_rapend ('MP_suzuki10', 3)
1029  call prof_rapstart('_SBM_Nucleat', 3)
1030  call prof_rapend ('_SBM_Nucleat', 3)
1031 ! call PROF_rapstart('_SBM_NucleatA', 3)
1032 ! call PROF_rapend ('_SBM_NucleatA', 3)
1033  call prof_rapstart('_SBM_Liqphase', 3)
1034  call prof_rapend ('_SBM_Liqphase', 3)
1035  call prof_rapstart('_SBM_Icephase', 3)
1036  call prof_rapend ('_SBM_Icephase', 3)
1037  call prof_rapstart('_SBM_Mixphase', 3)
1038  call prof_rapend ('_SBM_Mixphase', 3)
1039  call prof_rapstart('_SBM_AdvLiq', 3)
1040  call prof_rapend ('_SBM_AdvLiq', 3)
1041  call prof_rapstart('_SBM_AdvIce', 3)
1042  call prof_rapend ('_SBM_AdvIce', 3)
1043  call prof_rapstart('_SBM_AdvMix', 3)
1044  call prof_rapend ('_SBM_AdvMix', 3)
1045 ! call PROF_rapstart('_SBM_FAero', 3)
1046 ! call PROF_rapend ('_SBM_FAero', 3)
1047  call prof_rapstart('_SBM_Freezing', 3)
1048  call prof_rapend ('_SBM_Freezing', 3)
1049  call prof_rapstart('_SBM_IceNucleat', 3)
1050  call prof_rapend ('_SBM_IceNucleat', 3)
1051  call prof_rapstart('_SBM_Melting', 3)
1052  call prof_rapend ('_SBM_Melting', 3)
1053  call prof_rapstart('_SBM_CollCoag', 3)
1054  call prof_rapend ('_SBM_CollCoag', 3)
1055 ! call PROF_rapstart('_SBM_CollCoagR', 3)
1056 ! call PROF_rapend ('_SBM_CollCoagR', 3)
1057 
1058  if ( ijkcount > 0 ) then
1059 
1060  call prof_rapstart('MP_suzuki10', 3)
1061 
1062  call mp_suzuki10( ka, ia, ja, & ! [IN]
1063  ijkcount, & ! [IN]
1064  ijkcount_cold, & ! [IN]
1065  ijkcount_warm, & ! [IN]
1066  index_cold( 1:ijkcount), & ! [IN]
1067  index_warm( 1:ijkcount), & ! [IN]
1068  dens_ijk( 1:ijkcount), & ! [IN]
1069  pres_ijk( 1:ijkcount), & ! [IN]
1070  qdry_ijk( 1:ijkcount), & ! [IN]
1071  ccn_ijk( 1:ijkcount), & ! [IN]
1072  temp_ijk( 1:ijkcount), & ! [INOUT]
1073  qvap_ijk( 1:ijkcount), & ! [INOUT]
1074  ghyd_ijk(:,:,1:ijkcount), & ! [INOUT]
1075  gaer_ijk(:, 1:ijkcount), & ! [INOUT]
1076  cp_ijk( 1:ijkcount), & ! [INOUT]
1077  cv_ijk( 1:ijkcount), & ! [INOUT]
1078  evaporate_ijk(1:ijkcount), & ! [OUT]
1079  dt ) ! [IN]
1080 
1081  call prof_rapend ('MP_suzuki10', 3)
1082 
1083 ! if ( flg_sf_aero ) then
1084 ! do j = JS-2, JE+2
1085 ! do i = IS-2, IE+1
1086 ! VELX(i,j) = MOMX(K10_1,i,j) / ( DENS(K10_1,i+1,j)+DENS(K10_1,i,j) ) * R10M1 &
1087 ! + MOMX(K10_2,i,j) / ( DENS(K10_2,i+1,j)+DENS(K10_2,i,j) ) * R10M2
1088 ! enddo
1089 ! enddo
1090 !
1091 ! do j = JS-2, JE+1
1092 ! do i = IS-2, IE+2
1093 ! VELY(i,j) = MOMY(K10_1,i,j) / ( DENS(K10_1,i,j+1)+DENS(K10_1,i,j) ) * R10M1 &
1094 ! + MOMY(K10_2,i,j) / ( DENS(K10_2,i,j+1)+DENS(K10_2,i,j) ) * R10M2
1095 ! enddo
1096 ! enddo
1097 ! endif
1098 !
1099 ! !--- SURFACE FLUX by Monahan et al. (1986)
1100 ! if ( flg_sf_aero .AND. nccn /= 0 ) then
1101 ! do j = JS, JE
1102 ! do i = IS, IE
1103 ! ijk = ( j - JS ) * KMAX * IMAX &
1104 ! + ( i - IS ) * KMAX &
1105 ! + ( KS - KS ) &
1106 ! + 1
1107 ! Uabs = sqrt( ( ( VELX(i,j) + VELX(i-1,j ) ) * 0.50_RP )**2 &
1108 ! + ( ( VELY(i,j) + VELY(i ,j-1) ) * 0.50_RP )**2 )
1109 ! do n = 1, nccn
1110 ! if ( rada( n ) <= 2.0E-5_RP .AND. rada( n ) >= 3.0E-7_RP ) then
1111 ! bparam = ( 0.38_RP - log( rada( n ) ) )/0.65_RP
1112 ! SFLX_AERO(i,j,n) = 1.373_RP * Uabs**( 3.41_RP ) * rada( n )**( -3.0_RP ) &
1113 ! * ( 1.0_RP + 0.057_RP * rada( n )**( 1.05_RP ) ) &
1114 ! * 10.0_RP**( 1.19_RP * exp( -bparam*bparam ) )
1115 ! ! convert from [#/m^2/um/s] -> [kg/m^3/unit log (m)]
1116 ! SFLX_AERO(i,j,n) = SFLX_AERO(i,j,n) / DENS(KS,i,j) &
1117 ! / CDZ(KS) * rada( n ) / 3.0_RP * dt * expxactr( n )
1118 ! Gaer_ijk(n,ijk) = Gaer_ijk(n,ijk) + SFLX_AERO(i,j,n)/dxaer
1119 ! endif
1120 ! enddo
1121 ! enddo
1122 ! enddo
1123 ! endif
1124 
1125  call prof_rapstart('MP_ijkconvert', 3)
1126 
1127  !---- return original array
1128  do ijk = 1, ijkcount
1129  indirect = index_cld(ijk)
1130  i = ijk_index(indirect,1)
1131  j = ijk_index(indirect,2)
1132  k = ijk_index(indirect,3)
1133 
1134  rhoe_t(k,i,j) = ( temp_ijk(ijk) * cv_ijk(ijk) - temp(k,i,j) * cvtot(k,i,j) ) * dens(k,i,j) / dt
1135  cptot_t(k,i,j) = ( cp_ijk(ijk) - cptot(k,i,j) ) / dt
1136  cvtot_t(k,i,j) = ( cv_ijk(ijk) - cvtot(k,i,j) ) / dt
1137  evaporate(k,i,j) = evaporate_ijk(ijk) / dt ! [#/m3/s]
1138 
1139  rhoq_t(k,i,j,i_qv) = ( qvap_ijk(ijk) - qtrc(k,i,j,i_qv) ) * dens(k,i,j) / dt
1140 
1141  countbin = i_qv + 1
1142  do m = 1, nspc
1143  do n = 1, nbin
1144  rhoq_new = ghyd_ijk(n,m,ijk) * dxmic
1145  rhoq_t(k,i,j,countbin) = ( rhoq_new - qtrc(k,i,j,countbin)*dens(k,i,j) ) / dt
1146  countbin = countbin + 1
1147  enddo
1148  enddo
1149 
1150  do n = 1, nccn
1151  rhoq_new = gaer_ijk(n,ijk) * dxaer
1152  rhoq_t(k,i,j,countbin) = ( rhoq_new - qtrc(k,i,j,countbin)*dens(k,i,j) ) / dt
1153  countbin = countbin + 1
1154  enddo
1155  enddo
1156 
1157 
1158 ! if ( nccn /= 0 ) then
1159 ! AMR(:,:,:) = 0.0_RP
1160 ! do j = JS, JE
1161 ! do i = IS, IE
1162 ! do k = KS, KE
1163 ! do n = 1, nccn
1164 ! AMR(k,i,j) = AMR(k,i,j) + QTRC(k,i,j,QQE-1+n)
1165 ! enddo
1166 ! enddo
1167 ! enddo
1168 ! enddo
1169 ! endif
1170 
1171  call prof_rapend ('MP_ijkconvert', 3)
1172 
1173  endif
1174 
1175  return
module atmosphere / saturation
integer, public ia
of whole cells: x, local, with HALO
real(rp), parameter, public const_tem00
temperature reference (0C) [K]
Definition: scale_const.F90:90
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 ke
end point of inner domain: z, local
integer, public je
end point of inner domain: y, local
integer, public ks
start point of inner domain: z, local
module CONSTANT
Definition: scale_const.F90:11
integer, public js
start point of inner domain: y, local
integer, public ka
of whole cells: z, local, with HALO
integer, public kijmax
of computational cells: z*x*y
Here is the call graph for this function:
Here is the caller graph for this function:

◆ atmos_phy_mp_suzuki10_terminal_velocity()

subroutine, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_terminal_velocity ( integer, intent(in)  KA,
real(rp), dimension(ka,qa-1), intent(out)  vterm_o 
)

get terminal velocity

Definition at line 1184 of file scale_atmos_phy_mp_suzuki10.F90.

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_calc_tendency().

1184  implicit none
1185 
1186  integer, intent(in) :: ka
1187 
1188  real(RP), intent(out) :: vterm_o(ka,qa-1)
1189 
1190  integer :: iq
1191  !---------------------------------------------------------------------------
1192 
1193  do iq = 1, qa-1
1194  vterm_o(:,iq) = vterm(iq)
1195  end do
1196 
1197  return
integer, public ka
of whole cells: z, local, with HALO
Here is the caller graph for this function:

◆ atmos_phy_mp_suzuki10_cloud_fraction()

subroutine, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_cloud_fraction ( integer, intent(in)  KA,
integer, intent(in)  KS,
integer, intent(in)  KE,
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 (ka,ia,ja,nspc*nbin), intent(in)  QTRC0,
real(rp), intent(in)  mask_criterion,
real(rp), dimension(ka,ia,ja), intent(out)  cldfrac 
)

Calculate Cloud Fraction.

Definition at line 1209 of file scale_atmos_phy_mp_suzuki10.F90.

References nbin.

Referenced by mod_atmos_phy_mp_vars::atmos_phy_mp_vars_get_diagnostic().

1209  implicit none
1210 
1211  integer, intent(in) :: ka, ks, ke
1212  integer, intent(in) :: ia, is, ie
1213  integer, intent(in) :: ja, js, je
1214 
1215  real(RP), intent(in) :: qtrc0 (ka,ia,ja,nspc*nbin)
1216  real(RP), intent(in) :: mask_criterion
1217  real(RP), intent(out) :: cldfrac(ka,ia,ja)
1218 
1219  real(RP) :: qhydro
1220  integer :: k, i, j, iq, ihydro
1221  !---------------------------------------------------------------------------
1222 
1223  if( nspc > 1 ) then
1224  do j = js, je
1225  do i = is, ie
1226  do k = ks, ke
1227  qhydro = 0.0_rp
1228  do ihydro = 1, nspc
1229  do iq = nbin*(ihydro-1)+1, nbin*ihydro
1230  qhydro = qhydro + qtrc0(k,i,j,iq)
1231  enddo
1232  enddo
1233  cldfrac(k,i,j) = 0.5_rp + sign(0.5_rp,qhydro-mask_criterion)
1234  enddo
1235  enddo
1236  enddo
1237  elseif( nspc == 1 ) then
1238  do j = js, je
1239  do i = is, ie
1240  do k = ks, ke
1241  qhydro = 0.0_rp
1242  do ihydro = 1, i_mp_qc
1243  do iq = nbin*(ihydro-1)+1, nbin*ihydro
1244  qhydro = qhydro + qtrc0(k,i,j,iq)
1245  enddo
1246  enddo
1247  cldfrac(k,i,j) = 0.5_rp + sign(0.5_rp,qhydro-mask_criterion)
1248  enddo
1249  enddo
1250  enddo
1251  endif
1252 
1253  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 ke
end point of inner domain: z, local
integer, public je
end point of inner domain: y, local
integer, public ks
start point of inner domain: z, local
integer, public js
start point of inner domain: y, local
integer, public ka
of whole cells: z, local, with HALO
Here is the caller graph for this function:

◆ atmos_phy_mp_suzuki10_effective_radius()

subroutine, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_effective_radius ( integer, intent(in)  KA,
integer, intent(in)  KS,
integer, intent(in)  KE,
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(ka,ia,ja), intent(in)  DENS0,
real(rp), dimension(ka,ia,ja), intent(in)  TEMP0,
real(rp), dimension(ka,ia,ja,nspc*nbin), intent(in)  QTRC0,
real(rp), dimension (ka,ia,ja,n_hyd), intent(out)  Re 
)

Calculate Effective Radius.

Definition at line 1266 of file scale_atmos_phy_mp_suzuki10.F90.

References scale_const::const_eps, scale_atmos_hydrometeor::i_hc, scale_atmos_hydrometeor::i_hg, scale_atmos_hydrometeor::i_hh, scale_atmos_hydrometeor::i_hi, scale_atmos_hydrometeor::i_hr, scale_atmos_hydrometeor::i_hs, scale_atmos_hydrometeor::i_qv, scale_atmos_hydrometeor::n_hyd, and nbin.

Referenced by mod_atmos_phy_mp_vars::atmos_phy_mp_vars_get_diagnostic().

1266  use scale_const, only: &
1267  eps => const_eps
1268  use scale_atmos_hydrometeor, only: &
1269  n_hyd, &
1270  i_qv, &
1271  i_hc, &
1272  i_hr, &
1273  i_hi, &
1274  i_hs, &
1275  i_hg, &
1276  i_hh
1277  implicit none
1278 
1279  integer, intent(in) :: ka, ks, ke
1280  integer, intent(in) :: ia, is, ie
1281  integer, intent(in) :: ja, js, je
1282 
1283  real(RP), intent(in) :: dens0(ka,ia,ja) ! density [kg/m3]
1284  real(RP), intent(in) :: temp0(ka,ia,ja) ! temperature [K]
1285  real(RP), intent(in) :: qtrc0(ka,ia,ja,nspc*nbin) ! tracer mass concentration [kg/kg]
1286  real(RP), intent(out) :: re (ka,ia,ja,n_hyd) ! effective radius [cm]
1287 
1288  real(RP), parameter :: um2cm = 100.0_rp
1289 
1290  real(RP) :: sum0(nspc), sum2, sum3, re_tmp(nspc)
1291  integer :: i, j, k, iq, ihydro
1292  !---------------------------------------------------------------------------
1293 
1294  do k = ks, ke
1295  do j = js, je
1296  do i = is, ie
1297  re(k,i,j,:) = 0.0_rp
1298 
1299  ! HC
1300  sum3 = 0.0_rp
1301  sum2 = 0.0_rp
1302  ihydro = i_mp_qc
1303  do iq = 1, nbnd
1304  sum3 = sum3 &
1305  + ( ( qtrc0(k,i,j,iq) * dens0(k,i,j) ) & !--- [kg/kg] -> [kg/m3]
1306  * rexpxctr( iq-nbin*(ihydro-1) ) & !--- mass -> number
1307  * radc( iq-nbin*(ihydro-1) )**3.0_rp )
1308  sum2 = sum2 &
1309  + ( ( qtrc0(k,i,j,iq) * dens0(k,i,j) ) & !--- [kg/kg] -> [kg/m3]
1310  * rexpxctr( iq-nbin*(ihydro-1) ) & !--- mass -> number
1311  * radc( iq-nbin*(ihydro-1) )**2.0_rp )
1312  enddo
1313  sum3 = max( sum3, 0.0_rp )
1314  sum2 = max( sum2, 0.0_rp )
1315  if ( sum2 /= 0.0_rp ) then
1316  re(k,i,j,i_hc) = sum3 / sum2 * um2cm
1317  else
1318  re(k,i,j,i_hc) = 0.0_rp
1319  endif
1320 
1321  ! HR
1322  sum3 = 0.0_rp
1323  sum2 = 0.0_rp
1324  ihydro = i_mp_qc
1325  do iq = nbnd+1, nbin
1326  sum3 = sum3 &
1327  + ( ( qtrc0(k,i,j,iq) * dens0(k,i,j) ) & !--- [kg/kg] -> [kg/m3]
1328  * rexpxctr( iq-nbin*(ihydro-1) ) & !--- mass -> number
1329  * radc( iq-nbin*(ihydro-1) )**3.0_rp )
1330  sum2 = sum2 &
1331  + ( ( qtrc0(k,i,j,iq) * dens0(k,i,j) ) & !--- [kg/kg] -> [kg/m3]
1332  * rexpxctr( iq-nbin*(ihydro-1) ) & !--- mass -> number
1333  * radc( iq-nbin*(ihydro-1) )**2.0_rp )
1334  enddo
1335  sum3 = max( sum3, 0.0_rp )
1336  sum2 = max( sum2, 0.0_rp )
1337  if ( sum2 /= 0.0_rp ) then
1338  re(k,i,j,i_hr) = sum3 / sum2 * um2cm
1339  else
1340  re(k,i,j,i_hr) = 0.0_rp
1341  endif
1342 
1343  enddo
1344  enddo
1345  enddo
1346 
1347  ! other hydrometeors
1348  if ( nspc > 1 ) then
1349  do k = ks, ke
1350  do j = js, je
1351  do i = is, ie
1352  do ihydro = 2, nspc
1353  sum0(ihydro) = 0.0_rp
1354  sum2 = 0.0_rp
1355  sum3 = 0.0_rp
1356  do iq = nbin*(ihydro-1)+1, nbin*ihydro
1357  sum0(ihydro) = sum0(ihydro) &
1358  + ( qtrc0(k,i,j,iq) * dens0(k,i,j) ) !--- [kg/kg] -> [kg/m3]
1359  sum3 = sum3 &
1360  + ( ( qtrc0(k,i,j,iq) * dens0(k,i,j) ) & !--- [kg/kg] -> [kg/m3]
1361  * rexpxctr( iq-nbin*(ihydro-1) ) & !--- mass -> number
1362  * radc( iq-nbin*(ihydro-1) )**3.0_rp )
1363  sum2 = sum2 &
1364  + ( ( qtrc0(k,i,j,iq) * dens0(k,i,j) ) & !--- [kg/kg] -> [kg/m3]
1365  * rexpxctr( iq-nbin*(ihydro-1) ) & !--- mass -> number
1366  * radc( iq-nbin*(ihydro-1) )**2.0_rp )
1367  enddo
1368  sum3 = max( sum3, 0.0_rp )
1369  sum2 = max( sum2, 0.0_rp )
1370  if ( sum2 == 0.0_rp ) then
1371  re_tmp(ihydro) = 0.0_rp
1372  else
1373  re_tmp(ihydro) = sum3 / sum2 * um2cm
1374  end if
1375  end do
1376 
1377  re(k,i,j,i_hi) = ( re_tmp(i_mp_qcl) * sum0(i_mp_qcl) &
1378  + re_tmp(i_mp_qp ) * sum0(i_mp_qp ) &
1379  + re_tmp(i_mp_qd ) * sum0(i_mp_qd ) ) &
1380  / ( sum0(i_mp_qcl) + sum0(i_mp_qp) + sum0(i_mp_qd) + eps )
1381  re(k,i,j,i_hs) = re_tmp(i_mp_qs)
1382  re(k,i,j,i_hg) = re_tmp(i_mp_qg)
1383  re(k,i,j,i_hh) = re_tmp(i_mp_qh)
1384 
1385  enddo
1386  enddo
1387  enddo
1388 
1389  end if
1390 
1391  return
integer, public ia
of whole cells: x, local, with HALO
integer, parameter, public i_hs
snow
integer, parameter, public i_hr
liquid water rain
integer, parameter, public i_hi
ice water cloud
integer, public ja
of whole cells: y, local, with HALO
integer, parameter, public i_hh
hail
integer, public is
start point of inner domain: x, local
integer, public ie
end point of inner domain: x, local
module atmosphere / hydrometeor
integer, public ke
end point of inner domain: z, local
integer, public je
end point of inner domain: y, local
integer, public ks
start point of inner domain: z, local
module CONSTANT
Definition: scale_const.F90:11
integer, parameter, public i_hc
liquid water cloud
integer, public js
start point of inner domain: y, local
real(rp), public const_eps
small number
Definition: scale_const.F90:33
integer, public ka
of whole cells: z, local, with HALO
integer, parameter, public n_hyd
integer, parameter, public i_hg
graupel
Here is the caller graph for this function:

◆ atmos_phy_mp_suzuki10_qtrc2qhyd()

subroutine, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_qtrc2qhyd ( integer, intent(in)  KA,
integer, intent(in)  KS,
integer, intent(in)  KE,
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(ka,ia,ja,nbin*nspc), intent(in)  QTRC0,
real(rp), dimension (ka,ia,ja,n_hyd), intent(out)  Qe 
)

Calculate mass ratio of each category.

Definition at line 1402 of file scale_atmos_phy_mp_suzuki10.F90.

References scale_atmos_hydrometeor::i_hc, scale_atmos_hydrometeor::i_hg, scale_atmos_hydrometeor::i_hh, scale_atmos_hydrometeor::i_hi, scale_atmos_hydrometeor::i_hr, scale_atmos_hydrometeor::i_hs, scale_atmos_hydrometeor::n_hyd, and nbin.

Referenced by mod_atmos_phy_mp_vars::atmos_phy_mp_vars_get_diagnostic().

1402  use scale_atmos_hydrometeor, only: &
1403  n_hyd, &
1404  i_hc, &
1405  i_hr, &
1406  i_hi, &
1407  i_hs, &
1408  i_hg, &
1409  i_hh
1410  implicit none
1411 
1412  integer, intent(in) :: ka, ks, ke
1413  integer, intent(in) :: ia, is, ie
1414  integer, intent(in) :: ja, js, je
1415  real(RP), intent(in) :: qtrc0(ka,ia,ja,nbin*nspc) ! tracer mass concentration [kg/kg]
1416  real(RP), intent(out) :: qe (ka,ia,ja,n_hyd) ! mixing ratio of each cateory [kg/kg]
1417 
1418  integer :: ihydro, ibin, iq, icateg
1419  integer :: k, i, j
1420  !---------------------------------------------------------------------------
1421 
1422 !OCL XFILL
1423  qe(:,:,:,:) = 0.0_rp
1424 
1425  do ihydro = 1, nspc
1426  do ibin = 1, nbin
1427  iq = nbin*(ihydro-1) + ibin
1428 
1429  if ( iq > 0 .AND. iq <= nbin*(i_mp_qc -1) ) then ! liquid
1430  if ( iq > 0 .AND. iq <= nbnd ) then ! cloud
1431  icateg = i_hc
1432  elseif( iq > nbnd .AND. iq <= nbin ) then ! rain
1433  icateg = i_hr
1434  endif
1435  elseif( iq > nbin*(i_mp_qc -1) .AND. iq <= nbin*(i_mp_qcl-1) ) then ! ice (column)
1436  icateg = i_hi
1437  elseif( iq > nbin*(i_mp_qcl-1) .AND. iq <= nbin*(i_mp_qp -1) ) then ! ice (plate)
1438  icateg = i_hi
1439  elseif( iq > nbin*(i_mp_qp -1) .AND. iq <= nbin*(i_mp_qs -1) ) then ! ice (dendrite)
1440  icateg = i_hi
1441  elseif( iq > nbin*(i_mp_qs -1) .AND. iq <= nbin*(i_mp_qg -1) ) then ! snow
1442  icateg = i_hs
1443  elseif( iq > nbin*(i_mp_qg -1) .AND. iq <= nbin*(i_mp_qh -1) ) then ! graupel
1444  icateg = i_hg
1445  elseif( iq > nbin*(i_mp_qh -1) .AND. iq <= nbin*nspc ) then ! hail
1446  icateg = i_hh
1447  endif
1448 
1449  do j = js, je
1450  do i = is, ie
1451  do k = ks, ke
1452  qe(k,i,j,icateg) = qe(k,i,j,icateg) + qtrc0(k,i,j,iq)
1453  enddo
1454  enddo
1455  enddo
1456  enddo
1457  enddo
1458 
1459  return
integer, public ia
of whole cells: x, local, with HALO
integer, parameter, public i_hs
snow
integer, parameter, public i_hr
liquid water rain
integer, parameter, public i_hi
ice water cloud
integer, public ja
of whole cells: y, local, with HALO
integer, parameter, public i_hh
hail
integer, public is
start point of inner domain: x, local
integer, public ie
end point of inner domain: x, local
module atmosphere / hydrometeor
integer, public ke
end point of inner domain: z, local
integer, public je
end point of inner domain: y, local
integer, public ks
start point of inner domain: z, local
integer, parameter, public i_hc
liquid water cloud
integer, public js
start point of inner domain: y, local
integer, public ka
of whole cells: z, local, with HALO
integer, parameter, public n_hyd
integer, parameter, public i_hg
graupel
Here is the caller graph for this function:

◆ atmos_phy_mp_suzuki10_qtrc2nhyd()

subroutine, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_qtrc2nhyd ( integer, intent(in)  KA,
integer, intent(in)  KS,
integer, intent(in)  KE,
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 (ka,ia,ja), intent(in)  DENS,
real(rp), dimension(ka,ia,ja,nbin*nspc), intent(in)  QTRC0,
real(rp), dimension (ka,ia,ja,n_hyd), intent(out)  Ne 
)

Calculate number concentration of each category.

Definition at line 1470 of file scale_atmos_phy_mp_suzuki10.F90.

References scale_atmos_hydrometeor::i_hc, scale_atmos_hydrometeor::i_hg, scale_atmos_hydrometeor::i_hh, scale_atmos_hydrometeor::i_hi, scale_atmos_hydrometeor::i_hr, scale_atmos_hydrometeor::i_hs, scale_atmos_hydrometeor::n_hyd, and nbin.

Referenced by mod_atmos_phy_mp_vars::atmos_phy_mp_vars_get_diagnostic().

1470  use scale_atmos_hydrometeor, only: &
1471  n_hyd, &
1472  i_hc, &
1473  i_hr, &
1474  i_hi, &
1475  i_hs, &
1476  i_hg, &
1477  i_hh
1478  implicit none
1479 
1480  integer, intent(in) :: ka, ks, ke
1481  integer, intent(in) :: ia, is, ie
1482  integer, intent(in) :: ja, js, je
1483  real(RP), intent(in) :: dens (ka,ia,ja) ! density [kg/m3]
1484  real(RP), intent(in) :: qtrc0(ka,ia,ja,nbin*nspc) ! tracer mass concentration [kg/kg]
1485  real(RP), intent(out) :: ne (ka,ia,ja,n_hyd) ! number concentration of each cateory [1/m3]
1486 
1487  integer :: ihydro, ibin, iq, icateg
1488  integer :: k, i, j
1489  !---------------------------------------------------------------------------
1490 
1491 !OCL XFILL
1492  ne(:,:,:,:) = 0.0_rp
1493 
1494  do ihydro = 1, nspc
1495  do ibin = 1, nbin
1496  iq = nbin*(ihydro-1) + ibin
1497 
1498  if ( iq > 0 .AND. iq <= nbin*(i_mp_qc -1) ) then ! liquid
1499  if ( iq > 0 .AND. iq <= nbnd ) then ! cloud
1500  icateg = i_hc
1501  elseif( iq > nbnd .AND. iq <= nbin ) then ! rain
1502  icateg = i_hr
1503  endif
1504  elseif( iq > nbin*(i_mp_qc -1) .AND. iq <= nbin*(i_mp_qcl-1) ) then ! ice (column)
1505  icateg = i_hi
1506  elseif( iq > nbin*(i_mp_qcl-1) .AND. iq <= nbin*(i_mp_qp -1) ) then ! ice (plate)
1507  icateg = i_hi
1508  elseif( iq > nbin*(i_mp_qp -1) .AND. iq <= nbin*(i_mp_qs -1) ) then ! ice (dendrite)
1509  icateg = i_hi
1510  elseif( iq > nbin*(i_mp_qs -1) .AND. iq <= nbin*(i_mp_qg -1) ) then ! snow
1511  icateg = i_hs
1512  elseif( iq > nbin*(i_mp_qg -1) .AND. iq <= nbin*(i_mp_qh -1) ) then ! graupel
1513  icateg = i_hg
1514  elseif( iq > nbin*(i_mp_qh -1) .AND. iq <= nbin*nspc ) then ! hail
1515  icateg = i_hh
1516  endif
1517 
1518  do j = js, je
1519  do i = is, ie
1520  do k = ks, ke
1521  ne(k,i,j,icateg) = ne(k,i,j,icateg) + dens(k,i,j) * qtrc0(k,i,j,iq) * rexpxctr(ibin)
1522  enddo
1523  enddo
1524  enddo
1525  enddo
1526  enddo
1527 
1528  return
integer, public ia
of whole cells: x, local, with HALO
integer, parameter, public i_hs
snow
integer, parameter, public i_hr
liquid water rain
integer, parameter, public i_hi
ice water cloud
integer, public ja
of whole cells: y, local, with HALO
integer, parameter, public i_hh
hail
integer, public is
start point of inner domain: x, local
integer, public ie
end point of inner domain: x, local
module atmosphere / hydrometeor
integer, public ke
end point of inner domain: z, local
integer, public je
end point of inner domain: y, local
integer, public ks
start point of inner domain: z, local
integer, parameter, public i_hc
liquid water cloud
integer, public js
start point of inner domain: y, local
integer, public ka
of whole cells: z, local, with HALO
integer, parameter, public n_hyd
integer, parameter, public i_hg
graupel
Here is the caller graph for this function:

◆ atmos_phy_mp_suzuki10_qhyd2qtrc()

subroutine, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_qhyd2qtrc ( integer, intent(in)  KA,
integer, intent(in)  KS,
integer, intent(in)  KE,
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(ka,ia,ja,n_hyd), intent(in)  Qe,
real(rp), dimension(ka,ia,ja,qa-1), intent(out)  QTRC,
real(rp), dimension(ka,ia,ja,n_hyd), intent(in), optional  QNUM 
)

get mass ratio of each category

Definition at line 1538 of file scale_atmos_phy_mp_suzuki10.F90.

References scale_const::const_dwatr, scale_const::const_emelt, scale_const::const_eps, scale_const::const_pi, scale_const::const_psat0, scale_const::const_rvap, scale_const::const_tem00, scale_const::const_tmelt, scale_atmos_hydrometeor::cp_ice, scale_atmos_hydrometeor::cp_vapor, scale_atmos_hydrometeor::cp_water, scale_atmos_hydrometeor::cv_ice, scale_atmos_hydrometeor::cv_vapor, scale_atmos_hydrometeor::cv_water, scale_atmos_hydrometeor::i_hc, scale_atmos_hydrometeor::i_hg, scale_atmos_hydrometeor::i_hh, scale_atmos_hydrometeor::i_hi, scale_atmos_hydrometeor::i_hr, scale_atmos_hydrometeor::i_hs, scale_atmos_hydrometeor::n_hyd, nbin, nccn, scale_prc::prc_abort(), scale_prof::prof_rapend(), scale_prof::prof_rapstart(), scale_random::random_uniform(), and scale_specfunc::sf_gamma().

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_qhyd2qtrc().

1538  use scale_const, only: &
1539  pi => const_pi, &
1540  eps => const_eps
1541  use scale_atmos_hydrometeor, only: &
1542  n_hyd, &
1543  i_hc, &
1544  i_hr, &
1545  i_hi, &
1546  i_hs, &
1547  i_hg, &
1548  i_hh
1549  use scale_specfunc, only: &
1550  sf_gamma
1551  implicit none
1552  integer, intent(in) :: ka, ks, ke
1553  integer, intent(in) :: ia, is, ie
1554  integer, intent(in) :: ja, js, je
1555 
1556  real(RP), intent(in) :: qe(ka,ia,ja,n_hyd) ! mass ratio of each cateory [kg/kg]
1557 
1558  real(RP), intent(out) :: qtrc(ka,ia,ja,qa-1)
1559 
1560  real(RP), intent(in), optional :: qnum(ka,ia,ja,n_hyd) ! number concentratio
1561 
1562  real(RP) :: coef0, coef1, coef2
1563  real(RP) :: dummy(nbin)
1564  real(RP) :: tmp_hyd, num_hyd, lambda_hyd
1565 
1566  integer :: k, i, j, iq
1567 
1568  if ( present(qnum) ) then
1569  log_warn("ATMOS_PHY_MP_suzuki10_qhyd2qtrc",*) 'At this moment, number concentratio is ignored'
1570  end if
1571 
1572  !--- define coefficients
1573  coef0 = 4.0_rp/3.0_rp*pi
1574  coef1 = 4.0_rp/3.0_rp*sqrt(pi/2.0_rp)
1575 
1576  if( nspc == 1 ) then !--- put all hydrometeors to liquid (warm bin)
1577 
1578  do j = js, je
1579  do i = is, ie
1580  do k = ks, ke
1581 
1582  tmp_hyd = 0.0_rp
1583  do iq = 1, nbin
1584  dummy(iq) = coef1 / sigma_sdf(1) * rho_sdf(1) * radc( iq )**3 &
1585  * exp( &
1586  - ( log( radc(iq) )-log( r0_sdf(1) ) )**2*0.5_rp &
1587  / sigma_sdf(1) / sigma_sdf(1) &
1588  )
1589  tmp_hyd = tmp_hyd + dummy(iq)
1590  enddo
1591 
1592  coef2 = ( qe(k,i,j,i_hc) + qe(k,i,j,i_hr) &
1593  + qe(k,i,j,i_hi) + qe(k,i,j,i_hs) + qe(k,i,j,i_hg) ) &
1594  / ( tmp_hyd + ( 0.50_rp - sign(0.50_rp,tmp_hyd-eps) ) )
1595 
1596  do iq = 1, nbin
1597  qtrc(k+2,i,j,(il-1)*nbin+iq) = coef2 * dummy(iq)
1598  enddo
1599 
1600  enddo
1601  enddo
1602  enddo
1603 
1604  elseif( nspc > 1 ) then !--- put each hydrometeor to each category (ice bin)
1605 
1606  do j = js, je
1607  do i = is, ie
1608  do k = ks, ke
1609 
1610  !--- Rain and Cloud put into liquid bin (log-normal)
1611  tmp_hyd = 0.0_rp
1612  do iq = 1, nbin
1613  dummy(iq) = coef1 / sigma_sdf(1) * rho_sdf(1) * radc( iq )**3 &
1614  * exp( &
1615  - ( log( radc(iq) )-log( r0_sdf(1) ) )**2*0.5_rp &
1616  / sigma_sdf(1) / sigma_sdf(1) &
1617  )
1618  tmp_hyd = tmp_hyd + dummy(iq)
1619  enddo
1620 
1621  coef2 = ( qe(k,i,j,i_hc) + qe(k,i,j,i_hr) ) &
1622  / ( tmp_hyd + ( 0.50_rp - sign(0.50_rp,tmp_hyd-eps) ) )
1623 
1624  do iq = 1, nbin
1625  qtrc(k,i,j,(il-1)*nbin+iq) = coef2 * dummy(iq)
1626  enddo
1627 
1628  !--- Ice put into plate bin (log-normal)
1629  tmp_hyd = 0.0_rp
1630  do iq = 1, nbin
1631  dummy(iq) = coef1 / sigma_sdf(2) * rho_sdf(2) * radc( iq )**3 &
1632  * exp( &
1633  - ( log( radc(iq) )-log( r0_sdf(2) ) )**2*0.5_rp &
1634  / sigma_sdf(2) / sigma_sdf(2) &
1635  )
1636  tmp_hyd = tmp_hyd + dummy(iq)
1637  enddo
1638 
1639  coef2 = ( qe(k,i,j,i_hi) ) &
1640  / ( tmp_hyd + ( 0.50_rp - sign(0.50_rp,tmp_hyd-eps) ) )
1641 
1642  do iq = 1, nbin
1643  qtrc(k,i,j,(ip-1)*nbin+iq) = coef2 * dummy(iq)
1644  enddo
1645 
1646  !--- Snow put into snow bin (gamma)
1647  num_hyd = coef0 * n0_sdf(3) * rho_sdf(3)
1648  lambda_hyd = ( pi * rho_sdf(3) / 6.0_rp *n0_sdf(3) * sf_gamma(4.0_rp) &
1649  / ( qe(k,i,j,i_hs) &
1650  + (0.50_rp-sign(0.50_rp,qe(k,i,j,i_hs)-eps)) &
1651  ) )**(0.25_rp)
1652 
1653  tmp_hyd = 0.0_rp
1654  do iq = 1, nbin
1655  dummy(iq) = num_hyd * radc( iq )**3 &
1656  * exp( -lambda_hyd * 0.5_rp * radc( iq ) )
1657  tmp_hyd = tmp_hyd + dummy(iq)
1658  enddo
1659 
1660  coef2 = ( qe(k,i,j,i_hs) ) &
1661  / ( tmp_hyd + ( 0.50_rp - sign(0.50_rp,tmp_hyd-eps) ) )
1662 
1663  do iq = 1, nbin
1664  qtrc(k,i,j,(iss-1)*nbin+iq) = coef2 * dummy(iq)
1665  enddo
1666 
1667  !--- Graupel put into Graupel bin (gamma)
1668  num_hyd = coef0 * n0_sdf(4) * rho_sdf(4)
1669  lambda_hyd = ( pi * rho_sdf(4) / 6.0_rp *n0_sdf(4) * sf_gamma(4.0_rp) &
1670  / ( qe(k,i,j,i_hg) &
1671  + (0.50_rp-sign(0.50_rp,qe(k,i,j,i_hg)-eps)) &
1672  ) )**(0.25_rp)
1673 
1674  tmp_hyd = 0.0_rp
1675  do iq = 1, nbin
1676  dummy(iq) = num_hyd * radc( iq )**3 &
1677  * exp( -lambda_hyd * 0.5_rp * radc( iq ) )
1678  tmp_hyd = tmp_hyd + dummy(iq)
1679  enddo
1680 
1681  coef2 = ( qe(k,i,j,i_hg) ) &
1682  / ( tmp_hyd + ( 0.50_rp - sign(0.50_rp,tmp_hyd-eps) ) )
1683 
1684  do iq = 1, nbin
1685  qtrc(k,i,j,(ig-1)*nbin+iq) = coef2 * dummy(iq)
1686  enddo
1687 
1688  !--- Hail put into Hail bin (gamma)
1689  num_hyd = coef0 * n0_sdf(5) * rho_sdf(5)
1690  lambda_hyd = ( pi * rho_sdf(5) / 6.0_rp *n0_sdf(5) * sf_gamma(4.0_rp) &
1691  / ( qe(k,i,j,i_hh) &
1692  + (0.50_rp-sign(0.50_rp,qe(k,i,j,i_hh)-eps)) &
1693  ) )**(0.25_rp)
1694 
1695  tmp_hyd = 0.0_rp
1696  do iq = 1, nbin
1697  dummy(iq) = num_hyd * radc( iq )**3 &
1698  * exp( -lambda_hyd * 0.5_rp * radc( iq ) )
1699  tmp_hyd = tmp_hyd + dummy(iq)
1700  enddo
1701 
1702  coef2 = ( qe(k,i,j,i_hh) ) &
1703  / ( tmp_hyd + ( 0.50_rp - sign(0.50_rp,tmp_hyd-eps) ) )
1704 
1705  do iq = 1, nbin
1706  qtrc(k,i,j,(ih-1)*nbin+iq) = coef2 * dummy(iq)
1707  enddo
1708 
1709  enddo
1710  enddo
1711  enddo
1712 
1713  endif
1714 
1715  do iq = nbin*nspc+1, qa-1
1716  do j = js, je
1717  do i = is, ie
1718  do k = ks, ke
1719  qtrc(k,i,j,iq) = 0.0_rp
1720  end do
1721  end do
1722  end do
1723  end do
1724 
1725  return
integer, public ia
of whole cells: x, local, with HALO
integer, parameter, public i_hs
snow
real(rp) function, public sf_gamma(x)
Gamma function.
integer, parameter, public i_hr
liquid water rain
integer, parameter, public i_hi
ice water cloud
integer, public ja
of whole cells: y, local, with HALO
integer, parameter, public i_hh
hail
integer, public is
start point of inner domain: x, local
integer, public ie
end point of inner domain: x, local
module atmosphere / hydrometeor
integer, public ke
end point of inner domain: z, local
integer, public je
end point of inner domain: y, local
integer, public ks
start point of inner domain: z, local
module SPECFUNC
module CONSTANT
Definition: scale_const.F90:11
integer, parameter, public i_hc
liquid water cloud
integer, public js
start point of inner domain: y, local
real(rp), public const_eps
small number
Definition: scale_const.F90:33
integer, public ka
of whole cells: z, local, with HALO
real(rp), public const_pi
pi
Definition: scale_const.F90:31
integer, parameter, public n_hyd
integer, parameter, public i_hg
graupel
Here is the call graph for this function:
Here is the caller graph for this function:

Variable Documentation

◆ atmos_phy_mp_suzuki10_ntracers

integer, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_ntracers

Definition at line 54 of file scale_atmos_phy_mp_suzuki10.F90.

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_tracer_setup(), and atmos_phy_mp_suzuki10_tracer_setup().

54  integer, public :: atmos_phy_mp_suzuki10_ntracers

◆ atmos_phy_mp_suzuki10_nwaters

integer, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_nwaters

Definition at line 55 of file scale_atmos_phy_mp_suzuki10.F90.

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_tracer_setup(), and atmos_phy_mp_suzuki10_tracer_setup().

55  integer, public :: atmos_phy_mp_suzuki10_nwaters

◆ atmos_phy_mp_suzuki10_nices

integer, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_nices

Definition at line 56 of file scale_atmos_phy_mp_suzuki10.F90.

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_tracer_setup(), and atmos_phy_mp_suzuki10_tracer_setup().

56  integer, public :: atmos_phy_mp_suzuki10_nices

◆ atmos_phy_mp_suzuki10_nccn

integer, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_nccn

Definition at line 57 of file scale_atmos_phy_mp_suzuki10.F90.

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_tracer_setup(), and atmos_phy_mp_suzuki10_tracer_setup().

57  integer, public :: atmos_phy_mp_suzuki10_nccn

◆ atmos_phy_mp_suzuki10_tracer_names

character(len=h_short), dimension(:), allocatable, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_tracer_names

Definition at line 59 of file scale_atmos_phy_mp_suzuki10.F90.

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_tracer_setup(), and atmos_phy_mp_suzuki10_tracer_setup().

59  character(len=H_SHORT), public, allocatable :: atmos_phy_mp_suzuki10_tracer_names(:)

◆ atmos_phy_mp_suzuki10_tracer_descriptions

character(len=h_mid), dimension(:), allocatable, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_tracer_descriptions

Definition at line 60 of file scale_atmos_phy_mp_suzuki10.F90.

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_tracer_setup(), and atmos_phy_mp_suzuki10_tracer_setup().

60  character(len=H_MID) , public, allocatable :: atmos_phy_mp_suzuki10_tracer_descriptions(:)

◆ atmos_phy_mp_suzuki10_tracer_units

character(len=h_short), dimension(:), allocatable, public scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_tracer_units

Definition at line 61 of file scale_atmos_phy_mp_suzuki10.F90.

Referenced by mod_atmos_phy_mp_driver::atmos_phy_mp_driver_tracer_setup(), and atmos_phy_mp_suzuki10_tracer_setup().

61  character(len=H_SHORT), public, allocatable :: atmos_phy_mp_suzuki10_tracer_units(:)

◆ nbin

integer, public scale_atmos_phy_mp_suzuki10::nbin = 33

◆ nccn

integer, public scale_atmos_phy_mp_suzuki10::nccn = 0