This module contains the RUC Land Surface Model developed by NOAA/GSD (Smirnova et al. 2016 [168]).
More...
local_name | standard_name | long_name | units | type | dimensions | kind | intent | optional |
iter | ccpp_loop_counter | loop counter for subcycling loops in CCPP | index | integer | () | | in | False |
me | mpi_rank | current MPI-rank | index | integer | () | | in | False |
master | mpi_root | master MPI-rank | index | integer | () | | in | False |
kdt | index_of_time_step | current number of time steps | index | integer | () | | in | False |
im | horizontal_loop_extent | horizontal loop extent | count | integer | () | | in | False |
nlev | vertical_dimension | number of vertical levels | count | integer | () | | in | False |
lsoil_ruc | soil_vertical_dimension_for_land_surface_model | number of soil layers internal to land surface model | count | integer | () | | in | False |
lsoil | soil_vertical_dimension | soil vertical layer dimension | count | integer | () | | in | False |
zs | depth_of_soil_levels_for_land_surface_model | depth of soil levels for land surface model | m | real | (soil_vertical_dimension_for_land_surface_model) | kind_phys | inout | False |
t1 | air_temperature_at_lowest_model_layer | mean temperature at lowest model layer | K | real | (horizontal_dimension) | kind_phys | in | False |
q1 | water_vapor_specific_humidity_at_lowest_model_layer | water vapor specific humidity at lowest model layer | kg kg-1 | real | (horizontal_dimension) | kind_phys | in | False |
qc | cloud_condensed_water_mixing_ratio_at_lowest_model_layer | moist (dry+vapor, no condensates) mixing ratio of cloud water at lowest model layer | kg kg-1 | real | (horizontal_dimension) | kind_phys | in | False |
soiltyp | soil_type_classification | soil type at each grid cell | index | integer | (horizontal_dimension) | | inout | False |
vegtype | vegetation_type_classification | vegetation type at each grid cell | index | integer | (horizontal_dimension) | | inout | False |
sigmaf | vegetation_area_fraction | areal fractional cover of green vegetation | frac | real | (horizontal_dimension) | kind_phys | in | False |
laixy | leaf_area_index | leaf area index | none | real | (horizontal_dimension) | kind_phys | in | False |
sfcemis | surface_longwave_emissivity_over_land_interstitial | surface lw emissivity in fraction over land (temporary use as interstitial) | frac | real | (horizontal_dimension) | kind_phys | inout | False |
dlwflx | surface_downwelling_longwave_flux | surface downwelling longwave flux at current time | W m-2 | real | (horizontal_dimension) | kind_phys | in | False |
dswsfc | surface_downwelling_shortwave_flux | surface downwelling shortwave flux at current time | W m-2 | real | (horizontal_dimension) | kind_phys | in | False |
snet | surface_net_downwelling_shortwave_flux | surface net downwelling shortwave flux at current time | W m-2 | real | (horizontal_dimension) | kind_phys | in | False |
delt | time_step_for_dynamics | physics time step | s | real | () | kind_phys | in | False |
tg3 | deep_soil_temperature | deep soil temperature | K | real | (horizontal_dimension) | kind_phys | in | False |
cm | surface_drag_coefficient_for_momentum_in_air_over_land | surface exchange coeff for momentum over land | none | real | (horizontal_dimension) | kind_phys | in | False |
ch | surface_drag_coefficient_for_heat_and_moisture_in_air_over_land | surface exchange coeff heat & moisture over land | none | real | (horizontal_dimension) | kind_phys | in | False |
prsl1 | air_pressure_at_lowest_model_layer | mean pressure at lowest model layer | Pa | real | (horizontal_dimension) | kind_phys | in | False |
zf | height_above_ground_at_lowest_model_layer | layer 1 height above ground (not MSL) | m | real | (horizontal_dimension) | kind_phys | in | False |
wind | wind_speed_at_lowest_model_layer | wind speed at lowest model level | m s-1 | real | (horizontal_dimension) | kind_phys | in | False |
shdmin | minimum_vegetation_area_fraction | min fractional coverage of green vegetation | frac | real | (horizontal_dimension) | kind_phys | in | False |
shdmax | maximum_vegetation_area_fraction | max fractional coverage of green vegetation | frac | real | (horizontal_dimension) | kind_phys | in | False |
alvwf | mean_vis_albedo_with_weak_cosz_dependency | mean vis albedo with weak cosz dependency | frac | real | (horizontal_dimension) | kind_phys | in | False |
alnwf | mean_nir_albedo_with_weak_cosz_dependency | mean nir albedo with weak cosz dependency | frac | real | (horizontal_dimension) | kind_phys | in | False |
snoalb | upper_bound_on_max_albedo_over_deep_snow | maximum snow albedo | frac | real | (horizontal_dimension) | kind_phys | in | False |
sfalb | surface_diffused_shortwave_albedo | mean surface diffused sw albedo | frac | real | (horizontal_dimension) | kind_phys | inout | False |
flag_iter | flag_for_iteration | flag for iteration | flag | logical | (horizontal_dimension) | | in | False |
flag_guess | flag_for_guess_run | flag for guess run | flag | logical | (horizontal_dimension) | | in | False |
isot | soil_type_dataset_choice | soil type dataset choice | index | integer | () | | in | False |
ivegsrc | vegetation_type_dataset_choice | land use dataset choice | index | integer | () | | in | False |
fice | sea_ice_concentration | ice fraction over open water | frac | real | (horizontal_dimension) | kind_phys | inout | False |
smc | volume_fraction_of_soil_moisture | total soil moisture | frac | real | (horizontal_dimension, soil_vertical_dimension) | kind_phys | inout | False |
stc | soil_temperature | soil temperature | K | real | (horizontal_dimension, soil_vertical_dimension) | kind_phys | inout | False |
slc | volume_fraction_of_unfrozen_soil_moisture | liquid soil moisture | frac | real | (horizontal_dimension, soil_vertical_dimension) | kind_phys | inout | False |
lsm_ruc | flag_for_ruc_land_surface_scheme | flag for RUC land surface model | flag | integer | () | | in | False |
lsm | flag_for_land_surface_scheme | flag for land surface model | flag | integer | () | | in | False |
land | flag_nonzero_land_surface_fraction | flag indicating presence of some land surface area fraction | flag | logical | (horizontal_dimension) | | in | False |
islimsk | sea_land_ice_mask | sea/land/ice mask (=0/1/2) | flag | integer | (horizontal_dimension) | | in | False |
rdlai | flag_for_reading_leaf_area_index_from_input | flag for reading leaf area index from initial conditions for RUC LSM | flag | logical | () | | in | False |
imp_physics | flag_for_microphysics_scheme | choice of microphysics scheme | flag | integer | () | | in | False |
imp_physics_gfdl | flag_for_gfdl_microphysics_scheme | choice of GFDL microphysics scheme | flag | integer | () | | in | False |
imp_physics_thompson | flag_for_thompson_microphysics_scheme | choice of Thompson microphysics scheme | flag | integer | () | | in | False |
smcwlt2 | volume_fraction_of_condensed_water_in_soil_at_wilting_point | soil water fraction at wilting point | frac | real | (horizontal_dimension) | kind_phys | inout | False |
smcref2 | threshold_volume_fraction_of_condensed_water_in_soil | soil moisture threshold | frac | real | (horizontal_dimension) | kind_phys | inout | False |
do_mynnsfclay | do_mynnsfclay | flag to activate MYNN surface layer | flag | logical | () | | in | False |
con_cp | specific_heat_of_dry_air_at_constant_pressure | specific heat !of dry air at constant pressure | J kg-1 K-1 | real | () | kind_phys | in | False |
con_rv | gas_constant_water_vapor | ideal gas constant for water vapor | J kg-1 K-1 | real | () | kind_phys | in | False |
con_rd | gas_constant_dry_air | ideal gas constant for dry air | J kg-1 K-1 | real | () | kind_phys | in | False |
con_g | gravitational_acceleration | gravitational acceleration | m s-2 | real | () | kind_phys | in | False |
con_pi | pi | ratio of a circle's circumference to its diameter | none | real | () | kind_phys | in | False |
con_hvap | latent_heat_of_vaporization_of_water_at_0C | latent heat of vaporization/sublimation (hvap) | J kg-1 | real | () | kind_phys | in | False |
con_fvirt | ratio_of_vapor_to_dry_air_gas_constants_minus_one | rv/rd - 1 (rv = ideal gas constant for water vapor) | none | real | () | kind_phys | in | False |
weasd | water_equivalent_accumulated_snow_depth_over_land | water equiv of acc snow depth over land | mm | real | (horizontal_dimension) | kind_phys | inout | False |
snwdph | surface_snow_thickness_water_equivalent_over_land | water equivalent snow depth over land | mm | real | (horizontal_dimension) | kind_phys | inout | False |
tskin | surface_skin_temperature_over_land_interstitial | surface skin temperature over land use as interstitial | K | real | (horizontal_dimension) | kind_phys | inout | False |
tskin_wat | surface_skin_temperature_over_ocean_interstitial | surface skin temperature over ocean (temporary use as interstitial) | K | real | (horizontal_dimension) | kind_phys | inout | False |
rainnc | lwe_thickness_of_explicit_rainfall_amount_from_previous_timestep | explicit rainfall from previous timestep | m | real | (horizontal_dimension) | kind_phys | in | False |
rainc | lwe_thickness_of_convective_precipitation_amount_from_previous_timestep | convective_precipitation_amount from previous timestep | m | real | (horizontal_dimension) | kind_phys | in | False |
ice | lwe_thickness_of_ice_amount_from_previous_timestep | ice amount from previous timestep | m | real | (horizontal_dimension) | kind_phys | in | False |
snow | lwe_thickness_of_snow_amount_from_previous_timestep | snow amount from previous timestep | m | real | (horizontal_dimension) | kind_phys | in | False |
graupel | lwe_thickness_of_graupel_amount_from_previous_timestep | graupel amount from previous timestep | m | real | (horizontal_dimension) | kind_phys | in | False |
srflag | flag_for_precipitation_type | snow/rain flag for precipitation | flag | real | (horizontal_dimension) | kind_phys | inout | False |
smois | volume_fraction_of_soil_moisture_for_land_surface_model | volumetric fraction of soil moisture for lsm | frac | real | (horizontal_dimension, soil_vertical_dimension_for_land_surface_model) | kind_phys | inout | False |
tslb | soil_temperature_for_land_surface_model | soil temperature for land surface model | K | real | (horizontal_dimension, soil_vertical_dimension_for_land_surface_model) | kind_phys | inout | False |
sh2o | volume_fraction_of_unfrozen_soil_moisture_for_land_surface_model | volume fraction of unfrozen soil moisture for lsm | frac | real | (horizontal_dimension, soil_vertical_dimension_for_land_surface_model) | kind_phys | inout | False |
keepfr | flag_for_frozen_soil_physics | flag for frozen soil physics (RUC) | flag | real | (horizontal_dimension, soil_vertical_dimension_for_land_surface_model) | kind_phys | inout | False |
smfrkeep | volume_fraction_of_frozen_soil_moisture_for_land_surface_model | volume fraction of frozen soil moisture for lsm | frac | real | (horizontal_dimension, soil_vertical_dimension_for_land_surface_model) | kind_phys | inout | False |
canopy | canopy_water_amount | canopy water amount | kg m-2 | real | (horizontal_dimension) | kind_phys | inout | False |
trans | transpiration_flux | total plant transpiration rate | W m-2 | real | (horizontal_dimension) | kind_phys | out | False |
tsurf | surface_skin_temperature_after_iteration_over_land | surface skin temperature after iteration over land | K | real | (horizontal_dimension) | kind_phys | inout | False |
tsnow | snow_temperature_bottom_first_layer | snow temperature at the bottom of first snow layer | K | real | (horizontal_dimension) | kind_phys | inout | False |
zorl | surface_roughness_length_over_land_interstitial | surface roughness length over land (temporary use as interstitial) | cm | real | (horizontal_dimension) | kind_phys | inout | False |
sfcqc | cloud_condensed_water_mixing_ratio_at_surface | moist cloud water mixing ratio at surface | kg kg-1 | real | (horizontal_dimension) | kind_phys | inout | False |
sfcdew | surface_condensation_mass | surface condensation mass | kg m-2 | real | (horizontal_dimension) | kind_phys | inout | False |
tice | sea_ice_temperature_interstitial | sea ice surface skin temperature use as interstitial | K | real | (horizontal_dimension) | kind_phys | inout | False |
sfcqv | water_vapor_mixing_ratio_at_surface | water vapor mixing ratio at surface | kg kg-1 | real | (horizontal_dimension) | kind_phys | inout | False |
sncovr1 | surface_snow_area_fraction_over_land | surface snow area fraction | frac | real | (horizontal_dimension) | kind_phys | inout | False |
qsurf | surface_specific_humidity_over_land | surface air saturation specific humidity over land | kg kg-1 | real | (horizontal_dimension) | kind_phys | inout | False |
gflux | upward_heat_flux_in_soil_over_land | soil heat flux over land | W m-2 | real | (horizontal_dimension) | kind_phys | out | False |
drain | subsurface_runoff_flux | subsurface runoff flux | kg m-2 s-1 | real | (horizontal_dimension) | kind_phys | out | False |
evap | kinematic_surface_upward_latent_heat_flux_over_land | kinematic surface upward evaporation flux over land | kg kg-1 m s-1 | real | (horizontal_dimension) | kind_phys | out | False |
hflx | kinematic_surface_upward_sensible_heat_flux_over_land | kinematic surface upward sensible heat flux over land | K m s-1 | real | (horizontal_dimension) | kind_phys | out | False |
rhosnf | density_of_frozen_precipitation | density of frozen precipitation | kg m-3 | real | (horizontal_dimension) | kind_phys | out | False |
runof | surface_runoff_flux | surface runoff flux | kg m-2 s-1 | real | (horizontal_dimension) | kind_phys | out | False |
runoff | total_runoff | total water runoff | kg m-2 | real | (horizontal_dimension) | kind_phys | inout | False |
srunoff | surface_runoff | surface water runoff (from lsm) | kg m-2 | real | (horizontal_dimension) | kind_phys | inout | False |
chh | surface_drag_mass_flux_for_heat_and_moisture_in_air_over_land | thermal exchange coefficient over land | kg m-2 s-1 | real | (horizontal_dimension) | kind_phys | inout | False |
cmm | surface_drag_wind_speed_for_momentum_in_air_over_land | momentum exchange coefficient over land | m s-1 | real | (horizontal_dimension) | kind_phys | inout | False |
evbs | soil_upward_latent_heat_flux | soil upward latent heat flux | W m-2 | real | (horizontal_dimension) | kind_phys | out | False |
evcw | canopy_upward_latent_heat_flux | canopy upward latent heat flux | W m-2 | real | (horizontal_dimension) | kind_phys | out | False |
sbsno | snow_deposition_sublimation_upward_latent_heat_flux | latent heat flux from snow depo/subl | W m-2 | real | (horizontal_dimension) | kind_phys | out | False |
stm | soil_moisture_content | soil moisture content | kg m-2 | real | (horizontal_dimension) | kind_phys | inout | False |
wetness | normalized_soil_wetness_for_land_surface_model | normalized soil wetness | frac | real | (horizontal_dimension) | kind_phys | inout | False |
acsnow | accumulated_water_equivalent_of_frozen_precip | snow water equivalent of run-total frozen precip | kg m-2 | real | (horizontal_dimension) | kind_phys | inout | False |
snowfallac | total_accumulated_snowfall | run-total snow accumulation on the ground | kg m-2 | real | (horizontal_dimension) | kind_phys | inout | False |
flag_init | flag_for_first_time_step | flag signaling first time step for time integration loop | flag | logical | () | | in | False |
flag_restart | flag_for_restart | flag for restart (warmstart) or coldstart | flag | logical | () | | in | False |
errmsg | ccpp_error_message | error message for error handling in CCPP | none | character | () | len=* | out | False |
errflg | ccpp_error_flag | error flag for error handling in CCPP | flag | integer | () | | out | False |
|
subroutine | lsm_ruc::rucinit (restart, im, lsoil_ruc, lsoil, nlev, isot, soiltyp, vegtype, fice, land, tsurf, tsurf_wat, tg3, smc, slc, stc, smcref2, smcwlt2, lsm_ruc, lsm, zs, sh2o, smfrkeep, tslb, smois, wetness, me, master, errmsg, errflg) |
| This subroutine contains RUC LSM initialization. More...
|
|
subroutine | module_sf_ruclsm::ruclsm_soilvegparm (debug_print, MMINLURUC, MMINSL) |
| This subroutine specifies vegetation related characteristics. More...
|
|
subroutine, public | set_soilveg_ruc_mod::set_soilveg_ruc (me, isot, ivet, nlunit) |
| This subroutine specifies vegetation and soil parameters for a given soil and land-use classification. More...
|
|
subroutine, public | module_soil_pre::init_soil_depth_3 (zs, dzs, num_soil_levels) |
| This subroutine defines level depth in soil and thickness of soil layers RUC LSM. More...
|
|
subroutine, public | module_soil_pre::init_soil_3_real (tsk, tmn, smois, tslb, st_input, sm_input, landmask, sst, zs, dzs, st_levels_input, sm_levels_input, num_soil_layers, num_st_levels_input, num_sm_levels_input, num_st_levels_alloc, num_sm_levels_alloc, flag_sst, flag_soil_layers, flag_soil_levels, ids, ide, jds, jde, kds, kde, ims, ime, jms, jme, kms, kme, its, ite, jts, jte, kts, kte) |
| This subroutine initializes soil moisture and temperature at RUC vertical levels from the Noah layers. RUC has 3 levels in the top Noah layer, therefore, initialization of soil moisture at these top levels is questionable. More...
|
|
subroutine, public | module_sf_ruclsm::lsmruc ( DT, init, restart, KTAU, iter, NSL, graupelncv, snowncv, rainncv, raincv, ZS, RAINBL, SNOW, SNOWH, SNOWC, FRZFRAC, frpcpn, rhosnf, precipfr, Z3D, P8W, T3D, QV3D, QC3D, RHO3D, GLW, GSW, EMISS, CHKLOWQ, CHS, FLQC, FLHC, MAVAIL, CANWAT, VEGFRA, ALB, ZNT, Z0, SNOALB, ALBBCK, LAI, landusef, nlcat, soilctop, nscat, QSFC, QSG, QVG, QCG, DEW, SOILT1, TSNAV, TBOT, IVGTYP, ISLTYP, XLAND, ISWATER, ISICE, XICE, XICE_THRESHOLD, CP, RV, RD, G0, PI, LV, STBOLT, SOILMOIS, SH2O, SMAVAIL, SMMAX, TSO, SOILT, HFX, QFX, LH, INFILTR, RUNOFF1, RUNOFF2, ACRUNOFF, SFCEXC, SFCEVP, GRDFLX, SNOWFALLAC, ACSNOW, SNOM, SMFR3D, KEEPFR3DFLAG, myj, shdmin, shdmax, rdlai2d, ims, ime, jms, jme, kms, kme, its, ite, jts, jte, kts, kte ) |
| The RUN LSM model is described in Smirnova et al.(1997) [166] and Smirnova et al.(2000) [167]. More...
|
|
subroutine | module_sf_ruclsm::sfctmp (debug_print, delt, ktau, conflx, i, j, nzs, nddzs, nroot, meltfactor, ILAND, ISOIL, IVGTYP, ISLTYP, PRCPMS, NEWSNMS, SNWE, SNHEI, SNOWFRAC, RHOSN, RHONEWSN, RHOSNFALL, snowrat, grauprat, icerat, curat, PATM, TABS, QVATM, QCATM, rho, GLW, GSW, EMISS, QKMS, TKMS, PC, MAVAIL, CST, VEGFRA, ALB, ZNT, ALB_SNOW, ALB_SNOW_FREE, lai, MYJ, SEAICE, ISICE, QWRTZ, rhocs, dqm, qmin, ref, wilt, psis, bclh, ksat, sat, cn, zsmain, zshalf, DTDZS, DTDZS2, tbq, cp, rovcp, g0, lv, stbolt, cw, c1sn, c2sn, KQWRTZ, KICE, KWT, snweprint, snheiprint, rsm, soilm1d, ts1d, smfrkeep, keepfr, soilt, soilt1, tsnav, dew, qvg, qsg, qcg, SMELT, SNOH, SNFLX, SNOM, SNOWFALLAC, ACSNOW, edir1, ec1, ett1, eeta, qfx, hfx, s, sublim, evapl, prcpl, fltot, runoff1, runoff2, soilice, soiliqw, infiltr, smf) |
| This subroutine solves energy and moisture budgets. More...
|
|
real function | module_sf_ruclsm::qsn (TN, T) |
| This function computes water vapor mixing ratio at saturation from the precomputed table and a given temperature. More...
|
|
subroutine | module_sf_ruclsm::soil (debug_print, i, j, iland, isoil, delt, ktau, conflx, nzs, nddzs, nroot, PRCPMS, RAINF, PATM, QVATM, QCATM, GLW, GSW, GSWin, EMISS, RNET, QKMS, TKMS, PC, cst, drip, infwater, rho, vegfrac, lai, myj, QWRTZ, rhocs, dqm, qmin, ref, wilt, psis, bclh, ksat, sat, cn, zsmain, zshalf, DTDZS, DTDZS2, tbq, xlv, CP, rovcp, G0_P, cw, stbolt, TABS, KQWRTZ, KICE, KWT, soilmois, tso, smfrkeep, keepfr, dew, soilt, qvg, qsg, qcg, edir1, ec1, ett1, eeta, qfx, hfx, s, evapl, prcpl, fltot, runoff1, runoff2, mavail, soilice, soiliqw, infiltrp, smf) |
| This subroutine calculates energy and moisture budget for vegetated surfaces without snow, heat diffusion and Richards eqns in soil. More...
|
|
subroutine | module_sf_ruclsm::sice (debug_print, i, j, iland, isoil, delt, ktau, conflx, nzs, nddzs, nroot, PRCPMS, RAINF, PATM, QVATM, QCATM, GLW, GSW, EMISS, RNET, QKMS, TKMS, rho, myj, tice, rhosice, capice, thdifice, zsmain, zshalf, DTDZS, DTDZS2, tbq, xlv, CP, rovcp, cw, stbolt, tabs, tso, dew, soilt, qvg, qsg, qcg, eeta, qfx, hfx, s, evapl, prcpl, fltot ) |
| This subroutine is called for sea ice without accumulated snow on its surface. it solves heat diffusion inside ice and energy budget at the surface of ice. It computes skin temperature and temerature inside sea ice. More...
|
|
subroutine | module_sf_ruclsm::snowsoil (debug_print, i, j, isoil, delt, ktau, conflx, nzs, nddzs, nroot, meltfactor, rhonewsn, SNHEI_CRIT, ILAND, PRCPMS, RAINF, NEWSNOW, snhei, SNWE, SNOWFRAC, RHOSN, PATM, QVATM, QCATM, GLW, GSW, GSWin, EMISS, RNET, IVGTYP, QKMS, TKMS, PC, cst, drip, infwater, rho, vegfrac, alb, znt, lai, MYJ, QWRTZ, rhocs, dqm, qmin, ref, wilt, psis, bclh, ksat, sat, cn, zsmain, zshalf, DTDZS, DTDZS2, tbq, xlv, CP, rovcp, G0_P, cw, stbolt, TABS, KQWRTZ, KICE, KWT, ilnb, snweprint, snheiprint, rsm, soilmois, tso, smfrkeep, keepfr, dew, soilt, soilt1, tsnav, qvg, qsg, qcg, SMELT, SNOH, SNFLX, SNOM, edir1, ec1, ett1, eeta, qfx, hfx, s, sublim, prcpl, fltot, runoff1, runoff2, mavail, soilice, soiliqw, infiltrp ) |
| This subroutine is called for snow covered areas of land. It solves energy and moisture budgets on the surface of snow, and on the interface of snow and soil. It computes skin temperature, snow temperature, snow depth and snow melt. More...
|
|
subroutine | module_sf_ruclsm::snowseaice (debug_print, i, j, isoil, delt, ktau, conflx, nzs, nddzs, meltfactor, rhonewsn, SNHEI_CRIT, ILAND, PRCPMS, RAINF, NEWSNOW, snhei, SNWE, snowfrac, RHOSN, PATM, QVATM, QCATM, GLW, GSW, EMISS, RNET, QKMS, TKMS, RHO, myj, ALB, ZNT, tice, rhosice, capice, thdifice, zsmain, zshalf, DTDZS, DTDZS2, tbq, xlv, CP, rovcp, cw, stbolt, tabs, ilnb, snweprint, snheiprint, rsm, tso, dew, soilt, soilt1, tsnav, qvg, qsg, qcg, SMELT, SNOH, SNFLX, SNOM, eeta, qfx, hfx, s, sublim, prcpl, fltot ) |
| This subroutine is called for sea ice with accumulated snow on its surface. It solves energy budget on the snow interface with atmosphere and snow interface with ice. It calculates skin temperature, snow and ice temperatures, snow depth and snow melt. More...
|
|
subroutine | module_sf_ruclsm::soiltemp (debug_print, i, j, iland, isoil, delt, ktau, conflx, nzs, nddzs, nroot, PRCPMS, RAINF, PATM, TABS, QVATM, QCATM, EMISS, RNET, QKMS, TKMS, PC, RHO, VEGFRAC, lai, THDIF, CAP, DRYCAN, WETCAN, TRANSUM, DEW, MAVAIL, soilres, alfa, DQM, QMIN, BCLH, ZSMAIN, ZSHALF, DTDZS, TBQ, XLV, CP, G0_P, CVW, STBOLT, TSO, SOILT, QVG, QSG, QCG, X) |
| This subroutine solves energy budget equation and heat diffusion equation. More...
|
|
subroutine | module_sf_ruclsm::snowtemp (debug_print, i, j, iland, isoil, delt, ktau, conflx, nzs, nddzs, nroot, snwe, snwepr, snhei, newsnow, snowfrac, beta, deltsn, snth, rhosn, rhonewsn, meltfactor, PRCPMS, RAINF, PATM, TABS, QVATM, QCATM, GLW, GSW, EMISS, RNET, QKMS, TKMS, PC, RHO, VEGFRAC, THDIF, CAP, DRYCAN, WETCAN, CST, TRANF, TRANSUM, DEW, MAVAIL, DQM, QMIN, PSIS, BCLH, ZSMAIN, ZSHALF, DTDZS, TBQ, XLVM, CP, rovcp, G0_P, CVW, STBOLT, SNWEPRINT, SNHEIPRINT, RSM, TSO, SOILT, SOILT1, TSNAV, QVG, QSG, QCG, SMELT, SNOH, SNFLX, S, ILNB, X) |
| This subroutine solves energy bugdget equation and heat diffusion equation to obtain snow and soil temperatures. More...
|
|
subroutine | module_sf_ruclsm::soilmoist (debug_print, DELT, NZS, NDDZS, DTDZS, DTDZS2, RIW, ZSMAIN, ZSHALF, DIFFU, HYDRO, QSG, QVG, QCG, QCATM, QVATM, PRCP, QKMS, TRANSP, DRIP, DEW, SMELT, SOILICE, VEGFRAC, SNOWFRAC, soilres, DQM, QMIN, REF, KSAT, RAS, INFMAX, SOILMOIS, SOILIQW, MAVAIL, RUNOFF, RUNOFF2, INFILTRP) |
| This subroutine solves moisture budget and computes soil moisture and surface and sub-surface runoffs. More...
|
|
subroutine | module_sf_ruclsm::soilprop (debug_print, nzs, fwsat, lwsat, tav, keepfr, soilmois, soiliqw, soilice, soilmoism, soiliqwm, soilicem, QWRTZ, rhocs, dqm, qmin, psis, bclh, ksat, riw, xlmelt, CP, G0_P, cvw, ci, kqwrtz, kice, kwt, thdif, diffu, hydro, cap) |
| This subroutine computes thermal diffusivity, and diffusional and hydraulic condeuctivities in soil. More...
|
|
subroutine | module_sf_ruclsm::transf (debug_print, nzs, nroot, soiliqw, tabs, lai, gswin, dqm, qmin, ref, wilt, zshalf, pc, iland, tranf, transum) |
| This subroutine solves the transpiration function (EQs. 18,19 in Smirnova et al.(1997) [166]) More...
|
|
subroutine | module_sf_ruclsm::vilka (TN, D1, D2, PP, QS, TS, TT, NSTEP, ii, j, iland, isoil) |
| This subroutine finds the solution of energy budget at the surface from the pre-computed table of saturated water vapor mixing ratio and estimated surface temperature. More...
|
|
subroutine | module_sf_ruclsm::soilvegin (debug_print, soilfrac, nscat, shdmin, shdmax, mosaic_lu, mosaic_soil, NLCAT, IVGTYP, ISLTYP, iswater, MYJ, IFOREST, lufrac, vegfrac, EMISS, PC, ZNT, LAI, RDLAI2D, QWRTZ, RHOCS, BCLH, DQM, KSAT, PSIS, QMIN, REF, WILT, I, J) |
| This subroutine computes effective land and soil parameters in the grid cell from the weighted contribution of soil and land categories represented in the grid cell. More...
|
|
subroutine, public | module_sf_ruclsm::ruclsminit (debug_print, landmask, nzs, isltyp, ivgtyp, xice, mavail, sh2o, smfr3d, tslb, smois, ims, ime, jms, jme, kms, kme, its, ite, jts, jte, kts, kte ) |
| This subroutine computes liquid and forezen soil moisture from the total soil moisture, and also computes soil moisture availability in the top soil layer. More...
|
|
subroutine | module_sf_ruclsm::soilin (ISLTYP, DQM, REF, PSIS, QMIN, BCLH) |
| This subroutine specifies 19 soiltyp classification according to STATSGO. More...
|
|
real function, public | module_sf_ruclsm::rslf (P, T) |
| This function calculates the liquid saturation vapor mixing ratio as a function of temperature and pressure (from Thompson scheme). More...
|
|