Version 100 (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). |
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. |
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. |
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). This parameter comes into effect if conserve_volume_flow = .T. and conserve_volume_flow_mode = 'bulk_velocity'. |
ws_vertical_gradient ¶ | R(10) | 10 * 0.0 | Gradient(s) of the profile for the large scale subsidence/ascent velocity (in (m/s) / 100 m). This gradient holds starting from the height level defined by ws_vertical_gradient_level (precisely: for all uv levels k where zu(k) > ws_vertical_gradient_level, w_subs(k) is set: w_subs(k) = w_subs(k-1) + dzu(k) * ws_vertical_gradient) up to the top boundary or up to the next height level defined by ws_vertical_gradient_level. A total of 10 different gradients for 11 height intervals (10 intervals if ws_vertical_gradient_level(1) = 0.0) can be assigned. Example:
That defines the subsidence/ascent profile to be linear up to z = 1000.0 m with a surface value of 0 m/s. 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). With an appropriate construction of w_subs the height of the boundary layer z_i can be kept approximately constant. Attention: The large scale vertical motion is only applied to the prognostic equation for the scalar quantities (potential temperature, humidity if humidity = .T. or passive scalar if passive_scalar = .T.) because it cannot be applied to the momentum equations due to incompressibility. Thus, the model is not mass consistent. |
[=#ws_vertical_gradient _level ws_vertical_gradient _level] | R(10) | 10 * 0.0 |
Height level from which on the gradient for the subsidence/ascent velocity defined by ws_vertical_gradient is effective (in m). The height levels have to be assigned in ascending order. The default values result in a profile which is zero everywhere regardless of the values of ws_vertical_gradient. For the piecewise construction of the subsidence/ascent velocity profile see ws_vertical_gradient. |
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. |
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'
With parallel runs, starting from a certain grid level the data of the subdomains are possibly gathered on PE0 in order to allow for a further coarsening of the grid. The grid level for gathering can be manually set by mg_switch_to_pe0_level.
'sor'
|
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 * |
Height above (ocean: below) which the Rayleigh damping starts (in m). |
residual_limit ¶ | R | 1.0E-6 |
Largest residual permitted for the multi-grid scheme (in s-2m-3). |
scalar_advec ¶ | C*10 | 'pw-scheme' |
Advection scheme to be used for the scalar quantities.
'bc-scheme'
'ups-scheme'
Since the cubic splines used tend to overshoot under certain circumstances, this effect must be adjusted by suitable filtering and smoothing (see long_filter_factor). This is always neccesssary for runs with stable stratification, even if this stratification appears only in parts of the model domain. |
[=#<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> |
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). |
outflow_damping_width ¶ | I |
Width of the damping range in the vicinity of the outflow (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 | 0.0 |
Scalar flux at the surface (in kg/(m2 s)). |
surface_waterflux ¶ | R | 0.0 |
Kinematic water flux near the surface (in 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> |
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?. |
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). |
[=#<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> |
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' . |
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: |
[=#<insert_parameter_name> <insert_parameter_name>] | <insert type> | <insert value> | <insert explanation> |
[=#<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). |
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). |
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