Version 77 (modified by kanani, 15 years ago) (diff) |
---|
Initialization parameters ¶
Mode ¶
Grid ¶
Numerics ¶
Physics ¶
Boundary Conditions ¶
Initialization ¶
Topography ¶
Canopy ¶
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). |
dt_coupling ¶ | R | 9999999.9 |
Temporal interval for the data exchange in case of runs with coupled models? (e.g. atmosphere - ocean) (in s). |
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). |
km_damp_max ¶ | R |
Maximum diffusivity used for filtering the velocity field in the vicinity of the outflow (in m2/s). | |
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. |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
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
|
grid_matching ¶ | C*6 | 'strict' |
Variable to adjust the subdomain sizes in parallel runs. |
npex ¶ | I |
Number of processors along x-direction of the virtual processor net. | |
npey ¶ | I |
Number of processors along y-direction of the virtual processor net. | |
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). |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
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. |
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. |
long_filter_factor ¶ | R | 0.0 |
Filter factor for the so-called Long-filter. |
loop_optimization ¶ | C*16 | see right |
Method used to optimize loops for solving the prognostic equations. |
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 | 'pw-scheme' |
Advection scheme to be used for the momentum equations.
'ups-scheme'
Since the cubic splines used tend to overshoot under certain circumstances, this effect must be adjusted by suitable filtering and smoothing (see cut_spline_overshoot, long_filter_factor, ups_limit_pt, ups_limit_u, ups_limit_v, ups_limit_w). This is always neccessary for runs with stable stratification, even if this stratification appears only in parts of the model domain. |
ngsrb ¶ | I | 2 |
Grid level at which data shall be gathered on PE0. |
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. |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
Physics: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
omega ¶ | R | 7.29212E-5 |
Angular velocity of the rotating system (in rad s-1).
|
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 |
---|---|---|---|
adjust_mixing_length ¶ | L | .F. |
Near-surface adjustment of the mixing length to the Prandtl-layer law. |
bc_e_b ¶ | C*20 | 'neumann' |
Bottom boundary condition of the TKE. |
bc_lr ¶ | C*20 | 'cyclic' |
Boundary condition along x (for all quantities). 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. |
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 | MIN(10, nx/2 or ny/2) |
Lower limit of the horizontal range for which random perturbations are to be imposed on the horizontal velocity field (gridpoints). |
inflow_disturbance_end ¶ | I | MIN(100, 3/4*nx or 3/4*ny) |
Upper limit of the horizontal range for which random perturbations are to be imposed on the horizontal velocity field (gridpoints). |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
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_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.
'set_1d-model_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?. |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
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. |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
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' . |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
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). |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
Others: ¶
Parameter Name | FORTRAN Type | Default Value | Explanation |
---|---|---|---|
[=# '] | |||
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
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