CCPP Scidoc for SRW v2.1.0  SRW v2.1.0
Common Community Physics Package Developed at DTC
MYNN-EDMF PBL and Shallow Convection Module <br>

This scheme (1) performs pre-mynnedmf work, (2) runs the mynnedmf, and (3) performs post-mynnedmf work. More...

Modules

module  bl_mynn_common
 Define Model-specific constants/parameters.
 

Functions/Subroutines

subroutine module_bl_mynn::mym_level2 (kts, kte, dz, u, v, thl, thetav, qw, thlsg, qwsg, ql, vt, vq, dtl, dqw, dtv, gm, gh, sm, sh)
 This subroutine calculates the level 2, non-dimensional wind shear \(G_M\) and vertical temperature gradient \(G_H\) as well as the level 2 stability funcitons \(S_h\) and \(S_m\). More...
 
subroutine module_bl_mynn::mym_length (kts, kte, dz, dx, zw, rmo, flt, flq, vt, vq, u1, v1, qke, dtv, el, zi, theta, qkw, Psig_bl, cldfra_bl1D, bl_mynn_mixlength, edmf_w1, edmf_a1, edmf_qc1, bl_mynn_edmf)
 This subroutine calculates the mixing lengths. More...
 
subroutine module_bl_mynn::boulac_length0 (k, kts, kte, zw, dz, qtke, theta, lb1, lb2)
 This subroutine was taken from the BouLac scheme in WRF-ARW and modified for integration into the MYNN PBL scheme. WHILE loops were added to reduce the computational expense. This subroutine computes the length scales up and down and then computes the min, average of the up/down length scales, and also considers the distance to the surface. More...
 
subroutine module_bl_mynn::boulac_length (kts, kte, zw, dz, qtke, theta, lb1, lb2)
 This subroutine was taken from the BouLac scheme in WRF-ARW and modified for integration into the MYNN PBL scheme. WHILE loops were added to reduce the computational expense. This subroutine computes the length scales up and down and then computes the min, average of the up/down length scales, and also considers the distance to the surface. More...
 
subroutine module_bl_mynn::mym_turbulence (kts, kte, closure, dz, dx, zw, u, v, thl, thetav, ql, qw, thlsg, qwsg, qke, tsq, qsq, cov, vt, vq, rmo, flt, flq, zi, theta, sh, sm, El, Dfm, Dfh, Dfq, Tcd, Qcd, Pdk, Pdt, Pdq, Pdc, qWT1D, qSHEAR1D, qBUOY1D, qDISS1D, bl_mynn_tkebudget, Psig_bl, Psig_shcu, cldfra_bl1D, bl_mynn_mixlength, edmf_w1, edmf_a1, edmf_qc1, bl_mynn_edmf, TKEprodTD, spp_pbl, rstoch_col)
 This subroutine calculates the vertical diffusivity coefficients and the production terms for the turbulent quantities.
More...
 
subroutine module_bl_mynn::mym_predict (kts, kte, closure, delt, dz, ust, flt, flq, pmz, phh, el, dfq, rho, pdk, pdt, pdq, pdc, qke, tsq, qsq, cov, s_aw, s_awqke, bl_mynn_edmf_tke, qWT1D, qDISS1D, bl_mynn_tkebudget)
 This subroutine predicts the turbulent quantities at the next step. More...
 
subroutine module_bl_mynn::mym_condensation (kts, kte, dx, dz, zw, thl, qw, qv, qc, qi, p, exner, tsq, qsq, cov, Sh, el, bl_mynn_cloudpdf, qc_bl1D, qi_bl1D, cldfra_bl1D, PBLH1, HFX1, Vt, Vq, th, sgm, rmo, spp_pbl, rstoch_col)
 This subroutine calculates the nonconvective component of the subgrid cloud fraction and mixing ratio as well as the functions used to calculate the buoyancy flux. Different cloud PDFs can be selected by use of the namelist parameter bl_mynn_cloudpdf . More...
 
subroutine module_bl_mynn::mynn_tendencies (kts, kte, i, closure, delt, dz, rho, u, v, th, tk, qv, qc, qi, qnc, qni, psfc, p, exner, thl, sqv, sqc, sqi, sqw, qnwfa, qnifa, ozone, ust, flt, flq, flqv, flqc, wspd, uoce, voce, tsq, qsq, cov, tcd, qcd, dfm, dfh, dfq, Du, Dv, Dth, Dqv, Dqc, Dqi, Dqnc, Dqni, Dqnwfa, Dqnifa, Dozone, vdfg1, diss_heat, s_aw, s_awthl, s_awqt, s_awqv, s_awqc, s_awu, s_awv, s_awqnc, s_awqni, s_awqnwfa, s_awqnifa, sd_aw, sd_awthl, sd_awqt, sd_awqv, sd_awqc, sd_awu, sd_awv, sub_thl, sub_sqv, sub_u, sub_v, det_thl, det_sqv, det_sqc, det_u, det_v, FLAG_QC, FLAG_QI, FLAG_QNC, FLAG_QNI, FLAG_QNWFA, FLAG_QNIFA, cldfra_bl1d, bl_mynn_cloudmix, bl_mynn_mixqt, bl_mynn_edmf, bl_mynn_edmf_mom, bl_mynn_mixscalars)
 This subroutine solves for tendencies of U, V, \(\theta\), qv, qc, and qi. More...
 
subroutine module_bl_mynn::moisture_check (kte, delt, dp, exner, qv, qc, qi, th, dqv, dqc, dqi, dth)
 ensure non-negative moist species. More...
 
subroutine module_bl_mynn::mynn_mix_chem (kts, kte, i, delt, dz, pblh, nchem, kdvel, ndvel, chem1, vd1, rho, flt, tcd, qcd, dfh, s_aw, s_awchem, emis_ant_no, frp, fire_turb)
 
subroutine module_bl_mynn::retrieve_exchange_coeffs (kts, kte, dfm, dfh, dz, K_m, K_h)
 
subroutine module_bl_mynn::tridiag (n, a, b, c, d)
 
subroutine module_bl_mynn::tridiag2 (n, a, b, c, d, x)
 
subroutine module_bl_mynn::tridiag3 (kte, a, b, c, d, x)
 
subroutine module_bl_mynn::mynn_bl_init_driver (RUBLTEN, RVBLTEN, RTHBLTEN, RQVBLTEN, RQCBLTEN, RQIBLTEN, QKE, EXCH_H, RESTART, ALLOWED_TO_READ, LEVEL, IDS, IDE, JDS, JDE, KDS, KDE, IMS, IME, JMS, JME, KMS, KME, ITS, ITE, JTS, JTE, KTS, KTE)
 
subroutine module_bl_mynn::dmp_mf (kts, kte, dt, zw, dz, p, rho, momentum_opt, tke_opt, scalar_opt, u, v, w, th, thl, thv, tk, qt, qv, qc, qke, qnc, qni, qnwfa, qnifa, exner, vt, vq, sgm, ust, flt, fltv, flq, flqv, pblh, kpbl, DX, landsea, ts, edmf_a, edmf_w, edmf_qt, edmf_thl, edmf_ent, edmf_qc, s_aw, s_awthl, s_awqt, s_awqv, s_awqc, s_awu, s_awv, s_awqke, s_awqnc, s_awqni, s_awqnwfa, s_awqnifa, sub_thl, sub_sqv, sub_u, sub_v, det_thl, det_sqv, det_sqc, det_u, det_v, nchem, chem1, s_awchem, mix_chem, qc_bl1d, cldfra_bl1d, qc_bl1D_old, cldfra_bl1D_old, F_QC, F_QI, F_QNC, F_QNI, F_QNWFA, F_QNIFA, Psig_shcu, nup2, ktop, maxmf, ztop, spp_pbl, rstoch_col)
 This subroutine is the Dynamic Multi-Plume (DMP) Mass-Flux Scheme. More...
 
subroutine module_bl_mynn::condensation_edmf (QT, THL, P, zagl, THV, QC)
 zero or one condensation for edmf: calculates THV and QC More...
 
real function module_bl_mynn::esat_blend (t)
 
real function module_bl_mynn::qsat_blend (t, P, waterice)
 This function extends function "esat" and returns a "blended" saturation mixing ratio. More...
 
real function module_bl_mynn::xl_blend (t)
 This function interpolates the latent heats of vaporization and sublimation into a single, temperature-dependent, "blended" value, following Chaboureau and Bechtold (2002) [33], Appendix. More...
 
subroutine module_bl_mynn::topdown_cloudrad (kts, kte, dz1, zw, xland, kpbl, PBLH, sqc, sqi, sqw, thl, th1, ex1, p1, rho1, thetav, cldfra_bl1D, rthraten, maxKHtopdown, KHtopdown, TKEprodTD)
 Calculate the buoyancy production of TKE from cloud-top cooling. More...
 
subroutine module_bl_mynn::mynn_bl_driver (initflag, restart, cycling, delt, dz, dx, znt, u, v, w, th, sqv3D, sqc3D, sqi3D, qnc, qni, qnwfa, qnifa, ozone, p, exner, rho, T3D, xland, ts, qsfc, ps, ust, ch, hfx, qfx, rmol, wspd, uoce, voce, vdfg, Qke, qke_adv, sh3d, sm3d, nchem, kdvel, ndvel, chem3d, vdep, frp, EMIS_ANT_NO, mix_chem, fire_turb, rrfs_smoke, Tsq, Qsq, Cov, RUBLTEN, RVBLTEN, RTHBLTEN, RQVBLTEN, RQCBLTEN, RQIBLTEN, RQNCBLTEN, RQNIBLTEN, RQNWFABLTEN, RQNIFABLTEN, DOZONE, exch_h, exch_m, Pblh, kpbl, el_pbl, dqke, qWT, qSHEAR, qBUOY, qDISS, qc_bl, qi_bl, cldfra_bl, bl_mynn_tkeadvect, bl_mynn_tkebudget, bl_mynn_cloudpdf, bl_mynn_mixlength, icloud_bl, closure, bl_mynn_edmf, bl_mynn_edmf_mom, bl_mynn_edmf_tke, bl_mynn_mixscalars, bl_mynn_output, bl_mynn_cloudmix, bl_mynn_mixqt, edmf_a, edmf_w, edmf_qt, edmf_thl, edmf_ent, edmf_qc, sub_thl3D, sub_sqv3D, det_thl3D, det_sqv3D, nupdraft, maxMF, ktop_plume, spp_pbl, pattern_spp_pbl, RTHRATEN, FLAG_QC, FLAG_QI, FLAG_QNC, FLAG_QNI, FLAG_QNWFA, FLAG_QNIFA, FLAG_OZONE, IDS, IDE, JDS, JDE, KDS, KDE, IMS, IME, JMS, JME, KMS, KME, ITS, ITE, JTS, JTE, KTS, KTE)
 This subroutine is the GSD MYNN-EDNF PBL driver routine,which encompassed the majority of the subroutines that comprise the procedures that ultimately solve for tendencies of \(U, V, \theta, q_v, q_c, and q_i\). More...
 
subroutine module_bl_mynn::mym_initialize (kts, kte, dz, dx, zw, u, v, thl, qw, thlsg, qwsg, zi, theta, thetav, sh, sm, ust, rmo, el, Qke, Tsq, Qsq, Cov, Psig_bl, cldfra_bl1D, bl_mynn_mixlength, edmf_w1, edmf_a1, edmf_qc1, bl_mynn_edmf, INITIALIZE_QKE, spp_pbl, rstoch_col)
 This subroutine gives the closure constants and initializes the turbulent qantities. More...
 
subroutine module_bl_mynn::get_pblh (KTS, KTE, zi, thetav1D, qke1D, zw1D, dz1D, landsea, kzi)
 This subroutine calculates hybrid diagnotic boundary-layer height (PBLH). More...
 

Detailed Description

Argument Table

mynnedmf_wrapper_run argument table
local_namestandard_namelong_nameunitstypedimensionskindintent
imhorizontal_loop_extenthorizontal loop extentcountinteger()in
levsvertical_layer_dimensionvertical layer dimensioncountinteger()in
flag_initflag_for_first_timestepflag signaling first time step for time integration loopflaglogical()in
flag_restartflag_for_restartflag for restart (warmstart) or coldstartflaglogical()in
lssavflag_for_diagnosticslogical flag for storing diagnosticsflaglogical()in
ldiag3dflag_for_diagnostics_3dflag for 3d diagnostic fieldsflaglogical()in
qdiag3dflag_for_tracer_diagnostics_3dflag for 3d tracer diagnostic fieldsflaglogical()in
lsideaflag_for_integrated_dynamics_through_earths_atmosphereflag for idealized physicsflaglogical()in
cplflxflag_for_surface_flux_couplingflag controlling cplflx collection (default off)flaglogical()in
delttimestep_for_physicstime step for physicssreal()kind_physin
dtftimestep_for_dynamicsdynamics timestepsreal()kind_physin
dxcharacteristic_grid_lengthscalesize of the grid cellmreal(ccpp_constant_one:horizontal_loop_extent)kind_physin
zorlsurface_roughness_lengthsurface roughness length in cmcmreal(ccpp_constant_one:horizontal_loop_extent)kind_physin
phiigeopotential_at_interfacegeopotential at model layer interfacesm2 s-2real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_interface_dimension)kind_physin
Ux_windx component of layer windm s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
Vy_windy component of layer windm s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
omegalagrangian_tendency_of_air_pressurelayer mean vertical velocityPa s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
T3Dair_temperaturelayer mean air temperatureKreal(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
qgrs_water_vaporspecific_humiditywater vapor specific humiditykg kg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
qgrs_liquid_cloudcloud_liquid_water_mixing_ratioratio of mass of cloud water to mass of dry air plus vapor (without condensates)kg kg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
qgrs_ice_cloudcloud_ice_mixing_ratioratio of mass of ice water to mass of dry air plus vapor (without condensates)kg kg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
qgrs_cloud_droplet_num_concmass_number_concentration_of_cloud_liquid_water_particles_in_airnumber concentration of cloud droplets (liquid)kg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
qgrs_cloud_ice_num_concmass_number_concentration_of_cloud_ice_water_crystals_in_airnumber concentration of icekg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
qgrs_ozoneozone_mixing_ratioozone mixing ratiokg kg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
qgrs_water_aer_num_concmass_number_concentration_of_hygroscopic_aerosolsnumber concentration of water-friendly aerosolskg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
qgrs_ice_aer_num_concmass_number_concentration_of_nonhygroscopic_ice_nucleating_aerosolsnumber concentration of ice-friendly aerosolskg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
qgrs_cccncloud_condensation_nuclei_number_concentrationnumber concentration of cloud condensation nucleikg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
prslair_pressuremean layer pressurePareal(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
exnerdimensionless_exner_functionExner function at layersnonereal(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
slmskarea_typelandmask: sea/land/ice=0/1/2flagreal(ccpp_constant_one:horizontal_loop_extent)kind_physin
tsurfsurface_skin_temperaturesurface temperatureKreal(ccpp_constant_one:horizontal_loop_extent)kind_physin
qsfcsurface_specific_humiditysurface air saturation specific humiditykg kg-1real(ccpp_constant_one:horizontal_loop_extent)kind_physin
pssurface_air_pressuresurface pressurePareal(ccpp_constant_one:horizontal_loop_extent)kind_physin
ustsurface_friction_velocityboundary layer parameterm s-1real(ccpp_constant_one:horizontal_loop_extent)kind_physin
chsurface_drag_wind_speed_for_momentum_in_airmomentum exchange coefficientm s-1real(ccpp_constant_one:horizontal_loop_extent)kind_physout
hflxkinematic_surface_upward_sensible_heat_flux_reduced_by_surface_roughness_and_vegetationkinematic surface upward sensible heat flux reduced by surface roughness and vegetationK m s-1real(ccpp_constant_one:horizontal_loop_extent)kind_physin
qflxsurface_upward_specific_humidity_fluxkinematic surface upward latent heat fluxkg kg-1 m s-1real(ccpp_constant_one:horizontal_loop_extent)kind_physin
wspdwind_speed_at_lowest_model_layerwind speed at lowest model levelm s-1real(ccpp_constant_one:horizontal_loop_extent)kind_physin
rbbulk_richardson_number_at_lowest_model_levelbulk Richardson number at the surfacenonereal(ccpp_constant_one:horizontal_loop_extent)kind_physin
dtsfc1instantaneous_surface_upward_sensible_heat_fluxsurface upward sensible heat flux valid for current callW m-2real(ccpp_constant_one:horizontal_loop_extent)kind_physout
dqsfc1instantaneous_surface_upward_latent_heat_fluxsurface upward latent heat flux valid for current callW m-2real(ccpp_constant_one:horizontal_loop_extent)kind_physout
dusfc1instantaneous_surface_x_momentum_fluxsurface momentum flux in the x-direction valid for current callPareal(ccpp_constant_one:horizontal_loop_extent)kind_physout
dvsfc1instantaneous_surface_y_momentum_fluxsurface momentum flux in the y-direction valid for current callPareal(ccpp_constant_one:horizontal_loop_extent)kind_physout
dusfci_diaginstantaneous_surface_x_momentum_flux_for_diaginstantaneous sfc x momentum flux multiplied by timestepPareal(ccpp_constant_one:horizontal_loop_extent)kind_physout
dvsfci_diaginstantaneous_surface_y_momentum_flux_for_diaginstantaneous sfc y momentum flux multiplied by timestepPareal(ccpp_constant_one:horizontal_loop_extent)kind_physout
dtsfci_diaginstantaneous_surface_upward_sensible_heat_flux_for_diaginstantaneous sfc sensible heat flux multiplied by timestepW m-2real(ccpp_constant_one:horizontal_loop_extent)kind_physout
dqsfci_diaginstantaneous_surface_upward_latent_heat_flux_for_diaginstantaneous sfc latent heat flux multiplied by timestepW m-2real(ccpp_constant_one:horizontal_loop_extent)kind_physout
dusfc_diagcumulative_surface_x_momentum_flux_for_diag_multiplied_by_timestepcumulative sfc x momentum flux multiplied by timestepPa sreal(ccpp_constant_one:horizontal_loop_extent)kind_physinout
dvsfc_diagcumulative_surface_y_momentum_flux_for_diag_multiplied_by_timestepcumulative sfc y momentum flux multiplied by timestepPa sreal(ccpp_constant_one:horizontal_loop_extent)kind_physinout
dtsfc_diagcumulative_surface_upward_sensible_heat_flux_for_diag_multiplied_by_timestepcumulative sfc sensible heat flux multiplied by timestepW m-2 sreal(ccpp_constant_one:horizontal_loop_extent)kind_physinout
dqsfc_diagcumulative_surface_upward_latent_heat_flux_for_diag_multiplied_by_timestepcumulative sfc latent heat flux multiplied by timestepW m-2 sreal(ccpp_constant_one:horizontal_loop_extent)kind_physinout
dusfc_cicesurface_x_momentum_flux_from_coupled_processsfc x momentum flux for couplingPareal(ccpp_constant_one:horizontal_loop_extent)kind_physin
dvsfc_cicesurface_y_momentum_flux_from_coupled_processsfc y momentum flux for couplingPareal(ccpp_constant_one:horizontal_loop_extent)kind_physin
dtsfc_cicesurface_upward_sensible_heat_flux_from_coupled_processsfc sensible heat flux for couplingW m-2real(ccpp_constant_one:horizontal_loop_extent)kind_physin
dqsfc_cicesurface_upward_latent_heat_flux_from_coupled_processsfc latent heat flux for couplingW m-2real(ccpp_constant_one:horizontal_loop_extent)kind_physin
hflx_watkinematic_surface_upward_sensible_heat_flux_over_waterkinematic surface upward sensible heat flux over waterK m s-1real(ccpp_constant_one:horizontal_loop_extent)kind_physin
qflx_watkinematic_surface_upward_latent_heat_flux_over_waterkinematic surface upward latent heat flux over waterkg kg-1 m s-1real(ccpp_constant_one:horizontal_loop_extent)kind_physin
stress_watsurface_wind_stress_over_watersurface wind stress over waterm2 s-2real(ccpp_constant_one:horizontal_loop_extent)kind_physin
oceanfracsea_area_fractionfraction of horizontal grid area occupied by oceanfracreal(ccpp_constant_one:horizontal_loop_extent)kind_physin
ficesea_ice_area_fraction_of_sea_area_fractionice fraction over open waterfracreal(ccpp_constant_one:horizontal_loop_extent)kind_physin
wetflag_nonzero_wet_surface_fractionflag indicating presence of some ocean or lake surface area fractionflaglogical(ccpp_constant_one:horizontal_loop_extent)in
icyflag_nonzero_sea_ice_surface_fractionflag indicating presence of some sea ice surface area fractionflaglogical(ccpp_constant_one:horizontal_loop_extent)in
dryflag_nonzero_land_surface_fractionflag indicating presence of some land surface area fractionflaglogical(ccpp_constant_one:horizontal_loop_extent)in
dusfci_cplsurface_x_momentum_flux_for_couplinginstantaneous sfc u momentum fluxPareal(ccpp_constant_one:horizontal_loop_extent)kind_physinout
dvsfci_cplsurface_y_momentum_flux_for_couplinginstantaneous sfc v momentum fluxPareal(ccpp_constant_one:horizontal_loop_extent)kind_physinout
dtsfci_cplsurface_upward_sensible_heat_flux_for_couplinginstantaneous sfc sensible heat fluxW m-2real(ccpp_constant_one:horizontal_loop_extent)kind_physinout
dqsfci_cplsurface_upward_latent_heat_flux_for_couplinginstantaneous sfc latent heat fluxW m-2real(ccpp_constant_one:horizontal_loop_extent)kind_physinout
dusfc_cplcumulative_surface_x_momentum_flux_for_coupling_multiplied_by_timestepcumulative sfc u momentum flux multiplied by timestepPa sreal(ccpp_constant_one:horizontal_loop_extent)kind_physinout
dvsfc_cplcumulative_surface_y_momentum_flux_for_coupling_multiplied_by_timestepcumulative sfc v momentum flux multiplied by timestepPa sreal(ccpp_constant_one:horizontal_loop_extent)kind_physinout
dtsfc_cplcumulative_surface_upward_sensible_heat_flux_for_coupling_multiplied_by_timestepcumulative sfc sensible heat flux multiplied by timestepW m-2 sreal(ccpp_constant_one:horizontal_loop_extent)kind_physinout
dqsfc_cplcumulative_surface_upward_latent_heat_flux_for_coupling_multiplied_by_timestepcumulative sfc latent heat flux multiplied by timestepW m-2 sreal(ccpp_constant_one:horizontal_loop_extent)kind_physinout
recmolreciprocal_of_obukhov_lengthone over obukhov lengthm-1real(ccpp_constant_one:horizontal_loop_extent)kind_physin
qkenonadvected_turbulent_kinetic_energy_multiplied_by_22 x tke at mass pointsm2 s-2real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
qke_advturbulent_kinetic_energyturbulent kinetic energyJreal(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
tsqvariance_of_air_temperaturetemperature fluctuation squaredK2real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physout
qsqvariance_of_specific_humiditywater vapor fluctuation squaredkg2 kg-2real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physout
covcovariance_of_air_temperature_and_specific_humiditycovariance of temperature and moistureK kg kg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physout
el_pblturbulent_mixing_lengthmixing length in metersmreal(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
Sh3Dstability_function_for_heatstability function for heatnonereal(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
Sm3Dstability_function_for_momentumstability function for momentumnonereal(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
exch_hatmosphere_heat_diffusivity_for_mynnedmfdiffusivity for heat for MYNN PBL (defined for all mass levels)m2 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physout
exch_matmosphere_momentum_diffusivity_for_mynnedmfdiffusivity for momentum for MYNN PBL (defined for all mass levels)m2 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physout
dqketotal_time_rate_of_change_of_tketotal tke tendencym2 s-3real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physout
qwttke_tendency_due_to_vertical_transporttke tendency due to vertical transport and diffusionm2 s-3real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physout
qsheartke_tendency_due_to_sheartke tendency due to shearm2 s-3real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physout
qbuoytke_tendency_due_to_buoyancytke tendency due to buoyancy production or consumptionm2 s-3real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physout
qdisstke_tendency_due_to_dissipationtke tendency due to the dissipation of tkem2 s-3real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physout
PBLHatmosphere_boundary_layer_thicknessPBL thicknessmreal(ccpp_constant_one:horizontal_loop_extent)kind_physinout
kpblvertical_index_at_top_of_atmosphere_boundary_layerPBL top model level indexindexinteger(ccpp_constant_one:horizontal_loop_extent)inout
QC_BLsubgrid_scale_cloud_liquid_water_mixing_ratiosubgrid cloud water mixing ratio from PBL schemekg kg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
QI_BLsubgrid_scale_cloud_ice_mixing_ratiosubgrid cloud ice mixing ratio from PBL schemekg kg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
CLDFRA_BLsubgrid_scale_cloud_area_fraction_in_atmosphere_layersubgrid cloud fraction from PBL schemefracreal(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
edmf_aemdf_updraft_areaupdraft area from mass flux schemefracreal(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
edmf_wemdf_updraft_vertical_velocityupdraft vertical velocity from mass flux schemem s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
edmf_qtemdf_updraft_total_waterupdraft total water from mass flux schemekg kg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
edmf_thlemdf_updraft_theta_lupdraft theta-l from mass flux schemeKreal(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
edmf_entemdf_updraft_entrainment_rateupdraft entrainment rate from mass flux schemes-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
edmf_qcemdf_updraft_cloud_waterupdraft cloud water from mass flux schemekg kg-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
sub_thltheta_subsidence_tendencyupdraft theta subsidence tendencyK s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
sub_sqvwater_vapor_subsidence_tendencyupdraft water vapor subsidence tendencykg kg-1 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
det_thltheta_detrainment_tendencyupdraft theta detrainment tendencyK s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
det_sqvwater_vapor_detrainment_tendencyupdraft water vapor detrainment tendencykg kg-1 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
nupdraftnumber_of_plumesnumber of plumes per grid columncountinteger(ccpp_constant_one:horizontal_loop_extent)inout
maxMFmaximum_mass_fluxmaximum mass flux within a columnm s-1real(ccpp_constant_one:horizontal_loop_extent)kind_physout
ktop_plumek_level_of_highest_plumek-level of highest plumecountinteger(ccpp_constant_one:horizontal_loop_extent)inout
dudtprocess_split_cumulative_tendency_of_x_windupdated tendency of the x windm s-2real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
dvdtprocess_split_cumulative_tendency_of_y_windupdated tendency of the y windm s-2real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
dtdtprocess_split_cumulative_tendency_of_air_temperatureupdated tendency of the temperatureK s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
dqdt_water_vaporprocess_split_cumulative_tendency_of_specific_humiditywater vapor specific humidity tendency due to model physicskg kg-1 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
dqdt_liquid_cloudprocess_split_cumulative_tendency_of_cloud_liquid_water_mixing_ratiocloud condensed water mixing ratio tendency due to model physicskg kg-1 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
dqdt_ice_cloudprocess_split_cumulative_tendency_of_cloud_ice_mixing_ratiocloud condensed water mixing ratio tendency due to model physicskg kg-1 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
dqdt_ozoneprocess_split_cumulative_tendency_of_ozone_mixing_ratioozone mixing ratio tendency due to model physicskg kg-1 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
dqdt_cloud_droplet_num_concprocess_split_cumulative_tendency_of_mass_number_concentration_of_cloud_liquid_water_particles_in_airnumber conc. of cloud droplets (liquid) tendency due to model physicskg-1 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
dqdt_ice_num_concprocess_split_cumulative_tendency_of_mass_number_concentration_of_cloud_ice_water_crystals_in_airnumber conc. of ice tendency due to model physicskg-1 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
dqdt_water_aer_num_concprocess_split_cumulative_tendency_of_mass_number_concentration_of_hygroscopic_aerosolsnumber conc. of water-friendly aerosols tendency due to model physicskg-1 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
dqdt_ice_aer_num_concprocess_split_cumulative_tendency_of_mass_number_concentration_of_nonhygroscopic_ice_nucleating_aerosolsnumber conc. of ice-friendly aerosols tendency due to model physicskg-1 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
dqdt_cccntendency_of_cloud_condensation_nuclei_number_concentration_due_to_model_physicsnumber concentration of cloud condensation nuclei tendency due to model physicskg-1 s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physinout
flag_for_pbl_generic_tendflag_for_generic_tendency_due_to_planetary_boundary_layertrue if GFS_PBL_generic should calculate tendenciesflaglogical()in
dtendcumulative_change_of_state_variablesdiagnostic tendencies for state variablesmixedreal(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension, ccpp_constant_one:cumulative_change_of_state_variables_outer_index_max)kind_physinout
dtidxcumulative_change_of_state_variables_outer_indexindex of state-variable and process in last dimension of diagnostic tendencies array AKA cumulative_change_indexindexinteger(ccpp_constant_one:number_of_tracers_plus_one_hundred, ccpp_constant_one:number_of_cumulative_change_processes)in
index_of_temperatureindex_of_temperature_in_cumulative_change_indexindex of temperature in first dimension of array cumulative change indexindexinteger()in
index_of_x_windindex_of_x_wind_in_cumulative_change_indexindex of x-wind in first dimension of array cumulative change indexindexinteger()in
index_of_y_windindex_of_y_wind_in_cumulative_change_indexindex of x-wind in first dimension of array cumulative change indexindexinteger()in
ntkeindex_of_turbulent_kinetic_energy_in_tracer_concentration_arraytracer index for turbulent kinetic energyindexinteger()in
ntozindex_of_ozone_mixing_ratio_in_tracer_concentration_arraytracer index for ozone mixing ratioindexinteger()in
ntqvindex_of_specific_humidity_in_tracer_concentration_arraytracer index for water vapor (specific humidity)indexinteger()in
ntcwindex_of_cloud_liquid_water_mixing_ratio_in_tracer_concentration_arraytracer index for cloud condensate (or liquid water)indexinteger()in
ntiwindex_of_cloud_ice_mixing_ratio_in_tracer_concentration_arraytracer index for ice waterindexinteger()in
ntlncindex_of_mass_number_concentration_of_cloud_droplets_in_tracer_concentration_arraytracer index for liquid number concentrationindexinteger()in
ntincindex_of_mass_number_concentration_of_cloud_ice_in_tracer_concentration_arraytracer index for ice number concentrationindexinteger()in
ntwaindex_of_mass_number_concentration_of_hygroscopic_aerosols_in_tracer_concentration_arraytracer index for water friendly aerosolindexinteger()in
ntiaindex_of_mass_number_concentration_of_nonhygroscopic_ice_nucleating_aerosols_in_tracer_concentration_arraytracer index for ice friendly aerosolindexinteger()in
index_of_process_pblindex_of_subgrid_scale_vertical_mixing_process_in_cumulative_change_indexindex of subgrid scale vertical mixing process in second dimension of array cumulative change indexindexinteger()in
htrswtendency_of_air_temperature_due_to_shortwave_heating_on_radiation_timesteptotal sky sw heating rateK s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
htrlwtendency_of_air_temperature_due_to_longwave_heating_on_radiation_timesteptotal sky lw heating rateK s-1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
xmuzenith_angle_temporal_adjustment_factor_for_shortwave_fluxeszenith angle temporal adjustment factor for shortwavenonereal(ccpp_constant_one:horizontal_loop_extent)kind_physin
bl_mynn_tkebudgetcontrol_for_tke_budget_outputflag for activating TKE budgetflaglogical()in
bl_mynn_tkeadvectflag_for_tke_advectionflag for activating TKE advectflaglogical()in
bl_mynn_cloudpdfcontrol_for_cloud_pdf_in_mellor_yamada_nakanishi_niino_pbl_schemeflag to determine which cloud PDF to useflaginteger()in
bl_mynn_mixlengthcontrol_for_mixing_length_in_mellor_yamada_nakanishi_niino_pbl_schemeflag to determine which mixing length form to useflaginteger()in
bl_mynn_edmfcontrol_for_edmf_in_mellor_yamada_nakanishi_niino_pbl_schemeflag to activate the mass-flux schemeflaginteger()in
bl_mynn_edmf_momcontrol_for_edmf_momentum_transport_in_mellor_yamada_nakanishi_niino_pbl_schemeflag to activate the transport of momentumflaginteger()in
bl_mynn_edmf_tkecontrol_for_edmf_tke_transport_in_mellor_yamada_nakanishi_niino_pbl_schemeflag to activate the transport of TKEflaginteger()in
bl_mynn_cloudmixcontrol_for_cloud_species_mixing_in_mellor_yamada_nakanishi_niino_pbl_schemeflag to activate mixing of cloud speciesflaginteger()in
bl_mynn_mixqtcontrol_for_total_water_mixing_in_mellor_yamada_nakanishi_niino_pbl_schemeflag to mix total water or individual speciesflaginteger()in
bl_mynn_outputcontrol_for_additional_diagnostics_in_mellor_yamada_nakanishi_niino_pbl_schemeflag initialize and output extra 3D variablesflaginteger()in
bl_mynn_closurecontrol_for_closure_level_in_mellor_yamada_nakanishi_niino_pbl_schemeflag to determine the closure level for the mynn1real()kind_physin
icloud_blcontrol_for_sgs_cloud_radiation_coupling_in_mellor_yamamda_nakanishi_niino_pbl_schemeflag for coupling sgs clouds to radiationflaginteger()in
do_mynnsfclayflag_for_mellor_yamada_nakanishi_niino_surface_layer_schemeflag to activate MYNN surface layerflaglogical()in
imp_physicscontrol_for_microphysics_schemechoice of microphysics schemeflaginteger()in
imp_physics_gfdlidentifier_for_gfdl_microphysics_schemechoice of GFDL microphysics schemeflaginteger()in
imp_physics_thompsonidentifier_for_thompson_microphysics_schemechoice of Thompson microphysics schemeflaginteger()in
imp_physics_wsm6identifier_for_wsm6_microphysics_schemechoice of WSM6 microphysics schemeflaginteger()in
imp_physics_nsslidentifier_for_nssl_microphysics_schemechoice of NSSL 2-moment microphysics schemeflaginteger()in
nssl_ccn_onnssl_ccn_onCCN activation flag in NSSL microflaglogical()in
chem3dchem3d_mynn_pbl_transportmynn pbl transport of smoke and dustvariousreal(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension, ccpp_constant_one:2)kind_physinout
frpfrp_hourlyhourly fire radiative powerMWreal(ccpp_constant_one:horizontal_loop_extent)kind_physinout
rrfs_smokedo_smoke_couplingflag controlling rrfs_smoke collection (default off)flaglogical()in
mix_chemdo_planetary_boundary_layer_smoke_mixingflag for rrfs smoke mynn tracer mixingflaglogical()in
fire_turbdo_planetary_boundary_layer_fire_enhancementflag for rrfs smoke mynn enh vermixflaglogical()in
nchemnumber_of_chemical_species_vertically_mixednumber of chemical vertically mixedcountinteger()in
ndvelnumber_of_chemical_species_depositednumber of chemical pbl depositedcountinteger()in
ltaerosolflag_for_aerosol_physicsflag for aerosol physicsflaglogical()in
mraerosoldo_merra2_aerosol_awarenessflag for merra2 aerosol-aware physics for example the thompson microphysicsflaglogical()in
spp_wts_pblspp_weights_for_pbl_schemespp weights for pbl scheme1real(ccpp_constant_one:horizontal_loop_extent, ccpp_constant_one:vertical_layer_dimension)kind_physin
spp_pblcontrol_for_pbl_spp_perturbationscontrol for pbl spp perturbationscountinteger()in
lprntflag_printcontrol flag for diagnostic print outflaglogical()in
hugenetcdf_float_fillvaluedefinition of NetCDF float FillValuenonereal()kind_physin
errmsgccpp_error_messageerror message for error handling in CCPPnonecharacter()len=*out
errflgccpp_error_codeerror code for error handling in CCPP1integer()out