Version 110 (modified by herbort, 15 years ago) (diff) |
---|
Listing of the steering parameters in alphabetical order
Initialization parameters (NAMELIST Group = I), run parameters (R), package parameters (P) as well as user-defined parameters (U) are alphabetically listed in the following table.
Jump to a, b, c, d, e, f, g, h, i, j, k, l, m, n, o, p, q, r, s, t, u, v, w, x, y, z
Parameter Name | NAMELIST Group | Parameter Class | FORTRAN Type | Default Value | Explanation |
---|---|---|---|---|---|
adjust_mixing_length | I | bc | L | .F. | Near-surface adjustment of the mixing length to the Prandtl-layer law. |
alpha_surface | I | others | R | 0.0 | Inclination of the model domain with respect to the horizontal (in degrees). |
averaging_interval | R | output | R | 0.0 | Averaging interval for all output of temporally averaged data (in s). |
averaging_interval_pr | R | output | R | value of averaging_interval | Averaging interval for vertical profiles output to local file DATA_1D_PR_NETCDF (in s). |
averaging_interval_sp | R | output | R | value of averaging_interval | Averaging interval for spectra output to local file DATA_1D_SP_NETCDF (in s). |
bc_e_b | I | bc | C*20 | 'neumann' | Bottom boundary condition of the TKE. |
bc_lr | I | bc | C*20 | 'cyclic' | Boundary condition along x (for all quantities). |
bc_ns | I | bc | C*20 | 'cyclic' | Boundary condition along y (for all quantities). |
bc_p_b | I | bc | C*20 | 'neumann' | Bottom boundary condition of the perturbation pressure. |
bc_par_b | P | bc | C*15 | 'reflect' | Bottom boundary condition for particle transport. |
bc_par_lr | P | bc | C*15 | 'cyclic' | Lateral boundary condition (x-direction) for particle transport. |
bc_par_ns | P | bc | C*15 | 'cyclic' | Lateral boundary condition (y-direction) for particle transport. |
bc_par_t | P | bc | C*15 | 'absorb' | Top boundary condition for particle transport. |
bc_pt_b | I | bc | C*20 | 'dirichlet' | Bottom boundary condition of the potential temperature. |
bc_pt_t | I | bc | C*20 | 'initial_gradient' | Top boundary condition of the potential temperature. |
bc_q_b | I | bc | C*20 | 'dirichlet' | Bottom boundary condition of the specific humidity / total water content. |
bc_q_t | I | bc | C*20 | 'neumann' | Top boundary condition of the specific humidity / total water content. |
bc_s_b | I | bc | C*20 | 'dirichlet' | Bottom boundary condition of the scalar concentration. |
bc_st | I | bc | C*20 | 'neumann' | Top boundary condition of the scalar concentration. |
bc_sa_t | I | bc | C*20 | 'neumann' | Top boundary condition of the salinity. |
bc_uv_t | I | bc | C*20 | 'dirichlet' | Bottom boundary condition of the horizontal wind components u and v. |
bc_uv_t | I | bc | C*20 | 'dirichlet' | Top boundary condition of the horizontal velocity components u and v. |
bottom_salinityflux | I | bc | R | 0.0 | Kinematic salinity flux near the surface (in psu m/s). |
building_height | I | topo | R | 50.0 | Height of a single building in m. |
building_length_x | I | topo | R | 50.0 | Width of a single building in m. |
building_length_y | I | topo | R | 50.0 | Depth of a single building in m. |
building_wall_left | I | topo | R | building centered in x-direction | x-coordinate of the left building wall in m. |
building_wall_south | I | topo | R | building centered in y-direction | y-coordinate of the South building wall in m. |
call_psolver_at_all_substeps | I | num | L | .T. | Switch to steer the call of the pressure solver. |
canopy_mode | I | canopy | C*20 | 'block' | Canopy mode. |
canyon_height | I | topo | R | 50.0 | Street canyon height in m. |
canyon_width_x | I | topo | R | 9999999.9 | Street canyon width in x-direction in m. |
canyon_width_y | I | topo | R | 9999999.9 | Street canyon width in y-direction in m. |
canyon_wall_left | I | topo | R | canyon centered in x-direction | x-coordinate of the left canyon wall in m. |
canyon_wall_south | I | topo | R | canyon centered in y-direction | y-coordinate of the South canyon wall in m. |
cfl_factor | I | num | R | 0.1, 0.8 or 0.9 (see parameter description) | Time step limiting factor. |
clip_dvrp_l | P | dvr | R | 0.0 | Left boundary of the displayed domain (in m). |
clip_dvrp_n | P | dvr | R | (ny + 1)*dy | North boundary of the displayed domain (in m). |
clip_dvrp_r | P | dvr | R | (nx + 1)*dx | Right boundary of the displayed domain (in m). |
clip_dvrp_s | P | dvr | R | 0.0 | South boundary of the displayed domain (in m). |
cloud_droplets | I | mode | L | .F. | Parameter to switch on usage of cloud droplets. |
cloud_physics | I | mode | L | .F. | Parameter to switch on the condensation scheme. |
cluster_size | P | dvr | I | 1 | Vertex cluster size for polygon reduction of topography. |
color_interval | P | dvr | R(2) | 0.0, 1.0 | Interval of values used for determining the particle color displayed in the animation. |
comp_spectra_level | P | output | I(100) | no level | Vertical level for which horizontal spectra are to be calculated and output (gridpoints). |
conserve_volume_flow | I | mode | L | .F. | Conservation of volume flow in x- and y-direction. |
conserve_volume_flow_mode | I | mode | C*16 | 'default' | Modus of volume flow conservation. |
coupling_start_time | I | mode | R | 0.0 | Simulation time of a precursor run.. |
create_disturbances | R | run steering | L | .T. | Switch to impose random perturbations to the horizontal velocity field. |
cross_normalized_x | R | output | C*10(100) | 100*' ' | Type of normalization applied to the x-coordinate of vertical profiles to be plotted with profil. |
cross_normalized_y | R | output | C*10(100) | 100*' ' | Type of normalization applied to the y-coordinate of vertical profiles to be plotted with profil. |
cross_profiles | R | output | C*100(100) | see parameter description | Determines which vertical profiles are to be presented in which coordinate system if the plot software profil is used. |
cross_xtext | R | output | C*40(100) | see parameter description | x-axis labels of vertical profile coordinate systems to be plotted with profil. |
cthf | R | canopy | R | 0.0 | Average heat flux that is prescribed at the top of the plant canopy (in K m/s). |
cycle_mg | I | num | C*1 | 'w' | Type of cycle to be used with the multi-grid method. |
damp_level_1d | I | ini | R | zu(nz + 1) | Height where the damping layer begins in the 1d-model (in m). |
data_output | R | output | C*10(100) | 100*' ' | Quantities for which 2d cross section and/or 3d volume data are to be output. |
data_output_format | R | output | C*10(10) | 'netCDF' | Format of output data. |
data_output_pr | R | output | C*10(100) | 100*' ' | Quantities for which vertical profiles (horizontally averaged) are to be output. |
data_output_pr_user | U | output | C*10(200) | 200*' ' | User defined quantities for which horizontally averaged profile data is to be output. |
data_output_on_each_pe | R | output | L | .T. | Output 2d cross section data by one or all processors. |
density_ratio | P | particles | R(10) | 0.0, 9*9999999.9 | Ratio of the density of the fluid and the density of the particles. |
dissipation_id | I | ini | C*20 | 'as_in_3d_model' | Calculation method for the energy dissipation term in the TKE equation of the 1d-model. |
disturbance_amplitude | R | run steering | R | 0.25 | Maximum perturbation amplitude of the random perturbations imposed to the horizontal velocity field (in m/s). |
disturbance_energy_limit | R | run steering | R | 0.01 | Upper limit value of the perturbation energy of the velocity field used as a criterion for imposing random perturbations (in m2/s2). |
disturbance_level_b | R | run steering | R | zu(3) or zu(nz*2/3) | Lower limit of the vertical range for which random perturbations are to be imposed on the horizontal wind field (in m). |
disturbance_level_t | R | run steering | R | zu(nz/3) or zu(nzt-3) | Upper limit of the vertical range for which random perturbations are to be imposed on the horizontal wind field (in m). |
do2d_at_begin | R | output | L | .F. | Output 2d cross section data by one or all processors. |
do3d_at_begin | R | output | L | .F. | Output of 3d volume data at the beginning of a run. |
do3d_compress | R | output | L | .F. | Output of data for 3d plots in compressed form. |
do3d_comp_prec | R | output | C*7(100) | see parameter description | Significant digits in case of compressed data output. |
dp_external | R | mode | L | .F. | External pressure gradient switch. |
dp_smooth | R | mode | L | .F. | Vertically smooth the external pressure gradient using a sinusoidal smoothing function. |
dp_level_b | R | mode | R | 0.0 | Lower limit of the vertical range for which the external pressure gradient is applied (in m). |
dpdxy | R | mode | R(2) | 2*0.0 | Values of the external pressure gradient applied in x- and y-direction, respectively (in Pa/m). |
drag_coefficient | I | canopy | R | 0.0 | Drag coefficient used in the plant canopy model. |
dt | R | run steering | R | variable | Time step for the 3d-model (in s). |
dt_averaging_input | R | output | R | 0.0 | Temporal interval of data which are subject to temporal averaging (in s). |
dt_averaging_input_pr | R | output | R | value of dt_averaging_input | Temporal interval of data which are subject to temporal averaging of vertical profiles and/or spectra (in s). |
dt_coupling | R | ocean | R | 9999999.9 | Temporal interval for the data exchange in case of runs with coupled models (e.g. atmosphere - ocean) (in s). |
dt_data_output | R | output | R | 9999999.9 | Temporal interval at which data (3d volume data, cross sections, vertical profiles, spectra) shall be output (in s). |
dt_data_output_av | R | output | R | value of dt_data_output | Temporal interval at which time averaged 3d volume data and/or 2d cross section data shall be output (in s). |
dt_disturb | R | run steering | R | 9999999.9 | Temporal interval at which random perturbations are to be imposed on the horizontal velocity field (in s). |
dt_dopr | R | output | R | value of dt_data_output | Temporal interval at which data of vertical profiles shall be output (to local file DATA_1D_PR_NETCDF (in s). |
dt_dopr_listing | R | output | R | 9999999.9 | Temporal interval at which data of vertical profiles shall be output (output for printouts, local file LIST_PROFIL) (in s). |
dt_dopts | P | output | R | value of dt_data_output | Temporal interval at which time series data of particle quantities shall be output (in s). |
dt_dosp | P | output | R | value of dt_data_output | Temporal interval at which spectra data shall be output (in s). |
dt_dots | R | output | R | see parameter description | Temporal interval at which time series data shall be output (in s). |
dt_do2d_xy | R | output | R | value of dt_data_output | Temporal interval at which horizontal cross section data shall be output (in s). |
dt_do2d_xz | R | output | R | value of dt_data_output | Temporal interval at which vertical cross section data (xz) shall be output (in s). |
dt_do2d_yz | R | output | R | value of dt_data_output | Temporal interval at which vertical cross section data (yz) shall be output (in s). |
dt_do3d | R | output | R | value of dt_data_output | Temporal interval at which 3d volume data shall be output (in s). |
dt_dvr | P | dvr | R | 9999999.9 | Temporal interval of scenes to be displayed with the dvrp software (in s). |
dt_max | R | run steering | R | 20.0 | Maximum allowed value of the timestep (in s). |
dt_min_part | P | particles | R | 0.0002 | Minimum value for the particle timestep when SGS velocities are used (in s). |
dt_prel | P | particles | R | 9999999.9 | Temporal interval at which particles are to be released from a particle source (in s). |
dt_pr_1d | I | ini | R | 9999999.9 | Temporal interval of vertical profile output of the 1D-model (in s). |
dt_restart | R | run steering | R | 9999999.9 | Temporal interval at which a new restart run is to be carried out (in s). |
dt_run_control | R | output | R | 60.0 | Temporal interval at which run control output is to be made (in s). |
dt_run_control_1d | I | ini | R | 60.0 | Temporal interval of runtime control output of the 1d-model (in s). |
dt_sort_particles | P | particles | R | 0.0 | Temporal interval for sorting particles (in s). |
dt_write_particle_data | P | particles | R | 9999999.9 | Temporal interval for output of particle data (in s). |
dvrp_directory | P | dvr | C*80 | 'default' | Name of the directory into which data created by the dvrp software shall be saved. |
dvrp_file | P | dvr | C*80 | 'default' | Name of the file into which data created by the dvrp software shall be output. |
dvrp_host | P | dvr | C*80 | 'origin.rvs uni-hannover.de' | Name of the computer to which data created by the dvrp software shall be transferred. |
dvrp_output | P | dvr | C*10 | 'rtsp' | Output mode for the dvrp software. |
dvrp_password | P | dvr | C*80 | '' | Password for the computer to which data created by the dvrp software is to be transferred. |
dvrp_psize | P | dvr | R | 0.2*dx | Diameter that the particles is given in visualizations with the dvrp software (in m). |
dvrpsize_interval | P | dvr | R(2) | 0.0, 1.0 | Interval of values used for determining the particle size displayed in the animation. |
dvrp_username | P | dvr | C*80 | no default value | User name of a valid account on the computer to which data created by the dvrp software is to be transferred. |
dx | I | grid | R | 1.0 | Horizontal grid spacing along the x-direction (in m). |
dy | I | grid | R | 1.0 | Horizontal grid spacing along the y-direction (in m). |
dz | I | grid | R | no default value, see parameter description | Vertical grid spacing (in m). |
dz_max | I | grid | R | 9999999.9 | Allowed maximum vertical grid spacing (in m). |
dz_stretch_factor | I | grid | R | 1.08 | Stretch factor for a vertically stretched grid (see dz_stretch_level). |
dz_stretch_level | I | grid | R | 100000.0 | Height level above/below which the grid is to be stretched vertically (in m). |
e_init | I | mode | R | 0.0 | Initial TKE in m2s-2. |
e_min | I | mode | R | 0.0 | Minimum TKE in m2s-2. |
end_time | R | run steering | R | 0.0 | Simulation time of the 3D model (in s). |
end_time_prel | P | particles | R | 9999999.9 | Time of the last release of particles (in s). |
end_time_1d | I | ini | R | 864000.0 | Time to be simulated for the 1D-model (in s). |
fft_method | I | num | C*20 | 'system specific' | FFT-method to be used. |
force_print_header | R | output | L | .F. | Steering of header output to the local file RUN_CONTROL. |
galilei_transformation | I | mode | L | .F. | Application of a Galilei-transformation to the coordinate system of the model. |
grid_matching | I | grid | C*6 | 'strict' | Variable to adjust the subdomain sizes in parallel runs. |
groundplate_color | P | dvr | R(3) | 0.0, 0.6, 0.0 | Color of the ground plate. |
humidity | I | mode | L | .F. | Parameter to switch on the prognostic equation for specific humidity q. |
inflow_damping_height | I | bc | R | from precursor run | Height below which the turbulence signal is used for turbulence recycling (in m). |
inflow_damping_width | I | bc | R | 0.1* inflow_damping_height | Transition range within which the turbulance signal is damped to zero (in m). |
inflow_disturbance_begin | I | bc | 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 | bc | 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). |
initializing_actions | I | ini | C*100 | no default value, see parameter description | Initialization actions to be carried out. |
initial_weighting_factor | P | particles | R | 1.0 | Factor to define the real number of initial droplets in a grid cell. |
isosurface_color | P | dvr | R(3,10) | 0.9, 0.9, 0.9 0.8, 0.1, 0.1 ... | Color of the isosurface(s). |
km_constant | I | mode | R | variable (computed from TKE) | Constant eddy diffusivities are used (laminar simulations). |
km_damp_max | I | mode | R | 0.5*(dx or dy) | Maximum diffusivity used for filtering the velocity field in the vicinity of the outflow (in m2/s). |
lad_surface | I | canopy | R | 0.0 | Surface value of the leaf area density (in m2/m3). |
lad_vertical_gradient | I | canopy | R(10) | 10*0.0 | Gradient(s) of the leaf area density (in m2/m4) |
lad_vertical_gradient_level | I | canopy | 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 | canopy | R | 0.0 | Concentration of a passive scalar at the surface of a leaf (in kg/m3). |
long_filter_factor | I | num | R | 0.0 | Filter factor for the so-called Long-filter. |
loop_optimization | I | num | C*16 | see parameter description | Method used to optimize loops for solving the prognostic equations. |
maximum_number_of_particles | P | particles | I | 1000 | Maximum number of particles (on a PE). |
maximum_number_of_tailpoints | P | particles | I | 100 | Maximum number of tailpoints that a particle tail can have. |
maximum_tailpoint_age | P | particles | R | 100000.0 | Maximum age that the end point of a particle tail is allowed to have (in s). |
mg_cycles | R | num | I | -1 | Number of cycles to be used with the multi-grid scheme. |
mg_switch_to_pe0_level | R | num | I | see parameter description | Grid level at which data shall be gathered on PE0. |
minimum_tailpoint_distance | P | particles | R | 0.0 | Minimum distance allowed between two adjacent points of a particle tail (in m). |
mixing_length_1d | I | ini | C*20 | 'as_in_3d_model' | Mixing length used in the 1d-model. |
mode_dvrp | P | dvr | C*20(10) | 10*' ' | Graphical objects (isosurfaces, slicers, particles) which are to be created by the dvrp software. |
momentum_advec | I | num | C*10 | 'pw-scheme' | Advection scheme to be used for the momentum equations. |
netcdf_data_format | R | output | I | 2 | Data format for netCDF files. |
netcdf_precision | I | output | C*20(10) | single precision for all output quantities | Defines the accuracy of the netCDF output. |
ngsrb | R | num | I | 2 | Grid level at which data shall be gathered on PE0. |
normalizing_region | R | output | I | 0 | Determines the subdomain from which the normalization quantities are calculated. |
npex | R | grid | I | no default value, see parameter description | Number of processors along x-direction of the virtual processor net. |
npey | R | grid | I | no default value, see parameter description | Number of processors along y-direction of the virtual processor net. |
nsor | R | num | I | 20 | Number of iterations to be used with the SOR-scheme. |
nsor_ini | I | num | I | 100 | Initial number of iterations with the SOR algorithm. |
number_of_particle_groups | P | particles | I | 1 | Number of particle groups to be used. |
nx | I | grid | I | no default value, see parameter description | Number of grid points in x-direction. |
ny | I | grid | I | no default value, see parameter description | Number of grid points in y-direction. |
nz | I | grid | I | no default value, see parameter description | Number of grid points in z-direction. |
nz_do3d | I | grid | I | nz + 1 | Limits the output of 3d volume data along the vertical direction (grid point index k). |
ocean | R | run steering | L | .F. | Parameter to switch on ocean runs. |
omega | I | phys | R | 7.29212E-5 | Angular velocity of the rotating system (in rad s-1). |
omega_sor | R | num | R | 1.8 | Convergence factor to be used with the SOR-scheme. |
outflow_damping_width | I | bc | I | MIN(20, nx/2 or ny/2) | Width of the damping range in the vicinity of the outflow (gridpoints). |
particles_per_point | P | particles | I | 1 | Number of particles to be started per point. |
particle_advection_start | P | particles | R | 0.0 | Time of the first release of particles (in s). |
particle_color | P | particles | C*10 | 'none' | Parameter, which allows to bind the displayed particle color to certain flow quantities. |
particle_dvrpsize | P | particles | C*10 | 'none' | Parameter, which allows to bind the displayed particle size to certain flow quantities. |
particle_maximum_age | P | particles | R | 9999999.9 | Maximum allowed age of particles (in s). |
passive_scalar | I | mode | L | .F. | Parameter to switch on the prognostic equation for a passive scalar. |
pch_index | I | canopy | I | 0 | Grid point index (scalar) of the upper boundary of the plant canopy layer. |
pdx | P | particles | R(10) | 10*dx | Distance along x between particles within a particle source (in m). |
pdy | P | particles | R(10) | 10*dy | Distance along y between particles within a particle source (in m). |
pdz | P | particles | R(10) | 10*(zu(2) - zu(1)) | Distance along z between particles within a particle source (in m). |
phi | I | phys | R | 55.0 | Geographical latitude (in degrees). |
plant_canopy | I | canopy | L | .F. | Parameter to switch on the plant canopy model. |
plot_spectra_level | P | output | I(100) | No level | Vertical level(s) for which horizontal spectra are to be plotted (in gridpoints). |
prandtl_layer | I | bc | L | .T. | Parameter to switch on a Prandtl layer. |
prandtl_number | I | phys | R | 1.0 | Ratio of the eddy diffusivities for momentum and heat (Km/Kh). |
precipitation | I | mode | L | .F. | Parameter to switch on the precipitation scheme. |
precipitation_amount_interval | R | output | R | value of dt_do2d_xy | Temporal interval for which the precipitation amount (in mm) shall be calculated and output (in s). |
profile_columns | R | output | I | 3 | Number of coordinate systems to be plotted in one row by profil. |
profile_rows | R | output | I | 2 | Number of rows of coordinate systems to be plotted on one page by profil. |
psb | P | particles | R(10) | 10*zu(nz/2) | Bottom edge of a particle source (in m). |
psl | P | particles | R(10) | 10*0.0 | Left edge of a particle source (in m). |
psn | P | particles | R(10) | 10*(ny*dy) | Rear ("north") edge of a particle source (in m). |
psolver | I | num | C*10 | 'poisfft' | Scheme to be used to solve the Poisson equation for the perturbation pressure. |
psr | P | particles | R(10) | 10*(nx*dx) | Right edge of a particle source (in m). |
pss | P | particles | R(10) | 10*0.0 | Front ("south") edge of a particle source (in m). |
pst | P | particles | R(10) | 10*zu(nz/2) | Top edge of a particle source (in m). |
pt_reference | I | num | R | use horizontal average as reference | Reference temperature to be used in all buoyancy terms (in K). |
pt_surface | I | ini | R | 300.0 | Surface potential temperature (in K). |
pt_surface_initial_change | I | ini | R | 0.0 | Change in surface temperature to be made at the beginning of the 3d run (in K). |
pt_vertical_gradient | I | ini | R(10) | 10*0.0 | Temperature gradient(s) of the initial temperature profile (in K / 100 m). |
pt_vertical_gradient | I | ini | R(10) | 10*0.0 | Height level from which on the temperature gradient defined by pt_vertical_gradient is effective (in m). |
q_surface | I | ini | R | 0.0 | Surface specific humidity / total water content (kg/kg). |
q_surface_initial_change | I | ini | 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 | I | ini | R(10) | 10*0.0 | Humidity gradient(s) of the initial humidity profile (in 1/100 m). |
q_vertical_gradient_level | I | ini | R(10) | 10*0.0 | Height level from which on the humidity gradient defined by q_vertical_gradient is effective (in m). |
radiation | I | mode | L | .F. | Parameter to switch on longwave radiation cooling at cloud-tops. |
radius | P | particles | R(10) | 0.0, 9* 9999999.9 | Particle radius (in m). |
random_generator | I | num | C*20 | 'numerical recipes' | Random number generator to be used for creating uniformly distributed random numbers. |
random_heatflux | I | mode | L | .F. | Parameter to impose random perturbations on the internal two-dimensional near surface heat flux field shf. |
random_start_position | P | particles | L | .F. | Initial position of the particles is varied randomly within certain limits. |
rayleigh_damping_factor | R | num | R | 0.0 and/or 0.01 (see parameter description) | Factor for Rayleigh damping. |
rayleigh_damping_height | R | num | R | 2/3*zu(nz) | Height where the Rayleigh damping starts (in m). |
read_particles_from_restartfile | P | particles | L | .T. | Read particle data from the previous run. |
recycling_width | I | bc | R | 0.1*nx*dx | Distance of the recycling plane from the inflow boundary (in m). |
region | U | output | C*40(0:9) | Name(s) of the subdomain(s) defined by the user. | |
residual_limit | I | num | R | 1.0E-6 | Largest residual permitted for the multi-grid scheme (in s-2m-3). |
restart_time | R | run steering | R | 9999999.9 | Simulated time after which a restart run is to be carried out (in s). |
rif_max | I | bc | R | 1.0 | Upper limit of the flux-Richardson number. |
rif_min | I | bc | R | -5.0 | Lower limit of the flux-Richardson number. |
roughness_length | I | bc | R | 0.1 | Roughness length (in m). |
sa_surface | I | ini | R | 35.0 | Surface salinity (in psu). |
sa_vertical_gradient | I | bc | R(10) | 10*0.0 | Salinity gradient(s) of the initial salinity profile (in psu / 100 m). |
sa_vertical_gradient_level | I | bc | R(10) | 10*0.0 | Height level from which on the salinity gradient defined by sa_vertical_gradient is effective (in m). |
scalar_advec | I | num | C*10 | 'pw-scheme' | Advection scheme to be used for the scalar quantities. |
scalar_exchange_coefficient | R | canopy | R | 0.0 | Scalar exchange coefficient for a leaf (dimensionless). |
section_xy | R | output | I(100) | no section | Position of cross section(s) for output of 2d horizontal cross sections (grid point index k). |
section_xz | R | output | I(100) | no section | Position of cross section(s) for output of 2d (xz) vertical cross sections (grid point index j). |
section_yz | R | output | I(100) | no section | Position of cross section(s) for output of 2d (yz) vertical cross sections (grid point index i). |
skip_particles_for_tail | P | particles | I | 100 | Limit the number of particle tails. |
skip_time_data_output | R | output | R | 0.0 | No data output before this interval has passed (in s). |
skip_time_data_output_av | R | output | R | value of skip_time _data_output | No output of temporally averaged 2d/3d data before this interval has passed (in s). |
skip_time_dopr | R | output | R | value of skip_time _data_output | No output of vertical profile data before this interval has passed (in s). |
skip_time_dosp | P | output | R | value of skip_time _data_output | No output of spectra data before this interval has passed (in s). |
skip_time_do2d_xy | R | output | R | value of skip_time _data_output | No output of instantaneous horizontal cross section data before this interval has passed (in s). |
skip_time_do2d_xz | R | output | R | value of skip_time _data_output | No output of instantaneous vertical (xz) cross section data before this interval has passed (in s). |
skip_time_do2d_yz | R | output | R | value of skip_time _data_output | No output of instantaneous vertical (yz) cross section data before this interval has passed (in s). |
skip_time_do3d | R | output | R | value of skip_time _data_output | No output of instantaneous 3d volume data before this interval has passed (in s). |
slicer_range_limits_dvrp | P | dvr | R(2,10) | 10*(-1,1) | Ranges of values to which a color table has to be mapped (units of the respective quantity). |
spectra_direction | P | output | C*2(10) | 10*' ' | Direction(s) along which spectra are to be calculated. |
statistic_regions | I | output | I | 0 | Number of additional user-defined subdomains for which statistical analysis and corresponding output (profiles, time series) shall be made. |
superelevation | P | dvr | R | 1.0 | Superelevation factor for the vertical coordinate. |
superelevation_x | P | dvr | R | 1.0 | Superelevation factor for the horizontal (x) coordinate. |
superelevation_y | P | dvr | R | 1.0 | Superelevation factor for the horizontal (y) coordinate. |
surface_heatflux | I | bc | R | no prescribed heatflux | Kinematic sensible heat flux at the bottom surface (in K m/s). |
surface_pressure | I | ini | R | 1013.25 | Atmospheric pressure at the surface (in hPa). |
surface_scalarflux | I | bc | R | 0.0 | Scalar flux at the surface (in kg/(m2s)). |
surface_waterflux | I | bc | R | 0.0 | Kinematic water flux near the surface (in m/s). |
s_surface | I | ini | R | 0.0 | Surface value of the passive scalar (in kg/m3). |
s_surface_initial_change | I | ini | R | 0.0 | Change in surface scalar concentration to be made at the beginning of the 3d run (in kg/m3). |
s_vertical_gradient | I | ini | R(10) | 10*0.0 | Scalar concentration gradient(s) of the initial scalar concentration profile (in kg/m3 / 100 m). |
s_vertical_gradient_level | I | ini | R(10) | 10*0.0 | Height level from which on the scalar gradient defined by s_vertical_gradient is effective (in m). |
termination_time_needed | R | run steering | R | 35.0 | CPU time needed for terminal actions at the end of a run in batch mode (in s). |
threshold | P | dvr | R(10) | 0.0 | Threshold value for which an isosurface is to be created by the dvrp software. |
timestep_scheme | I | num | C*20 | 'runge-kutta-3' | Time step scheme to be used for integration of the prognostic variables. |
topography | I | topo | C*40 | 'flat' | Topography mode. |
topography_color | P | dvr | R(3) | 0.8, 0.7, 0.6 | Color of the topography. |
topography_grid_convention | I | topo | C*11 | default depends on value of topography | Convention for defining the topography grid. |
top_heatflux | I | bc | R | no prescribed heatflux | Kinematic sensible heat flux at the top surface (in K m/s). |
top_momentumflux_u | I | bc | R | no prescribed momentumflux | Momentum flux along x at the top boundary (in m2/s2). |
top_momentumflux_v | I | bc | R | no prescribed momentumflux | Momentum flux along y at the top boundary (in m2/s2). |
top_salinityflux | I | bc | R | no prescribed salinityflux | Kinematic salinity flux at the top boundary, i.e. the sea surface (in psu m/s). |
turbulent_inflow | I | bc | L | .F. | Generates a turbulent inflow at side boundaries using a turbulence recycling method. |
u_bulk | I | mode | R | 0.0 | u-component of the predefined bulk velocity (in m/s). |
ug_surface | I | ini | R | 0.0 | u-component of the geostrophic wind at the surface (in m/s). |
ug_vertical_gradient | I | ini | 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 | I | ini | R(10) | 10*0.0 | Height level from which on the gradient defined by ug_vertical_gradient is effective (in m). |
use_particle_tails | P | particles | L | .F. | Give particles a tail. |
use_prior_plot1d_parameters | R | output | L | .F. | Additional plot of vertical profile data with profil from preceding runs of the job chain. |
use_sgs_for_particles | P | particles | L | .F. | Use subgrid-scale velocities for particle advection. |
use_surface_fluxes | I | bc | 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 | I | bc | L | .F. | Parameter to steer the treatment of the subgrid-scale vertical fluxes within the diffusion terms at k=nz (top boundary). |
use_ug_for_galilei_tr | I | mode | L | .T. | Switch to determine the translation velocity in case that a Galilean transformation is used. |
use_upstream_for_tke | I | num | L | .F. | Parameter to choose the advection/timestep scheme to be used for the subgrid-scale TKE. |
vertical_particle_advection | P | particles | L | .T. | Switch on/off vertical particle transport. |
v_bulk | I | mode | R | 0.0 | v-component of the predefined bulk velocity (in m/s). |
vg_surface | I | ini | R | 0.0 | v-component of the geostrophic wind at the surface (in m/s). |
vg_vertical_gradient | I | ini | 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 | I | ini | R(10) | 10*0.0 | Height level from which on the gradient defined by vg_vertical_gradient is effective (in m). |
wall_adjustment | I | bc | L | .T. | Parameter to restrict the mixing length in the vicinity of the bottom boundary (and near vertical walls of a non-flat topography). |
wall_heatflux | I | topo | R(5) | 5*0.0 | Prescribed kinematic sensible heat flux in K m/s at the five topography faces. |
wall_humidityflux | I | topo | R(5) | 5*0.0 | Prescribed kinematic humidtiy flux in m/s at the five topography faces. |
wall_scalarflux | I | topo | R(5) | 5*0.0 | Prescribed scalar flux in kg/(m2 s) at the five topography faces. |
ws_vertical_gradient | I | mode | R(10) | 10*0.0 | Gradient(s) of the profile for the large scale subsidence/ascent velocity in ((m/s) / 100 m). |
ws_vertical_gradient_level | I | mode | 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). |
write_particle_statistics | P | particles | L | .F. | Switch on/off output of particle informations. |
z_max_do1d | R | output | R | zu(nzt+1) (model top) | Height level up to which horizontally averaged profiles are to be plotted with profil (in m). |
z_max_do1d_normalized | R | output | R | determined by plot data | Normalized height level up to which horizontally averaged profiles are to be plotted with profil. |
z_max_do2d | R | output | R | zu(nz) | Height level up to which 2d cross sections are to be plotted with iso2d (in m). |