Version 183 (modified by raasch, 13 years ago) (diff) |
---|
Initialization parameters ¶
TracNav
Core Parameters
Module Parameters
- Agent system
- Aerosol (Salsa)
- Biometeorology
- Bulk cloud physics
- Chemistry
- FASTv8
- Indoor climate
- Land surface
- Nesting
- Nesting (offline)
- Ocean
- Particles
- Plant canopy
- Radiation
- Spectra
- Surface output
- Synthetic turbulence
- Turbulent inflow
- Urban surface
- User-defined
- Virtual flights
- Virtual measurements
- Wind turbine
- Alphabetical list (outdated!)
Mode ¶
Grid ¶
Numerics ¶
Physics ¶
Boundary conditions ¶
Initialization ¶
Topography ¶
Canopy ¶
Cloud physics ¶
Others ¶
NAMELIST group name: inipar ¶
Mode: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
cloud_droplets ¶ | L | .F. |
Parameter to switch on usage of cloud droplets. |
cloud_physics ¶ | L | .F. |
Parameter to switch on the condensation scheme. |
conserve_volume_flow ¶ | L | .F. |
Conservation of volume flow in x- and y-direction. |
conserve_volume_flow_mode ¶ | C*16 | 'default' |
Modus of volume flow conservation.
'initial_profiles'
'inflow_profile'
'bulk_velocity'
Note that conserve_volume_flow_mode only comes into effect if conserve_volume_flow = .T.. |
coupling_start_time ¶ | R | 0.0 |
Simulation time of precursor run. |
dp_external ¶ | L | .F. |
External pressure gradient switch. |
dp_smooth ¶ | L | .F. |
Vertically smooth the external pressure gradient using a sinusoidal smoothing function. |
dp_level_b ¶ | R | 0.0 |
Lower limit of the vertical range for which the external pressure gradient is applied (in m). |
dpdxy ¶ | R(2) | 2 * 0.0 |
Values of the external pressure gradient applied in x- and y-direction, respectively (in Pa/m). |
e_init ¶ | R | 0.0 |
Initial subgrid-scale TKE in m2s-2. |
e_min ¶ | R | 0.0 |
Minimum subgrid-scale TKE in m2s-2. |
galilei_transformation ¶ | L | .F. |
Application of a Galilei-transformation to the coordinate system of the model. |
humidity ¶ | L | .F. |
Parameter to switch on the prognostic equation for specific humidity q. |
km_constant ¶ | R | variable (computed from TKE) |
Constant eddy diffusivities are used (laminar simulations). |
neutral ¶ | L | .F. | Parameter to switch off calculation of temperature equation.
For simulating flows with pure neutral stratification, solution of the temperature equation can be switched off with neutral = .T. in order to save cpu-time. Additionally, this will also switch off calculation of all buoyancy related terms. |
ocean ¶ | L | .F. |
Parameter to switch on ocean runs.
Relevant parameters to be exclusively used for steering ocean runs are bc_sa_t, bottom_salinityflux, sa_surface, sa_vertical_gradient, sa_vertical_gradient_level, and top_salinityflux. |
passive_scalar ¶ | L | .F. |
Parameter to switch on the prognostic equation for a passive scalar. |
precipitation ¶ | L | .F. |
Parameter to switch on the precipitation scheme. |
radiation ¶ | L | .F. |
Parameter to switch on longwave radiation cooling at cloud-tops. |
random_heatflux ¶ | L | .F. |
Parameter to impose random perturbations on the internal two-dimensional near surface heat flux field shf. |
subs_vertical_gradient ¶ | R(10) | 10 * 0.0 |
Gradient(s) of the profile for the large scale subsidence/ascent velocity (in (m/s) / 100 m).
That defines the subsidence/ascent profile to be linear up to z = 1000.0 m with a surface value of 0 m/s. Due to the gradient of -0.002 (m/s) / 100 m the subsidence velocity has a value of -0.02 m/s in z = 1000.0 m. For z > 1000.0 m up to the top boundary the gradient is 0.0 (m/s) / 100 m (it is assumed that the assigned height levels correspond with uv levels). This results in a subsidence velocity of -0.02 m/s at the top boundary. |
subs_vertical_gradient_level ¶ | R(10) | 10 * 0.0 |
Height level from which on the gradient for the subsidence/ascent velocity defined by subs_vertical_gradient is effective (in m). |
u_bulk ¶ | R | 0.0 |
u-component of the predefined bulk velocity (in m/s). |
use_ug_for_galilei_tr ¶ | L | .T. |
Switch to determine the translation velocity in case that a Galilean transformation is used. |
v_bulk ¶ | R | 0.0 |
v-component of the predefined bulk velocity (in m/s). |
Grid: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
dx ¶ | R | 1.0 |
Horizontal grid spacing along the x-direction (in m). |
dy ¶ | R | 1.0 |
Horizontal grid spacing along the y-direction (in m). |
dz ¶ | R |
Vertical grid spacing (in m).
The w-levels lie half between them:
| |
dz_max ¶ | R | 9999999.9 |
Allowed maximum vertical grid spacing (in m). |
dz_stretch_factor ¶ | R | 1.08 |
Stretch factor for a vertically stretched grid (see dz_stretch_level). |
dz_stretch_level ¶ | R | 100000.0 |
Height level above/below which the grid is to be stretched vertically (in m).
and used as spacings for the scalar levels (zu). The w-levels are then defined as:
For ocean = .T., dz_stretch_level is the height level (in m, negative) below which the grid is to be stretched vertically. The vertical grid spacings dz below this level are calculated correspondingly as
|
nx ¶ | I |
Number of grid points in x-direction. | |
ny ¶ | I |
Number of grid points in y-direction. | |
nz ¶ | I |
Number of grid points in z-direction. | |
nz_do3d ¶ | I | nz+1 |
Limits the output of 3d volume data along the vertical direction (grid point index k). |
Numerics: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
call_psolver_at_all_substeps ¶ | L | .T. |
Switch to steer the call of the pressure solver. |
cfl_factor ¶ | R | 0.1, 0.8 or 0.9 (see right) |
Time step limiting factor. |
collective_wait ¶ | L | see right |
Set barriers in front of collective MPI operations. |
cycle_mg ¶ | C*1 | 'w' |
Type of cycle to be used with the multi-grid method. |
fft_method ¶ | C*20 | 'system-specific' |
FFT-method to be used. |
loop_optimization ¶ | C*16 | see right |
Method used to optimize loops for solving the prognostic equations. |
masking_method ¶ | L | .F. |
Switch for topography boundary conditions in multigrid solver. |
mg_cycles ¶ | I | -1 |
Number of cycles to be used with the multi-grid scheme. |
mg_switch_to_pe0_level ¶ | I |
Grid level at which data shall be gathered on PE0. | |
momentum_advec ¶ | C*10 | 'ws-scheme' |
Advection scheme to be used for the momentum equations.
Note: Due to the larger stencil of this scheme vertical grid stretching should be handled with care. The computation of turbulent fluxes takes place inside the advection routines to get a statistical evaluation consistent to the numerical solution.
Important: The number of ghost layers for 2d and 3d arrays changed. This affects also the user interface. Please adapt the allocation of 2d and 3d arrays in your user interface like here. Furthermore the exchange of ghost layers for 3d variables changed, so calls of exchange_horiz in the user interface have to be modified. Here an example for the u-component of the velocity: CALL exchange_horiz( u , nbgp ).
|
ngsrb ¶ | I | 2 |
Number of Gauss-Seidel iterations to be carried out on each grid level of the multigrid Poisson solver. |
nsor ¶ | I | 20 |
Number of iterations to be used with the SOR-scheme. |
nsor_ini ¶ | I | 100 |
Initial number of iterations with the SOR algorithm. |
omega_sor ¶ | R | 1.8 |
Convergence factor to be used with the the SOR-scheme. |
psolver ¶ | C*10 | 'poisfft' |
Scheme to be used to solve the Poisson equation for the perturbation pressure.
'poisfft_hybrid'
'multigrid'
'sor'
|
pt_damping_factor ¶ | R | 0.0 |
Factor for damping the potential temperature. This method effectively damps gravity waves at the inflow boundary in case of non-cyclic lateral boundary conditions (see bc_lr or bc_ns). If the damping factor is too low, gravity waves can develop within the damping domain and if the damping factor is too high, gravity waves can develop in front of the damping domain. |
pt_damping_width ¶ | R | 0.0 |
Width of the damping domain of the potential temperature (in m). |
pt_reference ¶ | R | use horizontal average as reference |
Reference temperature to be used in all buoyancy terms (in K). |
random_generator ¶ | C*20 |
'numerical |
Random number generator to be used for creating uniformly distributed random numbers. |
rayleigh_damping_factor ¶ | R | 0.0 or 0.01 |
Factor for Rayleigh damping. |
rayleigh_damping_height ¶ | R |
2/3*zu(nz) |
Height above (ocean: below) which the Rayleigh damping starts (in m). |
residual_limit ¶ | R | 1.0E-4 |
Largest residual permitted for the multi-grid scheme (in s-2m-3). |
scalar_advec ¶ | C*10 | 'ws-scheme' |
Advection scheme to be used for the scalar quantities.
Note: Due to the larger stencil of this scheme vertical grid stretching should be handled with care. The computation of turbulent fluxes takes place inside the advection routines to get a statistical evaluation consistent to the numerical solution.
Important: The number of ghost layers for 2d and 3d arrays changed. This affects also the user interface. Please adapt the allocation of 2d and 3d arrays in your user interface like here. Furthermore the exchange of ghost layers for 3d variables changed, so calls of exchange_horiz in the user interface have to be modified. Here an example for the potential temperature: CALL exchange_horiz( pt , nbgp ).
'bc-scheme'
A differing advection scheme can be chosen for the subgrid-scale TKE using parameter use_upstream_for_tke. |
scalar_rayleigh_damping ¶ | L | .T. |
Application of Rayleigh damping to scalars. |
timestep_scheme ¶ | C*20 |
'runge |
Time step scheme to be used for the integration of the prognostic variables.
'runge-kutta-2'
'euler'
A differing timestep scheme can be chosen for the subgrid-scale TKE using parameter use_upstream_for_tke. |
use_upstream_for_tke ¶ | L | .F. |
Parameter to choose the advection/timestep scheme to be used for the subgrid-scale TKE. |
Physics: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
omega ¶ | R | 7.29212E-5 |
Angular velocity of the rotating system (in rad/s).
|
phi ¶ | R | 55.0 |
Geographical latitude (in degrees). |
prandtl_number ¶ | R | 1.0 |
Ratio of the eddy diffusivities for momentum and heat (Km/Kh). |
Boundary conditions: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
bc_e_b ¶ | C*20 | 'neumann' |
Bottom boundary condition of the TKE. |
bc_lr ¶ | C*20 | 'cyclic' |
Boundary condition along x (for all quantities). |
bc_ns ¶ | C*20 | 'cyclic' |
Boundary condition along y (for all quantities). |
bc_p_b ¶ | C*20 | 'neumann' |
Bottom boundary condition of the perturbation pressure. |
bc_p_t ¶ | C*20 | 'dirichlet' |
Top boundary condition of the perturbation pressure. |
bc_pt_b ¶ | C*20 | 'dirichlet' |
Bottom boundary condition of the potential temperature. |
bc_pt_t ¶ | C*20 | 'initial_gradient' |
Top boundary condition of the potential temperature.
(up to k=nz the prognostic equation for the temperature is solved). When a constant sensible heat flux is used at the top boundary (top_heatflux), bc_pt_t = 'neumann' must be used, because otherwise the resolved scale may contribute to the top flux so that a constant value cannot be guaranteed. |
bc_q_b ¶ | C*20 | 'dirichlet' |
Bottom boundary condition of the specific humidity / total water content. |
bc_q_t ¶ | C*20 | 'neumann' |
Top boundary condition of the specific humidity / total water content.
(up tp k=nz the prognostic equation for q is solved). |
bc_s_b ¶ | C*20 | 'dirichlet' |
Bottom boundary condition of the scalar concentration. |
bc_s_t ¶ | C*20 | 'neumann' |
Top boundary condition of the scalar concentration.
(up to k=nz the prognostic equation for the scalar concentration is solved). |
bc_sa_t ¶ | C*20 | 'neumann' |
Top boundary condition of the salinity. |
bc_uv_b ¶ | C*20 | 'dirichlet' |
Bottom boundary condition of the horizontal velocity components u and v.
The Neumann boundary condition yields the free-slip condition with u(k=0) = u(k=1) and v(k=0) = v(k=1). With Prandtl - layer switched on (see prandtl_layer), the free-slip condition is not allowed (otherwise the run will be terminated). |
bc_uv_t ¶ | C*20 | 'dirichlet' |
Top boundary condition of the horizontal velocity components u and v. In the coupled ocean executable, bc_uv_t is internally set ('neumann') and does not need to be prescribed. |
bottom_salinityflux ¶ | R | 0.0 |
Kinematic salinity flux near the surface (in psu m/s). |
inflow_damping_height ¶ | R | from precursor run |
Height below which the turbulence signal is used for turbulence recycling (in m). |
inflow_damping_width ¶ | R |
0.1 * inflow_damping |
Transition range within which the turbulance signal is damped to zero (in m). |
inflow_disturbance_begin ¶ | I |
Lower limit of the horizontal range for which random perturbations are to be imposed on the horizontal velocity field (gridpoints). | |
inflow_disturbance_end ¶ | I |
Upper limit of the horizontal range for which random perturbations are to be imposed on the horizontal velocity field (gridpoints). | |
prandtl_layer ¶ | L | .T. |
Parameter to switch on a Prandtl layer. |
recycling_width ¶ | R |
Distance of the recycling plane from the inflow boundary (in m). | |
rif_max ¶ | R | 1.0 |
Upper limit of the flux-Richardson number. |
rif_min ¶ | R | -5.0 |
Lower limit of the flux-Richardson number. |
roughness_length ¶ | R | 0.1 |
Roughness length (in m). |
sa_vertical_gradient ¶ | R(10) | 10 * 0.0 |
Salinity gradient(s) of the initial salinity profile (in psu / 100 m).
That defines the salinity to be constant down to z = -500.0 m with a salinity given by sa_surface. For -500.0 m < z <= -1000.0 m the salinity gradient is 1.0 psu / 100 m and for z < -1000.0 m down to the bottom boundary it is 0.5 psu / 100 m (it is assumed that the assigned height levels correspond with uv levels). |
sa_vertical_gradient_level ¶ | R(10) | 10 * 0.0 |
Height level from which on the salinity gradient defined by sa_vertical_gradient is effective (in m). |
surface_heatflux ¶ | R |
no prescribed |
Kinematic sensible heat flux at the bottom surface (in K m/s). |
surface_scalarflux ¶ | R |
no prescribed |
Scalar flux at the surface (in kg/(m2 s)). |
surface_waterflux ¶ | R |
no prescribed |
Kinematic water flux near the surface (in m/s). |
top_heatflux ¶ | R |
no prescribed |
Kinematic sensible heat flux at the top boundary (in K m/s). |
top_momentumflux_u ¶ | R |
no prescribed |
Momentum flux along x at the top boundary (in m2/s2). |
top_momentumflux_v ¶ | R |
no prescribed |
Momentum flux along y at the top boundary (in m2/s2). |
top_salinityflux ¶ | R |
no prescribed |
Kinematic salinity flux at the top boundary, i.e. the sea surface (in psu m/s). |
turbulent_inflow ¶ | L | .F. |
Generates a turbulent inflow at side boundaries using a turbulence recycling method. |
use_surface_fluxes ¶ | L | .F. |
Parameter to steer the treatment of the subgrid-scale vertical fluxes within the diffusion terms at k=1 (bottom boundary). |
use_top_fluxes ¶ | L | .F. |
Parameter to steer the treatment of the subgrid-scale vertical fluxes within the diffusion terms at k=nz (top boundary). |
wall_adjustment ¶ | L | .T. |
Parameter to restrict the mixing length in the vicinity of the bottom boundary (and near vertical walls of a non-flat topography). |
z0h_factor ¶ | R | 1.0 |
Factor for calculating the roughness length for scalars.
This parameter is effective only in case that a Prandtl layer is switched on (see prandtl_layer). |
Initialization: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
damp_level_1d ¶ | R | zu(nz+1) |
Height where the damping layer begins in the 1d-model (in m). |
dissipation_1d ¶ | C*20 | 'as_in_3d_model' |
Calculation method for the energy dissipation term in the TKE equation of the 1d-model. |
dt ¶ | R | variable |
Time step for the 3d-model (in s).
the simulation will be aborted. Such situations usually arise in case of any numerical problem / instability which causes a non-realistic increase of the wind speed. |
dt_pr_1d ¶ | R | 9999999.9 |
Temporal interval of vertical profile output of the 1d-model (in s). |
dt_run_control_1d ¶ | R | 60.0 |
Temporal interval of runtime control output of the 1d-model (in s). |
end_time_1d ¶ | R | 864000.0 |
Time to be simulated for the 1d-model (in s). |
initializing_actions ¶ | C*100 |
Initialization actions to be carried out.
Instead of using the geostrophic wind for constructing the initial u,v-profiles, these profiles can also be directly set using parameters u_profile, v_profile, and uv_heights, e.g. if observed profiles shall be used as initial values. In runs with non-cyclic horizontal boundary conditions these profiles are also used as fixed mean inflow profiles.
'by_user'
'initialize_vortex'
'initialize_ptanom'
'cyclic_fill'
Values may be combined, e.g. initializing_actions = 'set_constant_profiles initialize_vortex' , but the values of 'set_constant_profiles' , 'set_1d-model_profiles' , and 'by_user' must not be given at the same time. | |
mixing_length_1d ¶ | C*20 | 'as_in_3d_model' |
Mixing length used in the 1d-model. |
pt_surface ¶ | R | 300.0 |
Surface potential temperature (in K). |
pt_surface_initial_change ¶ | R | 0.0 |
Change in surface temperature to be made at the beginning of the 3d run (in K). |
pt_vertical_gradient ¶ | R(10) | 10*0.0 |
Temperature gradient(s) of the initial temperature profile (in K / 100 m).
That defines the temperature profile to be neutrally stratified up to z = 500.0 m with a temperature given by pt_surface. For 500.0 m < z <= 1000.0 m the temperature gradient is 1.0 K / 100 m and for z > 1000.0 m up to the top boundary it is 0.5 K / 100 m (it is assumed that the assigned height levels correspond with uv levels). |
pt_vertical_gradient_level ¶ | R(10) | 10*0.0 |
Height level from which on the temperature gradient defined by pt_vertical_gradient is effective (in m). |
q_surface ¶ | R | 0.0 |
Surface specific humidity / total water content (kg/kg). |
q_surface_initial_change ¶ | R | 0.0 |
Change in surface specific humidity / total water content to be made at the beginning of the 3d run (kg/kg). |
q_vertical_gradient ¶ | R(10) | 10 * 0.0 |
Humidity gradient(s) of the initial humidity profile (in 1/100 m).
That defines the humidity to be constant with height up to z = 500.0 m with a value given by q_surface. For 500.0 m < z <= 1000.0 m the humidity gradient is 0.001 / 100 m and for z > 1000.0 m up to the top boundary it is 0.0005 / 100 m (it is assumed that the assigned height levels correspond with uv levels). |
q_vertical_gradient_level ¶ | R(10) | 10 * 0.0 |
Height level from which on the humidity gradient defined by q_vertical_gradient is effective (in m). |
sa_surface ¶ | R | 35.0 |
Surface salinity (in psu). |
surface_pressure ¶ | R | 1013.25 |
Atmospheric pressure at the surface (in hPa). |
s_surface ¶ | R | 0.0 |
Surface value of the passive scalar (in kg/m3). |
s_surface_initial_change ¶ | R | 0.0 |
Change in surface scalar concentration to be made at the beginning of the 3d run (in kg/m3). |
s_vertical_gradient ¶ | R(10) | 10 * 0.0 |
Scalar concentration gradient(s) of the initial scalar concentration profile (in kg/m3 / 100 m).
That defines the scalar concentration to be constant with height up to z = 500.0 m with a value given by. For 500.0 m < z <= 1000.0 m the scalar gradient is 0.1 kg/m3 / 100 m and for z > 1000.0 m up to the top boundary it is 0.05 kg/m3 / 100 m (it is assumed that the assigned height levels correspond with uv levels). |
s_vertical_gradient_level ¶ | R(10) | 10 * 0.0 |
Height level from which on the scalar gradient defined by s_vertical_gradient is effective (in m). |
u_profile ¶ | R(100) | 100 * 9999999.9 |
Values of u-velocity component to be used as initial profile (in m/s). |
ug_surface ¶ | R | 0.0 |
u-component of the geostrophic wind at the surface (in m/s). |
ug_vertical_gradient ¶ | R(10) | 10 * 0.0 |
Gradient(s) of the initial profile of the u-component of the geostrophic wind (in 1/100s). |
ug_vertical_gradient_level ¶ | R(10) | 10 * 0.0 |
Height level from which on the gradient defined by ug_vertical_gradient is effective (in m). |
uv_heights ¶ | R(100) | 100 * 9999999.9 | Height levels in ascending order (in m), for which prescribed u,v-velocities are given (see u_profile, v_profile. The first height level must always be zero, i.e. uv_heights(1) = 0.0. |
v_profile ¶ | R(100) | 100 * 9999999.9 |
Values of v-velocity component to be used as initial profile (in m/s). |
vg_surface ¶ | R | 0.0 |
v-component of the geostrophic wind at the surface (in m/s). |
vg_vertical_gradient ¶ | R(10) | 10 * 0.0 |
Gradient(s) of the initial profile of the v-component of the geostrophic wind (in 1/100s). |
vg_vertical_gradient_level ¶ | R(10) | 10 * 0.0 |
Height level from which on the gradient defined by vg_vertical_gradient is effective (in m). |
Topography: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
building_height ¶ | R | 50.0 |
Height of a single building in m. |
building_length_x ¶ | R | 50.0 |
Width of a single building in m. |
building_length_y ¶ | R | 50.0 |
Depth of a single building in m. |
building_wall_left ¶ | R | building centered in x-direction |
x-coordinate of the left building wall (distance between the left building wall and the left border of the model domain) in m. |
building_wall_south ¶ | R | building centered in y-direction |
y-coordinate of the South building wall (distance between the South building wall and the South border of the model domain) in m. |
canyon_height ¶ | R | 50.0 |
Street canyon height in m. |
canyon_width_x ¶ | R | 9999999.9 |
Street canyon width in x-direction in m. |
canyon_width_y ¶ | R | 9999999.9 |
Street canyon width in y-direction in m. |
canyon_wall_left ¶ | R | canyon centered in x-direction |
x-coordinate of the left canyon wall (distance between the left canyon wall and the left border of the model domain) in m. |
canyon_wall_south ¶ | R | canyon centered in y-direction |
y-coordinate of the South canyon wall (distance between the South canyon wall and the South border of the model domain) in m. |
topography ¶ | C*40 | 'flat' |
Topography mode.
'single_building'
'single_street_canyon'
'read_from_file'
Alternatively, the user may add code to the user interface subroutine user_init_grid to allow further topography modes. These require to explicitly set the topography_grid_convention to either 'cell_edge' or 'cell_center' . |
topography_grid_convention ¶ | C*11 | default depends on value of topography; see text for details |
Convention for defining the topography grid.
'cell_center'
The example files example_topo_file and example_building in trunk/EXAMPLES/ illustrate the difference between both approaches. Both examples simulate a single building and yield the same results. The former uses a rastered topography input file with 'cell_center' convention, the latter applies a generic topography with 'cell_edge' convention.
This means that
|
wall_heatflux ¶ | R(5) | 5 * 0.0 |
Prescribed kinematic sensible heat flux in K m/s at the five topography faces: |
wall_humidityflux ¶ | R(5) | 5 * 0.0 |
Prescribed kinematic humidity flux in m/s at the five topography faces: |
wall_scalarflux ¶ | R(5) | 5 * 0.0 |
Prescribed scalar flux in kg/(m2 s) at the five topography faces: |
Canopy: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
canopy_mode ¶ | C*20 | 'block' |
Canopy mode. |
cthf ¶ | R | 0.0 |
Average heat flux that is prescribed at the top of the plant canopy. |
drag_coefficient ¶ | R | 0.0 |
Drag coefficient used in the plant_canopy_model. |
lad_surface ¶ | R | 0.0 |
Surface value of the leaf area density (in m2/m3). |
lad_vertical_gradient ¶ | R(10) | 10 * 0.0 |
Gradient(s) of the leaf area density (in m2/m4). |
lad_vertical_gradient_level ¶ | R(10) | 10 * 0.0 |
Height level from which on the gradient of the leaf area density defined by lad_vertical_gradient is effective (in m). |
leaf_surface_concentration ¶ | R | 0.0 |
Concentration of a passive scalar at the surface of a leaf (in K m/s). |
pch_index ¶ | I | 0 |
Grid point index (scalar) of the upper boundary of the plant canopy layer. |
plant_canopy ¶ | L | .F. |
Switch for the plant canopy model. |
scalar_exchange_coefficient ¶ | R | 0.0 |
Scalar exchange coefficient for a leaf (dimensionless). |
Cloud physics: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
curvature_solution_effects ¶ | L | .F. | Parameter to consider solution and curvature effects on the equilibrium vapor pressure of cloud droplets.
This parameter only comes into effect if Lagrangian cloud droplets are used (see cloud_droplets) and if the droplet radius is smaller than 1.0E-6 m. In case of curvature_solution_effects = .T., solution and curvature effects are included in the growth equation of droplets by condensation. Since in this case the growth equation is a stiff o.d.e, it is integrated in time using the Rosenbrock method (see Numerical Recipes in FORTRAN, 2nd Edition, p.731). If the droplet radius is larger or equal 1.0E-6 m, solution and curvature effects are neglected and the growth is calculated by a simple analytic formula (as for curvature_solution_effects = .F.). |
Others: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
alpha_surface ¶ | R | 0.0 |
Inclination of the model domain with respect to the horizontal (in degrees). |
statistic_regions ¶ | I | 0 |
Number of additional user-defined subdomains for which statistical analysis and corresponding output (profiles, time series) shall be made. |
Attachments (1)
-
y_shift_pic.png
(20.4 KB) -
added by sward 7 years ago.
picture for description of y_shift feature
Download all attachments as: .zip