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 ¶
Others ¶
NAMELIST group name: initialization_parameters ¶
Mode: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
approximation ¶ | C*20 | 'boussinesq' |
Parameter to choose the approximation of the model equations. Currently two approximations are available:
'anelastic'
Note, that the default flux representation for input and output depends on the approximation. For details, please see flux_input_mode and flux_output_mode. |
check_realistic_q ¶ | L | .T. | Parameter to switch on/off check if simulation is allowed to start with supersaturated environment. |
cloud_droplets ¶ | L | .F. |
Parameter to switch on the Lagrangian cloud model (LCM). |
conserve_volume_flow ¶ | L | .F. |
Conservation of volume flow in x- and y-direction. In case of non-cyclic lateral boundary conditions, detailed information about the conservation of volume flow can be found in the documentation. |
conserve_volume_flow_mode ¶ | C*16 | 'default' |
Mode of volume flow conservation.
'initial_profiles'
'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. |
flux_input_mode ¶ | C*40 | 'application-specific' |
Parameter to choose the flux unit for input data. Currently three choices are available:
'dynamic'
'application-specific'
|
flux_output_mode ¶ | C*40 | 'application-specific' |
Parameter to choose the flux unit for output data. Currently three choices are available:
'dynamic'
'application-specific'
|
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 the water vapor mixing ratio q. |
km_constant ¶ | R | variable (computed from TKE) |
Constant eddy diffusivities are used (laminar simulations). |
large_scale_forcing ¶ | L | .F. |
Parameter to choose large-scale forcing from an external file. By means of large_scale_forcing = .T. the time-dependent surface heat flux shf, surface water flux qsws, surface temperature pt_surface, surface humidity and surface pressure surface_pressure as well as vertical profiles of the geostrophic wind components ug and vg, the large-scale vertical subsidence profile w_subs, the horizontal large-scale advection tendencies of temperature td_lsa_thetal and humidity td_lsa_q and the large-scale subsidence tendencies of temperature td_sub_thetal and humidity td_sub_q are provided in the simulation. An example can be found here.
large_scale_forcing = .T. requires humidity = .T.. It is not implemented for the ocean mode, and it does also not work for non-cyclic lateral boundary conditions and non-flat topography. It is possible to drive the simulations either by means of surface fluxes or by means of prescribed surface values for temperature and humidity.
If large_scale_forcing = .T., the input file LSF_DATA is required. This file has to contain two kinds of information: time-dependent surface values and time-dependent profile information which can be provided by measurements or larger scale models. In case large-scale forcing shall be used without nudging (nudging = .F.) initial profiles of potential temperature, humidity, and horizontal wind components have to be provided by means of pt_surface, pt_vertical_gradient, pt_vertical_gradient_level and so forth. |
large_scale_subsidence ¶ | L | .F. |
Parameter to enable large-scale subsidence/ascent for atmospheric simulations. With large_scale_subsidence = .T., an additional tendency term, tend_subs, is calculated for the scalar quantities, e.g. for potential temperature it is tend_subs(k,j,i) = - w_subs(k)* dpt(k,j,i) / dz.
The profile for the subsidence velocity w_subs can either be set via subs_vertical_gradient and subs_vertical_gradient_level or by reading it from the large-scale forcing data set LSF_DATA. If use_subsidence_tendencies is set to .T., the subsidence velocity w_subs is not used. Instead, subsidence tendencies for temperature and humidity are read in from the large-scale forcing data set LSF_DATA and applied to the prognostic variables in the subroutine ls_advec.
large_scale_subsidence is not implemented for the ocean mode.
Attention:
Important: |
lsf_exception ¶ | L | .F. |
Parameter to explicitly allow large-scale forcing in case of topography /= 'flat' . So far, large_scale_forcing is not implemented to be used together with topography. However, in case of simulating moderately tall buildings on otherwise flat terrain, the user might choose to nevertheless apply large_scale_forcing. This can be done by setting lsf_exception = .T..
Attention: |
neutral ¶ | L | .F. | Parameter to switch off calculation of temperature equation.
For simulating flows with pure neutral stratification, solving the temperature equation can be switched off with neutral = .T. in order to save CPU time. Additionally, this will also switch off the calculation of all buoyancy related terms. |
nudging ¶ | L | .F. |
Parameter to choose nudging. Nudging is a relaxation technique which adjusts the large-eddy simulation to a given, larger scale flow situation. It can, for example, be used to simulate an observed situation. Further information can be found here.
With nudging = .T., additional tendencies are calculated for the prognostic variable u, v, lpt, and q. It requires humidity = .T. as well as large_scale forcing = .T.. So far, it is not implemented for the ocean mode and non-cyclic lateral boundary conditions. An example can be found here. Additionally, if nudging is set to .T., the input file NUDGING_DATA has to be provided. This file contains profile information at several time steps about the relaxation time scale tau and the prognostic variables u, v, w, lpt, q which must be provided by a larger scale model or by measurements. |
passive_scalar ¶ | L | .F. |
Parameter to switch on the prognostic equation for a passive scalar. |
pt_reference ¶ | R | value of pt_surface |
Reference temperature to be used in the buoyancy term (in K). |
random_heatflux ¶ | L | .F. |
Parameter to impose random perturbations on the internal two-dimensional near surface heat flux field shf. |
reference_state ¶ | C*20 | 'initial_profile' | This parameter defines what is used as reference state in the buoyancy term. There are three options:
'initial_profile'
'horizontal_average'
'single_value'
|
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_subsidence_tendencies ¶ | L | .F. | This control parameter determines how the large-scale subsidence is computed for runs with large-scale forcing. If it is set to .F., the large-scale subsidence velocity w_subs is used to advect the prognostic variables (subroutine subsidence). If it is set to .T., the subroutine subsidence is not called and the subsidence tendencies from LSF_DATA are applied to the prognostic variables in the new subroutine ls_advec. The usage of use_subsidence_tendencies requires large_scale_forcing = .T. as well as large_scale_subsidence = .T.. |
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(10) | 10 * -1.0 |
Vertical grid spacing (in m).
The w-levels lie half between them:
except for k=0, where
|
dz_max ¶ | R | 999.0 |
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 | -9999999.9 |
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 mode runs 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
|
dz_stretch_level_end ¶ | R(9) | 9 * 9999999.9 |
Height level until which the grid is to be stretched vertically (in m). Up to 9 heights/separate stretching regions are possible.
and used as spacings for the scalar levels (zu). The w-levels are then defined as:
For ocean mode runs dz_stretch_level_end is also the height level (in m) until which the grid is to be stretched vertically but it is defined negative. The vertical grid spacings dz between this level and the corresponding dz_stretch_level_start are calculated as
For each dz_stretch_level_end a corresponding dz_stretch_level_start must be defined. |
dz_stretch_level_start ¶ | R(9) | 9 * -9999999.9 |
Height level above/below which the grid is to be stretched vertically (in m). Up to 9 heights/separate stretching regions are possible.
and used as spacings for the scalar levels (zu). The w-levels are then defined as:
For ocean mode runs dz_stretch_level_start is the height level (in m, negative) below which the grid is to be stretched vertically. The vertical grid spacings dz between this level and the corresponding dz_stretch_level_end are calculated as
For each dz_stretch_level_start a corresponding dz_stretch_level_end must be defined except for the last level. Here, it is possible to omit the value for dz_stretch_level_end to consider 'endless' stretching until the value of dz_max is reached. In that case the stretching factor can not be calculated and is set to the value of dz_stretch_factor. |
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. |
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 multigrid method. |
fft_method ¶ | C*20 | 'temperton-algorithm' |
FFT-method to be used. |
loop_optimization ¶ | C*16 | 'cache' |
Method used to optimize loops for solving the prognostic equations. |
masking_method ¶ | L | .F. |
Switch for topography boundary conditions in 'multigrid_noopt' solver.
Remark 1 In case of very complex topography, including narrow street canyons or complex shapes resolved by only a few grid points, the use of psolver = 'multigrid_noopt' in combination with masking_method = .F. can lead to a blow up of wind velocity. So far, this never happened if masking_method = .T. or psolver = 'multigrid' (where topography is always masked). A possible workaround to prevent such velocity blow-up is to preprocess the topography by filling holes and removing complex shapes on the small scale before running the LES. (This approach should have no significant effect on the flow field, as in LES the flow in such regions is poorly resolved and do not yield to reliable physical information.) The reason for this velocity blow-up is unclear so far.
Remark 2 If topography is prescribed and psolver = 'multigrid_noopt', the mean velocity-divergence reduction (see RUN_CONTROL) is smaller in case of masking_method = .T. compared to masking_method = .F. (about one-order of magnitude). This smaller reduction can be attributed to wall-bounded grid points, where the divergence after pressure correction remains significantly larger in case of masking, while the divergence reduction for non-wall-bounded grid points is similar in both cases. However, validation tests revealed that this smaller divergence reduction has no effect on the resulting flow. |
mg_cycles ¶ | I | 4 |
Number of cycles to be used with the multigrid scheme. |
mg_switch_to_pe0_level ¶ | I | -1 |
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 ).
'up-scheme'
|
monotonic_limiter_z ¶ | C*10 | .F. | Control flag that enables a monotonic flux limiter for the vertical advection of passive scalars according to Skamarock (2006, Mon. Wea. Rev 134, 2241-2250). If the limiter is enabled, vertical scalar advection will be monotone and positive definite but strong gradients may be smoothed. This will avoid numerical oscillation that can cause unrealistically high concentrations within poorly resolved cavities within urban environments, e.g. narrow street canyons, which can spoil the entire simulation results. Please note, the limiter is only effective up to the height of the highest topography. Please note, this parameter becomes only effective if scalar_advec = 'ws-scheme' is set. Moreover, please note that the monontonic limiter is currently only implemented for loop_optimization = 'cache'. |
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 SOR-scheme. |
psolver ¶ | C*10 | 'poisfft' |
Scheme to be used to solve the Poisson equation for the perturbation pressure.
'multigrid'
'multigrid_noopt'
'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. Note that the method has no effect if recycling_method = 'absolute_value' or recycling_method = 'absolute_value_thermodynamic'. Detailed information about the damping can be found in the documentation of the non-cyclic lateral boundary conditions. |
pt_damping_width ¶ | R | 0.0 |
Width of the damping domain of the potential temperature (in m). Detailed information about the damping can be found in the documentation of the non-cyclic lateral boundary conditions. |
random_generator ¶ | C*20 |
'random- |
Random number generator to be used for creating uniformly distributed random numbers. |
rans_const_c ¶ | R(5) | 0.55, 1.44, 1.92, 0.0, 0.0 | Model parameter used in the turbulence closure for RANS mode. Constants are ![]() Default values are according to the standard TKE-e turbulence closure (see turbulence_closure). |
rans_const_sigma ¶ | R(2) | 1.0, 1.3 | Model parameter used in the turbulence closure for RANS mode. Constants are ![]() Default values are according to the standard TKE-e turbulence closure (see turbulence_closure). |
rayleigh_damping_factor ¶ | R | 0.0 |
Factor for Rayleigh damping. |
rayleigh_damping_height ¶ | R |
2/3*zu(nzt) |
Height above (ocean: below) which the Rayleigh damping starts (in m). |
residual_limit ¶ | R | 1.0E-4 |
Largest residual permitted for the multigrid 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. Note, in case of large gradients close to poorly-resolved cavities, e.g. narrow street canyons, numerical oscillation can occur which might built-up if the flow is almost completely blocked. In this case it is recommended to apply a monotonic flux limiter (monotonic_limiter_z = .T.) which guarantees monotone and positive definite vertical advection of passive scalars (only).
'pw-scheme'
'bc-scheme'
'up-scheme'
Remark: Independent on the choice of 'scalar_advec' and timestep_scheme, a different 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 time step scheme can be chosen for the subgrid-scale TKE using parameter use_upstream_for_tke. |
transpose_compute_overlap ¶ | L | .F. |
Parameter to switch on parallel execution of fft and transpositions (with MPI_ALLTOALL). |
turbulence_closure ¶ | C*20 | '1.5-order' |
Parameter to choose between different turbulence closures.
'1.5-order-dai'
'dynamic'
'tke-l'
'tke-e'
|
use_upstream_for_tke ¶ | L | .F. |
Parameter to choose the advection/time step 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).
|
latitude ¶ | R | 55.0 |
Geographical latitude (in degrees north). |
longitude ¶ | R | 0.0 |
Geographical longitude (in degrees east). |
rotation_angle ¶ | R | 0.0 |
Rotation angle of the model's North direction relative to geographical North (in degrees, clockwise rotation). |
prandtl_number ¶ | R | 1.0 |
Ratio of the eddy diffusivities for momentum and heat (Km/Kh). |
use_fixed_date ¶ | L | .F. |
Switch to fix the calendar day within a simulation. |
use_fixed_time ¶ | L | .F. |
Switch to fix the time of day within a simulation. |
Boundary conditions: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
bc_e_b ¶ | C*20 | 'neumann' |
Bottom boundary condition of the TKE.
bc_e_b = '(u*)**2+neumann' can be set as an alternative. In that case, e(k=1) = u*/0.1 is assumed. This alternative is just a test option and should be used with care. |
bc_lr ¶ | C*20 |
'cyclic' |
Boundary condition along x (for all quantities).
In case of nested run, except if nesting_mode= 'vertical' , the default value of 'bc_lr' in the nest domains is not 'cyclic' but 'nested' instead. For the root domain of a nested run the default is 'cyclic' as usually.
In case of offline nesting 'bc_lr' is set internally to Dirichlet boundary conditions.
Note: Using non-cyclic lateral boundaries requires very sensitive adjustments of the inflow (vertical profiles) and the bottom boundary conditions, e.g. a surface heating should not be applied near the inflow boundary because this may significantly disturb the inflow. Please check the model results very carefully.
Detailed information can be found in the documentation of the non-cyclic lateral boundary conditions. |
bc_ns ¶ | C*20 |
'cyclic' |
Boundary condition along y (for all quantities).
In case of offline nesting 'bc_ns' is set internally to Dirichlet boundary conditions. For further details regarding non-cyclic lateral boundary conditions see bc_lr. |
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.
Note: |
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. In case of offline nesting 'bc_pt_t' is set internally to Dirichlet boundary conditions. |
bc_q_b ¶ | C*20 | 'dirichlet' |
Bottom boundary condition of the water vapor / total water mixing ratio. |
bc_q_t ¶ | C*20 |
'neumann' |
Top boundary condition of the water vapor / total water mixing ratio.
(up to k=nz the prognostic equation for q is solved). In case of offline nesting 'bc_q_t' is set internally to Dirichlet boundary conditions. |
bc_s_b ¶ | C*20 | 'dirichlet' |
Bottom boundary condition of the scalar concentration. |
bc_s_t ¶ | C*20 |
'initial_gradient' |
Top boundary condition of the scalar concentration.
(up to k=nz the prognostic equation for the scalar concentration is solved).
When a constant scalar flux is used at the top boundary (top_scalarflux), bc_s_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_uv_b ¶ | C*20 | 'dirichlet' |
Bottom boundary condition of the horizontal velocity components u and v. |
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. |
constant_flux_layer ¶ | L | .T. |
Parameter to switch on a constant flux layer at the bottom boundary. |
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 turbulence 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 (grid points). | |
inflow_disturbance_end ¶ | I |
Upper limit of the horizontal range for which random perturbations are to be imposed on the horizontal velocity field (grid points). | |
outflow_source_plane ¶ | R | - | Horizintal position (in m) of the vertical source plane from where instantaneous values of u, v, w, pt, q, s, and e are copied to the outflow boundary in case of turbulent_outflow=.TRUE.. The position needs to be given as the distance from the inflow boundary. The source plane must be positioned inside the model domain. |
recycling_method ¶ | C*80 | 'turbulent_fluctuation' |
If turbulent_inflow = .TRUE., three recycling methods are available:
'turbulent_fluctuation': Turbulent fluctuations of all prognostic variables are recycled and added to the inflow profile, see turbulent_inflow for a detailed description. This method is the default method. If surface heating/cooling or a surface waterflux is applied, a horizontal temperature (humidity) gradient inside the boundary layer will develop, because the temperature/humidity profiles at the inflow are constant. The resulting horizontal differences in buoyancy can trigger an undesired circulation inside the entire domain and instabilities at the inflow boundary (see pt_damping_factor).
'absolute_value': The absolute instantaneous values of all prognostic variables but vertical velocity are recycled, so that the values at the inflow boundary and the recycling plane are identical (for vertical velocity, still only the turbulent fluctuations are recycled). With this method there is no horizontal temperature (humidity) gradient and thus the circulation and the instabilities at the inflow boundary will not occur. Note that the mean inflow profiles of all prognostic variables but vertical velocity will now change in time (growing boundary layer). 'absolute_value_thermodynamic': The absolute instantaneous values of potential temperature and (if present) humidity are recycled. For all other prognostic variables the turbulent fluctuations are recycled. With this method there is no horizontal temperature (humidity) gradient and thus the circulation and the instabilities at the inflow boundary will not occur. Note that the mean inflow profiles of potential temperature (humidity) will now change in time (growing boundary layer), in contrast to the inflow profile of all other quantities (e.g. u,v,w) that are constant. In order to avoid this mismatch, the boundary layer height should be kept constant by applying a large_scale_subsidence to scalar quantities. |
recycling_width ¶ | R | - |
Distance of the recycling plane from the inflow boundary (in m). |
roughness_length ¶ | R | 0.1 |
Roughness length (in m). |
surface_heatflux ¶ | R |
no prescribed |
Kinematic sensible heat flux at the bottom surface (unit depending on flux_input_mode). |
surface_scalarflux ¶ | R | 9999999.9 |
Scalar flux at the surface (in kg m-2 s-1 (particle flux) or ppm m s-1 (gaseous flux)). |
surface_waterflux ¶ | R |
no prescribed |
Kinematic water flux near the surface (in kg/kg 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_scalarflux ¶ | R |
no prescribed |
Scalar flux at the top boundary (in kg m-2 s-1 (particle flux) or ppm m s-1 (gaseous flux)). |
turbulent_inflow ¶ | L | .F. |
Generates a turbulent inflow at side boundaries using a turbulence recycling method. |
turbulent_outflow ¶ | L | .F. |
When set true, a turbulent outflow condition is used at the outflow boundary. This outflow condition works similar to the turbulent recycling method, but instantaneous values are copied from a vertical source plane (see outflow_source_plane) from inside the domain to the outflow boundary. This prevents numerical errors which can occur if negative velocity values appear at the outflow boundary while using the radiation boundary condition. |
use_free_convection_scaling ¶ | L | .F. | Parameter to switch on the use of the local free convection velocity scale w_lfc. When switched on, w_lfc is added to the horizontal wind velocity for use in the constant flux layer parameterization to calculate the Obukhov length and the friction velocity u_* over horizontally-aligned surfaces. The horizontal velocity u_h at height of the first vertical grid level z_mo is then calculated as: ![]() with ![]() This is particularly useful in simulations of convective boundary layers where the local near-surface wind is expected to close to zero, e.g. in urban environments when the present buildings create spots of stagnant air. w_lfc accounts for the dominant eddies close to the surface that cannot be resolved by the LES model and increases u_h by a small amount. When using the land surface scheme, this might prevent the surface sensible heat flux from dropping to zero under no-wind conditions. |
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). |
y_shift ¶ | I | 0 |
In case of cyclic boundary conditions: |
z0h_factor ¶ | R | 1.0 |
Factor for calculating the roughness length for scalars.
This parameter is effective only in case that a constant flux layer is switched on at the bottom boundary (see constant_flux_layer). |
zeta_max ¶ | R | 20.0 |
Upper limit of the stability parameter [zeta = z_mo/L, with z_mo being the height of the constant flux layer, and L being the Obukhov length. |
zeta_min ¶ | R | -20.0 |
Lower limit of the stability parameter [zeta = z_mo/L, with z_mo being the height of the constant flux layer, and L being the Obukhov length. |
Initialization: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
calc_soil_moisture_during_spinup ¶ | L | .F. | Parameter for switching on water transport equation in the soil model during the spinup phase (see spinup_time). If set to .TRUE. an additional prognostic equation for the volumetric moisture content of the soil layer is solved. |
damp_level_1d ¶ | R | zu(nzt+1) |
Height where the damping layer begins in the 1d-model (in m). |
data_output_during_spinup ¶ | L | .F. | Parameter for switching on data output in the spinup phase (see spinup_time). If set to .TRUE. timeseries and profile data will be output at regular intervals as prescribed by the user. Note that there will be no output of 2D/3D/masked data during the spinup phase. For radiation calculations during spinup, a starting time is calculated based on the setting of origin_date_time, so that the spinup starts at origin_date_time - spinup_time. The coupled run then starts at origin_date_time. In the output data, the timestamps during spinup will show negative values in the output data so that the coupled model system starts at timestamp 0 s. |
dissipation_1d ¶ | C*20 | 'detering' |
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). |
dt_spinup ¶ | R | 5.0 | Time step during integration of the land surface, urban surface, and radiation models during the spinup phase (see spinup_time). Longer time steps than the default value of 60 s can be considered, depending on the precise configuration of the respective surface models. Please note, we have recurrently experienced that the soil/wall spinup becomes unstable when the timestep is chosen too large. Hence, we recommend to use smaller values of dt_spinup <= 10 s. |
end_time_1d ¶ | R | 864000.0 |
Time to be simulated for the 1d-model (in s). |
ensemble_member_nr ¶ | I | 0 |
By setting the initialization parameter ensemble_member_nr to an integer between 1 and 2000, palm will produce statistically independent members of a simulation. |
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'
'initialize_bubble'
'cyclic_fill'
'interpolate_from_parent'
'inifor'
Values may be combined, e.g. initializing_actions = 'set_constant_profiles initialize_vortex' , but the values of 'set_constant_profiles' , 'set_1d-model_profiles' , 'cyclic_fill' , 'read_restart_data' , 'inifor' and 'by_user' must not be given at the same time.
Values may be combined with all other actions, e.g. initializing_actions = 'set_constant_profiles, except for the values of 'read_restart_data' . To use this option, spinup data from a previous run with spinup_time /= 0.0 must be available. This data is written into SPINOUT triggered by palmrun ... -a "... spinout". Please note, reading and writing surface spinup data is only possible with restart_data_format = mpi or mpi_shared_memory. In order to input the surface data in an initial run, the spinin attribute must be given: palmrun ... -a "d3# ... spinin". | |
mixing_length_1d ¶ | C*20 | 'blackadar' |
Mixing length used in the 1d-model. |
origin_date_time ¶ | C | '2019-06-21 12:00:00 +00' | Date and time at model start. The default is set to 21st of June 2019 at 12UTC (noon).
Further examples: Note, that PALM always uses UTC internally. If you specify a time zone different from UTC, the time is converted internally to UTC. Output will always use UTC. See use_fixed_date and use_fixed_time for further time-related options. Please see also possible side effects concerning the time-coordinates in the dynamic input file. |
pt_surface ¶ | R | 300.0 |
Surface potential temperature (in K). |
pt_surface_heating_rate ¶ | R | 0.0 |
Linear surface temperature increase in K/h.
Instead of prescribing a surface_heatflux also a surface heating rate can be prescribed by setting pt_surface_heating_rate to a non-zero value. Surface cooling can be achieved by assigning a negative value. |
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 above which the temperature gradient defined by pt_vertical_gradient is effective (in m). |
q_surface ¶ | R | 0.0 |
Surface water vapor / total water mixing ratio (kg/kg). |
q_surface_initial_change ¶ | R | 0.0 |
Change in surface water vapor / total water mixing ratio 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). |
spinup_pt_amplitude ¶ | R | 0.0 | Representative amplitude of the diurnal near-surface temperature variation during the spinup phase (see spinup_time). Note that this amplitude does not match the true temperature amplitude during spinup. The true amplitude depends also on the incoming shortwave radiation and thus depends on the day of the year and the geographic location. |
spinup_pt_mean ¶ | R | value of pt_surface | Mean near-surface air temperature during the spinup phase (see spinup_time). If no value is provided, the mean will be inferred from the setting of pt_surface. |
spinup_time ¶ | R | 0.0 | Parameter for steering the length of the soil/wall spinup phase (in s). The soil/wall spinup allows for the adjustment of the inert soil- and wall-layer temperatures to the prevailing atmospheric conditions, prior to the actual 3D atmosphere simulation. This saves a significant amount of computational time because during the spinup phase, the soil and wall models run without an interactive atmosphere. Currently, this mechanism is implemented for the land surface and the urban surface model. In the spinup phase, these models predict the skin and soil/wall temperatures. All window temperatures (surface and deeper layers) are not calculated during spinup. For using the spinup mechanism it is required to have a radiation model activated. Forcing is achieved by radiation and optionally a varying near-surface air temperature (steered via spinup_pt_mean, spinup_pt_amplitude, and the incoming solar radiation. After completion of the spinup, the atmospheric code is switched on and runs coupled to the surface models. On the timeline, the spinup phase has negative times counting towards 0 s, which is when the atmosphere is activated. Note that the near-surface temperatures are reset before coupling to their initial values prescribed by the user. The spinup mechanism can be steered via the additional parameters dt_spinup and data_output_during_spinup. |
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 m-3 (particles) or ppm (gases)). |
s_surface_initial_change ¶ | R | 0.0 |
Change in surface scalar concentration to be made at the beginning of the 3d run (in kg m-3 (particles) or ppm (gases)). |
s_vertical_gradient ¶ | R(10) | 10 * 0.0 |
Scalar concentration gradient(s) of the initial scalar concentration profile (in kg m-3 / 100 m (particles) or ppm / 100m (gases)).
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 m-3 / 100 m and for z > 1000.0 m up to the top boundary it is 0.05 kg m-3 / 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/100 m/s*1/m). |
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. |
complex_terrain ¶ | L | .F. | Parameter to enable simulations featuring complex topography. If the run is initialized using the cyclic fill method (initializing_actions= 'cyclic_fill' ), the initial 3D-data is shifted vertically for each grid point in the horizontal plane according to local surface height. The mean inflow profiles of the turbulence recycling method (see turbulent_inflow) can be prescribed at an elevated position by setting the topography height to a non-zero value inside the recycling plane. However, the topography height must exhibit a constant value within the entire recycling plane! If complex_terrain = .T., it is not allowed to use vertical grid stretching. The topography mode must be set to 'read_from_file' (see topography). |
topography ¶ | C*40 | 'flat' |
Topography mode.
'single_building'
'single_street_canyon'
'read_from_file'
'tunnel'
'closed_channel'
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' .
Note: In case there are holes in the topography that are resolved by only one grid point, the topography array in filtered so that such holes are filled up to the minimum topography height of the directly adjoining grid points in the x- and the y-direction. This is necessary, because for such chimney-like features resolved by one grid point, the continuity equation is not fulfilled on a discrete grid, as the only degree of freedom for the pressure solver is the vertical. Such holes are suspected to lead to unrealistic velocity blow-ups, hence, they are filled up. Note that an inclined model domain requires the use of topography = 'flat' and a nonzero alpha_surface. |
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
|
tunnel_height ¶ | R | zw(INT(0.2*nz)) | Height of tunnel top (outer wall). |
tunnel_length ¶ | R | 9999999.9 | Length of the tunnel. tunnel_length can be smaller (open tunnel) or larger (infinite tunnel) than the model-domain extents along the tunnel axis. |
tunnel_width_x ¶ | R | 9999999.9 | Width of the tunnel along x-direction with respect to the tunnel outer walls. A non-default value indicates a tunnel orientation along y. The tunnel width must be at least larger than 2 * dx + 2 * tunnel_wall_depth. |
tunnel_width_y ¶ | R | 9999999.9 | Width of the tunnel along y-direction with respect to the tunnel outer walls. A non-default value indicates a tunnel orientation along x. The tunnel width must be at least larger than 2 * dy + 2 * tunnel_wall_depth. |
tunnel_wall_depth ¶ | R | max( dx, dy, dz ) | Depth of the tunnel walls. |
wall_heatflux ¶ | R(0:5) | 6 * 0.0 |
Prescribed kinematic sensible heat flux in K m/s at the five topography faces: |
wall_humidityflux ¶ | R(0:5) | 6 * 0.0 |
Prescribed kinematic humidity flux in m/s at the five topography faces: |
wall_scalarflux ¶ | R(0:5) | 6 * 0.0 |
Prescribed scalar flux at the five topography faces (in kg m-2 s-1 (particle flux) or ppm m s-1 (gaseous flux)): |
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). | ||||||||||||||||||||
netcdf_precision ¶ | C*20 (10) | single precision for all output quantities |
Defines the accuracy of the netCDF output.
| ||||||||||||||||||||
restart_data_format ¶ | C*20 | 'mpi_shared_memory' |
Binary format of the input and output restart files. This parameter can also be used in the runtime parameter NAMELIST. | ||||||||||||||||||||
restart_data_format_input ¶ | C*20 | value of restart_data_format |
Binary format of the input restart file. This parameter can also be used in the runtime parameter NAMELIST. | ||||||||||||||||||||
restart_data_format_output ¶ | C*20 | value of restart_data_format |
Binary format of the output restart file. This parameter can also be used in the runtime parameter NAMELIST. | ||||||||||||||||||||
statistic_regions ¶ | I | 0 |
Number of additional user-defined subdomains for which statistical analysis and corresponding output (profiles, time series) shall be made. | ||||||||||||||||||||
vdi_checks ¶ | L | .F. |
To switch the internal controls according to VDI 3873 Part 9 on. |
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