PA0= PALM error messages = The following list displays the error messages reported by PALM. Each error message is identified by a unique message identifier which is composed of two letters and a four digit number. The second column contains the error message as reported in the job protocol (see [[../jobcontrol|here]]). The third column explains the error and possible reasons in more detail, and also gives suggestions how to solve the problem. {{{#!table style="border:none" {{{#!td style="vertical-align:top;border:none;width:70px" [#PA0001 PA****] }}} {{{#!td style="vertical-align:top;border:none" Identifier for messages in the PALM standard code }}} |---------------- {{{#!td style="vertical-align:top;border:none" [#UI0001 UI****] }}} {{{#!td style="vertical-align:top;border:none" Identifier for messages in !''user_!'' routines }}} |---------------- {{{#!td style="vertical-align:top;border:none" [#NC NC****] }}} {{{#!td style="vertical-align:top;border:none" Identifier for messages from the netCDF library }}} }}} ||='''Message identifier ''' =||='''Error message''' =||='''Explanation''' =|| ||[=#PA0001 PA0001] ||manual restart settings requires file activation string "restart" || Values for parameters {{{dt_restart}}} or/and {{{restart_time}}} have been given in the {{{&runtime_parameters}}}-NAMELIST. This also requires to give the file activation string {{{"restart"}}} with palmbuild-option {{{-a}}}, because otherwise the restart files wouldn't be generated at the end of the PALM run. \\\\Repeat the run with {{{-a ".... restart"}}} or remove parameters {{{dt_restart}}} or/and {{{restart_time}}} from your NAMELIST-file. || ||[=#PA0002 PA0002] ||3rd dimension of array "XXX" is larger than number of domain height levels: [size_of_3rd_dimension of XXX] > [nz+1]. Reading from file via MPI-IO not possible.||This is an internal error. If you did not add any user code to your simulation, please report this error via the trouble-ticket system. If you added user code and you try to read a 3-D variable from the restart files using the restart_data_mpi_io_mod module, the array you try to read is too large. It must not contain more entries in the 3rd dimension as the domain height of your simulation.|| ||[=#PA0003 PA0003] ||dt_coupling is required to be set in atmosphere runtime parameters namelist || This error appears if the temporal interval for the data exchange [../runtime_parameters#dt_coupling dt_coupling] is not explicitly set in case of runs with [../../app/examples/coupled coupled atmosphere-ocean]. || ||[=#PA0004 PA0004] ||mismatch between atmosphere and ocean model: dt_coupling (atmosphere) = "..." dt_coupling (ocean) = "..." ocean value is set to atmosphere value || For coupled runs the temporal interval for the data exchange [../runtime_parameters#dt_coupling dt_coupling] must be explicitly set and must have the same value in both models ([../runtime_parameters#dt_coupling dt_coupling] has to be set in [../iofiles#PARIN PARIN] and [../iofiles#PARIN_O PARIN_O]). See also [../examples/coupled coupled runs]. || ||[=#PA0005 PA0005] ||dt_coupling < 0.0 is not allowed || This error occurs if an invalid value for [../runtime_parameters#dt_coupling dt_coupling] is used in the parameter file. [../runtime_parameters#dt_coupling dt_coupling] must be >= 0.0 and equal in both models ([../runtime_parameters#dt_coupling dt_coupling] has to be set in [../iofiles#PARIN PARIN] and [../iofiles#PARIN_O PARIN_O]). || ||[=#PA0006 PA0006] ||time averaging of a static quantity ("...") is not provided ||Remove this quantity from the list of output quantities in runtime parameter [../runtime_parameters#data_output data_output], or just remove the {{{_av}}} from the respective string. Time averaging of static quantities is not provided, because these quantities do not change in time. || ||[=#PA0007 PA0007] ||illegal nesting boundary conditions: ... ||Allowed values for [../nesting_parameters#nesting_bounds nesting_bounds] are '3d_nested', 'cyclic_along_x', 'cyclic_along_y', or 'vertical_only'. || ||[=#PA0008 PA0008] ||mismatch between atmosphere and ocean model: time from reference point (atmosphere) = "..." time_from reference point (ocean) = "..." || The simulated time from the reference point is stored internally in the variable {{{time_to_be_simulated_from_reference_point}}}. In coupled mode both times must be equal. This error might occur when precursor runs are used with different startup times and the coupling is initiated inappropiately. See [../examples/coupled coupled runs] for a detailed description of the setup for precursor runs. || ||[=#PA0009 PA0009] ||dx in atmosphere is smaller than dx in ocean ||Coupled runs allow to use different grid resolutions in atmosphere and ocean. It is, however, not allowed to use a finer grid resolution in the atmosphere than in the ocean. || ||[=#PA0010 PA0010] ||dy in atmosphere is smaller than dy in ocean ||Coupled runs allow to use different grid resolutions in atmosphere and ocean. It is, however, not allowed to use a finer grid resolution in the atmosphere than in the ocean. || ||[=#PA0011 PA0011] ||3rd dimension of array "XXX" is larger than number of domain height levels: [size_of_3rd_dimension of XXX] > [nz+1]. Writing to file via MPI-IO not possible.||This is an internal error. If you did not add any user code to your simulation, please report this error via the trouble-ticket system. If you added user code and you try to write a 3-D variable to the restart files using the restart_data_mpi_io_mod module, the array you try to write is too large. It must not contain more entries in the 3rd dimension as the domain height of your simulation.|| ||[=#PA0012 PA0012] ||nested child (id: ..) domain boundaries along x/y do not match the respective parent boundaries. ||The nesting_parameter [../nesting_parameters#nesting_bounds nesting_bounds] has been chosen either 'cyclic_along_x', 'cyclic_along_y', or 'vertical_only', but the child does not exactly match the parent size along the respective direction(s). Adjust the child domain size respectively. || ||[=#PA0013 PA0013] ||illegal value given for loop_optimization: "..." ||See parameter [../initialization_parameters#loop_optimization loop_optimization] for allowed values, and check your parameter file. || ||[=#PA0014 PA0014] ||a non-flat topography does not allow ... ||There are several features which do not work together with a non-flat topography. See parameter [../initialization_parameters#topography topography] for possible restrictions and appropriately modify your parameter file. For a complete list of not allowed parameter settings due to a non-flat topography see check_parameters.f90. || ||[=#PA0015 PA0015] || Using synthetic turbulence generator requires initializing_actions = "set_constant_profiles" or "read_restart_data" || When switching on the synthetic turbulence generator by setting use_synthetic_turbulence_generator = .TRUE., PALM has to be initialized using either constant profiles ([../initialization_parameters#initializing_actions initializing_actions] = "set_constant_profiles") or loading data from a previous run ([../initialization_parameters#initializing_actions initializing_actions] = "read_restart_data"). Other initialization actions do not support the synthetic turbulence generator. || ||[=#PA0016 PA0016] ||unknown solver for perturbation pressure: psolver = "..." ||See parameter [../initialization_parameters#psolver psolver] for allowed values, and correct your parameter file. || ||[=#PA0017 PA0017] ||output of more than 300 profiles requested || The total sum of output profiles given via parameters [wiki:doc/app/runtime_parameters#data_output_pr data_output_pr] and [wiki:doc/app/user_parameters#data_output_pr_user data_output_pr_user] is greater than 300. You may either reduce the number of output profiles, or ask the PALM group (via the trouble-ticket system) to extend the bounds of PALM internal arrays to allow for more than 300 profiles. || ||[=#PA0018 PA0018] || illegal value for data_output_masks or data_output_masks_user: ... || Possible reasons are: (a) a typo in the parameter file related to masked data output, (b) a user-defined variable has not been defined in {{{user_check_data_output.f90}}}, (c) the string length of the user-defined variable exceeds the current limits (see [../userint/output here]). For possible output quantities see [../runtime_parameters#data_output_masks data_output_masks]. || ||[=#PA0019 PA0019] || unknown surface type: surface_type = "..." ||See parameter [../land_surface_parameters#surface_type surface_type] for allowed values, and appropriately correct your parameter file. || ||[=#PA0020 PA0020] ||unknown multigrid cycle: cycle_mg = "..." ||See parameter [../initialization_parameters#cycle_mg cycle_mg] for allowed values, and appropriately correct your parameter file. || ||[=#PA0021 PA0021] ||unknown fft-algorithm: fft_method = "..." ||See parameter [../initialization_parameters#fft_method fft_method] for allowed values, and appropriately correct your parameter file. || ||[=#PA0022 PA0022] ||unknown advection scheme: momentum_advec = "..." ||See parameter [../initialization_parameters#momentum_advec momentum_advec] for allowed values, and appropriately correct your parameter file. || ||[=#PA0023 PA0023] ||momentum_advec or scalar_advec = "..." is not allowed with timestep_scheme = "..." ||The 5th order advection scheme is conditional unstable in conjunction with ''euler'' or ''runge-kutta-2'' integration. Instead, use [../initialization_parameters#timestep_scheme timestep_scheme] = ''runge-kutta-3''. || ||[=#PA0024 PA0024] ||unknown advection scheme: scalar_advec = "..." ||See parameter [../initialization_parameters#scalar_advec scalar_advec] for allowed values, and appropriately correct your parameter file. || ||[=#PA0025 PA0025] ||use_upstream_for_tke is set to .TRUE. because use_sgs_for_particles = .TRUE. and scalar_advec /= 'ws-scheme' ||This is just a warning telling you that the simple upstream discretization is used for the advection term of the TKE equation instead of the one that you have set with parameter [../initialization_parameters#scalar_advec scalar_advec]. This is required in case of using SGS velocity components for particle transport, because non-diffusiv advection schemes may cause large artificial vertical gradients near the surface, which create numerical instabilities in the particle transport. You can avoid output of this warning by explicitly setting parameter [../initialization_parameters#use_upstream_for_tke use_upstream_for_tke] in the parameter file (initialization_parameters-NAMELIST). || ||[=#PA0026 PA0026] ||advection_scheme scalar_advec = "bc-scheme" not implemented for loop_optimization = "cache" ||For the Bott-Chlond scheme loop_optimization = "vector" must to be set. || ||[=#PA0027 PA0027] ||unknown timestep scheme: timestep_scheme = "..." ||See parameter [../initialization_parameters#timestep_scheme timestep_scheme] for allowed values, and appropriately correct your parameter file. || ||[=#PA0028 PA0028] ||negative weighting factor||A negative weighting factor might occur if the timestep is too long. Try to adjust [../initialization_parameters#dt dt]. || ||[=#PA0029 PA0029] ||momentum advection scheme "..." does not work with timestep_scheme "..." || For [../initialization_parameters#timestep_scheme timestep_scheme] = 'runge-kutta-3' only [../initialization_parameters#momentum_advec momentum_advec] = 'ws-scheme' or 'pw-scheme' gives a numerically stable solution. || ||[=#PA0030 PA0030] ||initializing_actions = "..." unkown or not allowed || See parameter [../initialization_parameters#initializing_actions initializing_actions] for allowed values in initial runs (of a job chain). For a [../runs restart run], please set [../initialization_parameters#initializing_actions initializing_actions] = '' 'read_restart_data' ''. || ||[=#PA0031 PA0031] ||initializing_actions = "set_constant_profiles" and "set_1d-model_profiles" are not allowed simultaneously || Set either [../initialization_parameters#initializing_actions initializing_actions] = '' 'set_constant_profiles' '' in your parameter file, if the 3d-model shall be initialized with constant profiles, or set [../initialization_parameters#initializing_actions initializing_actions] = '' 'set_1d-model_profiles' '' if the 3d-model shall be initialized with profiles of the (stationary) solution of the [../../tec/1dmodel 1d-model]. || ||[=#PA0032 PA0032] ||initializing_actions = "set_constant_profiles" and "by_user" are not allowed simultaneously || Set either [../initialization_parameters#initializing_actions initializing_actions] = '' 'set_constant_profiles' '' in your parameter file, if the 3d-model shall be initialized with constant profiles, or set [../initialization_parameters#initializing_actions initializing_actions] = '' 'by_user' '', if the 3d-model shall be initialized with profiles to be provided by the user in routine {{{user_init_3d_model}}} of the [../userint user-interface]. || ||[=#PA0033 PA0033] ||initializing_actions = "by_user" and "set_1d-model_profiles" are not allowed simultaneously || Set either [../initialization_parameters#initializing_actions initializing_actions] = '' 'by_user' '' in your parameter file, if the 3d-model shall be initialized with profiles to be provided by the user in routine {{{user_init_3d_model}}} of the [../userint user-interface], or set [../initialization_parameters#initializing_actions initializing_actions] = '' 'set_1d-model_profiles' '', if the 3d-model shall be initialized with profiles of the (stationary) solution of the [../../tec/1dmodel 1d-model]. || ||[=#PA0034 PA0034] ||bulk_cloud_model = .T. is not allowed with humidity = .F. || It is necessary to turn on [../initialization_parameters#humidity humidity] for the use of cloud physics. || ||[=#PA0035 PA0035] || Using synthetic turbulence generator requires bc_lr = "dirichlet/radiation" || The synthetic turbulence generator requires a non-cyclic boundary condition along x direction with an inflow at the left domain boundary. || ||[=#PA0036 PA0036] ||humidity = .TRUE. and sloping_surface = .TRUE. are not allowed simultaneously || If [../initialization_parameters#alpha_surface alpha_surface] is set to a non-zero value in order to use an inclined surface, the parameter sloping_surface is internally set ''.TRUE.''. I.e., in the case of [../initialization_parameters#alpha_surface alpha_surface] /= 0.0 the simultaneous use of [../initialization_parameters#humidity humidity] = ''.TRUE.'' is not allowed. || ||[=#PA0037 PA0037] || Using synthetic turbulence generator requires bc_ns = "cyclic" || The synthetic turbulence generator only supports non-cyclic boundary conditions at the left/right boundary. In north/south direction, cyclic boundary conditions must be set. || ||[=#PA0038 PA0038] || turbulent_outflow = .T. requires bc_lr = "dirichlet/radiation" || When using the turbulent outflow method, non-cyclic boundary condition along the x direction must be used. See also [../initialization_parameters#turbulent_outflow turbulent_outflow]. || ||[=#PA0039 PA0039] || Using synthetic turbulence generator in combination with turbulent_inflow = .T. is not allowed || A turbulent inflow can only be generated by either the synthetic turbulence generator or the turbulence recycling method. Using both at the same time is impossible. || ||[=#PA0040 PA0040] ||LWC is not conserved during collision! LWC after condensation: ... LWC after collision: ... || LWC means liquid water content. This should not happen. Please write a [https://palm.muk.uni-hannover.de/trac/newticket ticket]. || ||[=#PA0041 PA0041] ||plant_canopy = .TRUE. requires a non-zero drag coefficient, given value is canopy_drag_coeff = 0.0 || When simulating a plant canopy, a non-zero [../plant_canopy_parameters#canopy_drag_coeff canopy_drag_coeff] must be set in the parameter file under NAMELIST {{{&plant_canopy_parameters}}}. The [/wiki/doc/app/plant_canopy_parameters canopy model] in PALM adds an additional sink/source terms to the momentum equations, the prognostic equation for temperature, and the subgrid scale turbulent kinetic energy equation. In case of [../initialization_parameters#humidity humidity] = ''.TRUE.'' or [../initialization_parameters#passive_scalar passive_scalar] = ''.TRUE.'', an additional source/sink term is added to the prognostic equation of the respective scalar.\\ If [../plant_canopy_parameters#canopy_drag_coeff canopy_drag_coeff] = 0.0, the additional terms equal zero and there would be no effect on the flow. || ||[=#PA0042 PA0042] ||use_top_fluxes must be .TRUE. in ocean mode ||In [../initialization_parameters#ocean ocean] mode, fluxes at the water surface must be prescribed as driving boundary conditions. In atmosphere-ocean coupled runs, these fluxes are provided by the atmosphere run. || ||[=#PA0043 PA0043] ||ABS( alpha_surface = ... ) must be< 90.0 ||Upright surfaces are not allowed in case of sloping surfaces. || ||[=#PA0044 PA0044] ||dt = ... <= 0.0 || The parameter [../initialization_parameters#dt dt] (time step for the 3d-model) must not be set to a value <= 0.0. || ||[=#PA0045 PA0045] ||cfl_factor = ... out of range 0.0 < cfl_factor <= 1.0 is required ||The Courant-Friedrichs-Levy factor used in the timestep condition must be within the given limits. See also [../initialization_parameters#cfl_factor cfl_factor ]. || ||[=#PA0046 PA0046] ||baroclinity (ug) not allowed simultaneously with galilei transformation ||The Galilei coordinate transformation (see [../initialization_parameters#galilei_transformation galilei_transformation]) is not allowed under baroclinic conditions (where the geostrophic wind varies with height). Modify either [../initialization_parameters#ug_surface ug_surface] or [../initialization_parameters#galilei_transformation galilei_transformation], or set [../initialization_parameters#use_ug_for_galilei_tr use_ug_for_galilei_tr] = ''.FALSE.'' appropriately in the parameter file. || ||[=#PA0047 PA0047] ||baroclinity (vg) not allowed simultaneously with galilei transformation ||The Galilei coordinate transformation (see [../initialization_parameters#galilei_transformation galilei_transformation]) is not allowed under baroclinic conditions (where the geostrophic wind varies with height). Modify either [../initialization_parameters#vg_surface vg_surface], or [../initialization_parameters#galilei_transformation galilei_transformation] appropriately, or set [../initialization_parameters#use_ug_for_galilei_tr use_ug_for_galilei_tr] = ''.FALSE.'' in the parameter file. || ||[=#PA0048 PA0048] ||variable translation speed used for Galilei-transformation, which may cause instabilities in stably stratified regions ||You have set both [../initialization_parameters#galilei_transformation galilei_transformation] = ''.TRUE.'' and [../initialization_parameters#use_ug_for_galilei_tr use_ug_for_galilei_tr] = ''.FALSE.'', which means that the translation velocity to be used in the Galilei transformation will be newly calculated after every timestep. From past experiences, this may cause numerical flow instabilities within stably stratified, non-turbulent regions. || ||[=#PA0049 PA0049] ||unknown boundary condition: bc_lr = "..." ||See parameter [../initialization_parameters#bc_lr bc_lr] for allowed values, and appropriately correct your parameter file. || ||[=#PA0050 PA0050] ||unknown boundary condition: bc_ns = "..." ||See parameter [../initialization_parameters#bc_ns bs_ns] for allowed values, and appropriately correct your parameter file. || ||[=#PA0051 PA0051] ||non-cyclic lateral boundaries do not allow psolver = "..." with FFT method = "..." ||In case of non-cyclic lateral boundary conditions, the FFT solver requires the FFT methods ''fftw'', ''temperton-algorithm'', or ''singleton-algorithm''. Please set parameter [../initialization_parameters#fft_method fft_method] appropriately. Alternatively, you can choose the multigrid solver by setting the parameter [../initialization_parameters#psolver psolver] = '' 'multigrid' '' or '' 'multigrid_noopt' ''. || ||[=#PA0052 PA0052] ||non-cyclic lateral boundaries do not allow momentum_advec = "..." ||Using non-cyclic lateral boundary conditions requires to use either the Wicker-Skamarock or the Piacsek-Williams advection scheme for momentum. You can choose one of these methods by setting the parameter [../initialization_parameters#momentum_advec momentum_advec]. || ||[=#PA0053 PA0053] ||non-cyclic lateral boundaries do not allow scalar_advec = "..." ||Using non-cyclic lateral boundary conditions requires to use either the Wicker-Skamarock or Piacsek-Williams advection scheme for scalar quantities. You can choose one of these methods by setting the parameter [../initialization_parameters#scalar_advec scalar_advec]. || ||[=#PA0054 PA0054] ||non-cyclic lateral boundaries do not allow galilei_transformation = .T. ||The Galilei coordinate transformation can only be used with cyclic horizontal boundary conditions. Either use [../initialization_parameters#bc_lr bc_lr] = [../initialization_parameters#bc_ns bc_ns] = '' 'cyclic' '', or set [../initialization_parameters#galilei_transformation galilei_transformation] = ''.FALSE.'' in the parameter file.|| ||[=#PA0055 PA0055] ||turbulent_inflow = .T. requires initializing_actions = 'cyclic_fill' or initializing_actions = 'read_restart_data' ||Using a turbulent inflow requires that the 3d arrays have to be initialized by cyclically repeated data from a prerun or by restart data. Set parameter [../initialization_parameters#initializing_actions initializing_actions] appropriately and follow the instructions at [../examples/turbinf turbulent inflow]. || ||[=#PA0056 PA0056] ||illegal value for reference_state: "..." ||See parameter [../initialization_parameters#reference_state reference_state] for allowed values, and appropriately correct your parameter file. || ||[=#PA0057 PA0057] ||boundary condition bc_e_b changed to "..." ||You have set both [../initialization_parameters#bc_e_b bc_e_b] = {{{(u*)**+neumann}}}, and [../initialization_parameters#constant_flux_layer constant_flux_layer] = ''.FALSE.'', which is in conflict, since this type of boundary condition requires a constant flux layer. [../initialization_parameters#bc_e_b bc_e_b] has been set to '' 'neumann' '' instead. || ||[=#PA0058 PA0058] ||unknown boundary condition: bc_e_b = "..." ||See parameter [../initialization_parameters#bc_e_b bc_e_b] for allowed values, and appropriately correct your parameter file. || ||[=#PA0059 PA0059] ||unknown boundary condition: bc_p_b = "..." ||See parameter [../initialization_parameters#bc_p_b bc_p_b] for allowed values, and appropriately correct your parameter file. || ||[=#PA0060 PA0060] || Output at every timestep is wanted ("dt_..." = 0.0). The output interval is set to the fixed timestep dt = "..."s. || Occurs only when [../runtime_parameters#netcdf_data_format netcdf_data_format] > 4 and [../runtime_parameters#dt dt] /= -1 as an informative message. When using parallel NetCDF the output time interval must be >0. Using dt_do = 0.0 (output at every time step) is equal to setting the output interval to [../runtime_parameters#dt dt]. || ||[=#PA0061 PA0061] ||unknown boundary condition: bc_p_t = "..." ||See parameter [../initialization_parameters#bc_p_t bc_p_t] for allowed values, and appropriately correct your parameter file. || ||[=#PA0062 PA0062] ||unknown boundary condition: bc_pt_b = "..." ||See parameter [../initialization_parameters#bc_pt_b bc_pt_b] for allowed values, and appropriately correct your parameter file. || ||[=#PA0063 PA0063] ||unknown boundary condition: bc_pt_t = "..." ||See parameter [../initialization_parameters#bc_pt_t bc_pt_t] for allowed values, and appropriately correct your parameter file. || ||[=#PA0064 PA0064] ||both, top_momentumflux_u AND top_momentumflux_v must be set ||If you want to give a momentum flux as top boundary condition, you have to give both components [../initialization_parameters#top_momentumflux_u top_momentumflux_u] and [../initialization_parameters#top_momentumflux_v top_momentumflux_v] at the same time. || ||[=#PA0065 PA0065] ||boundary_condition: bc_pt_b = "..." is not allowed with constant_heatflux = .TRUE. ||You have tried to set both, a Dirichlet surface boundary condition for temperature (with [../initialization_parameters#bc_pt_b bc_pt_b] = '' 'dirichlet' ''), and a surface sensible heatflux (with [../initialization_parameters#surface_heatflux surface_heatflux] /= ''0.0''). Please decide, if you like to give either the surface temperature or the surface heatflux as boundary condition, and omit one of the two parameters in the parameter file. || ||[=#PA0066 PA0066] ||constant_heatflux = .TRUE. is not allowed with pt_surface_initial_change (/=0) = ... ||If you give the sensible heatflux as surface boundary condition (using parameter [../initialization_parameters#surface_heatflux surface_heatflux]), you must not specify anything about the surface temperature at the same time (e.g. with parameter [../initialization_parameters#pt_surface_initial_change pt_surface_initial_change]). || ||[=#PA0067 PA0067] ||boundary_condition: bc_pt_t = "..." is not allowed with constant_top_heatflux = .TRUE. ||You have tried to set both, a Dirichlet boundary condition for temperature at the top (with [../initialization_parameters#bc_pt_t bc_pt_t] = '' 'dirichlet' ''), and a sensible heatflux at the top (with [../initialization_parameters#top_heatflux top_heatflux] /= ''0.0''). Please decide, if you like to give either the temperature or the heatflux as boundary condition at the top, and omit one of the two parameters in the parameter file. || ||[=#PA0068 PA0068] ||unknown boundary condition: bc_sa_t = "..." ||See parameter [../initialization_parameters#bc_sa_t bc_sa_t] for allowed values, and appropriately correct your parameter file. || ||[=#PA0069 PA0069] ||boundary condition: bc_sa_t = "..." requires to set top_salinityflux ||You have chosen a Neumann boundary condition for salinity at the top (by setting [../initialization_parameters#bc_sa_t bc_sa_t] = '' 'neumann' ''), but you did not provide a salinity flux at the top. Please provide parameter [../initialization_parameters#top_salinityflux top_salinityflux] in the parameter file. || ||[=#PA0070 PA0070] ||boundary condition: bc_sa_t = "..." is not allowed with top_salinityflux /= 0.0' ||You have tried to set both, a Dirichlet boundary condition for salinity at the top (with [../initialization_parameters#bc_sa_t bc_sa_t] = '' 'dirichlet' ''), and a salinity flux at the top (with [../initialization_parameters#top_salinityflux top_salinityflux] /= ''0.0''). Please decide, if you like to give either the salinity or the salinity flux as top boundary condition, and omit one of the two parameters in the parameter file. || ||[=#PA0071 PA0071] ||unknown boundary condition: bc_..._b ="..." ||See the respective parameter description in the [../initialization_parameters documentation], and appropriately correct your parameter file. || ||[=#PA0072 PA0072] ||unknown boundary condition: bc_..._t ="..." ||See the respective parameter description in the [../initialization_parameters documentation], and appropriately correct your parameter file. || ||[=#PA0073 PA0073] ||boundary condition: bc_..._b = "..." is not allowed with prescribed surface flux ||You have tried to set both, a Dirichlet surface boundary condition for humidity / passive scalar (with [../initialization_parameters#bc_q_b bc_q_b] / [../initialization_parameters#bc_s_b bc_s_b] = '' 'dirichlet' ''), and a surface latent heatflux / scalar flux (with [../initialization_parameters#surface_waterflux surface_waterflux] / [../initialization_parameters#surface_scalarflux surface_scalarflux] /= ''0.0''). Please decide, if you like to give either the surface humidity / scalar or the surface latent heatflux / scalar flux as boundary condition, and omit one of the two parameters in the parameter file. || ||[=#PA0074 PA0074] ||a prescribed surface flux is not allowed with ..._surface_initial_change (/=0) = ... ||If you give the latent heatflux / scalar flux as surface boundary condition (using parameter [../initialization_parameters#surface_waterflux surface_waterflux] / [../initialization_parameters#surface_scalarflux surface_scalarflux]), you must not specify anything about the surface humidity / scalar at the same time (e.g. with parameter [../initialization_parameters#q_surface_initial_change q_surface_initial_change] / [../initialization_parameters#s_surface_initial_change s_surface_initial_change]). || ||[=#PA0075 PA0075] ||boundary condition: bc_uv_b = "..." is not allowed with constant_flux_layer = .TRUE. ||You have tried to set both, a Neumann surface boundary condition for horizontal velocity (with [../initialization_parameters#bc_uv_b bc_uv_b] = '' 'neumann' ''), and a constant flux layer between the surface and the first vertical grid point (with [../initialization_parameters#constant_flux_layer constant_flux_layer] = ''.TRUE.''), which are contradicting conditions. Either set [../initialization_parameters#constant_flux_layer constant_flux_layer] = ''.FALSE.'' or [../initialization_parameters#bc_uv_b bc_uv_b] = '' 'dirichlet' '' in the parameter file. || ||[=#PA0076 PA0076] ||unknown boundary condition: bc_uv_b = "..." ||See parameter [../initialization_parameters#bc_uv_b bc_uv_b] for allowed values, and appropriately correct your parameter file. || ||[=#PA0077 PA0077] ||unknown boundary condition: bc_uv_t = "..." ||See parameter [../initialization_parameters#bc_uv_t bc_uv_t] for allowed values, and appropriately correct your parameter file. || ||[=#PA0078 PA0078] ||rayleigh_damping_factor = ... out of range [0.0,1.0] ||Adjust the value of [../initialization_parameters#rayleigh_damping_factor rayleigh_damping_factor] in your parameter file to the allowed range. || ||[=#PA0079 PA0079] ||rayleigh_damping_height = ... out of range [0.0, ...] ||Adjust the value of [../initialization_parameters#rayleigh_damping_height rayleigh_damping_height] in your parameter file to the allowed range. This error may appear if you have reduced the domain height in your current run (e.g. by reducing the number of vertical grid points) without adjusting the height at which Rayleigh damping shall start. || ||[=#PA0080 PA0080] ||preprocessor switch for fftw is missing ||You have set [../initialization_parameters#fft_method fft_method] = '' 'fftw' '', but the fftw-code has not been activated by the corresponding cpp-preprocessor switch. Add '' {{{'-D__fftw'}}} '' to the {{{%cpp_options}}} line in the configuration file, touch file {{{fft_xy.f90}}} (e.g. by executing command {{{"touch trunk/SOURCE/fft_xy.f90"}}} and re-compile (i.e. call {{{palmbuild}}}. || ||[=#PA0081 PA0081] || "..." = 0.0 while using a variable timestep and parallel netCDF4 is not allowed. || When using parallel NetCDF output ([../runtime_parameters#netcdf_data_format netcdf_data_format]>4) the number of output time levels must be calculated in the beginning of the simulation (see e.g. [#PA0384]). With a variable time step it is not possible to determine how many output time levels are needed to do an output at every time step. Therefore you have to set a fixed time step [../initialization_parameters#dt dt]. || ||[=#PA0082 PA0082] ||number of statistic_regions = ... is not allowed ||Adjust parameter [../initialization_parameters#statistic_regions statistic_regions] in your parameter file to a value >= ''0''. || ||[=#PA0083 PA0083] ||normalizing_region = ... must be >= 0 and <= ... (value of statistic_regions) ||The region number given by [../runtime_parameters#normalizing_region normalizing_region] must be within the range [0, [../initialization_parameters#statistic_regions statistic_regions] ]. Adjust [../runtime_parameters#normalizing_region normalizing_region] appropriately in your parameter file. || ||[=#PA0084 PA0084] || urban surface model requires ... ||When using the USM it is required to use a [../initialization_parameters#constant_flux_layer constant_flux_layer] and the [../radiation_parameters#RadiationParameters radiation model]. || ||[=#PA0085 PA0085] ||averaging_interval = ... must be <= dt_data_output_av = ... ||The [../runtime_parameters#averaging_interval averaging_interval] for averaged output data must be smaller or equal to the output interval given by [../runtime_parameters#dt_data_output dt_data_output] or [../runtime_parameters#dt_data_output_av dt_data_output_av]. Adjust settings of these variables appropriately in the parameter file. || ||[=#PA0086 PA0086] ||averaging_interval_pr = ... must be <= dt_dopr = ... ||The [../runtime_parameters#averaging_interval_pr averaging_interval_pr] for profile output data must be smaller or equal to the output interval given by [../runtime_parameters#dt_dopr dt_dopr]. Adjust settings of these variables appropriately in the parameter file. || ||[=#PA0087 PA0087] ||averaging_interval_sp = ... must be <= dt_dosp = ... ||The [../spectra_parameters#averaging_interval_sp averaging_interval_sp] for spectra output data must be smaller or equal to the output interval given by [../spectra_parameters#dt_dosp dt_dosp]. Adjust settings of these variables appropriately in the parameter file. || ||[=#PA0088 PA0088] ||dt_averaging_input = ... must be <= averaging_interval = ... ||The sampling interval (set by [../runtime_parameters#dt_averaging_input dt_averaging_input]) for averaging data must be less or equal to the averaging interval (set by [../runtime_parameters#averaging_interval averaging_interval]). Adjust settings of these variables appropriately in the parameter file. || ||[=#PA0089 PA0089] ||dt_averaging_input_pr = ... must be <= averaging_interval_pr = ... ||The sampling interval (set by [../runtime_parameters#dt_averaging_input_pr dt_averaging_input_pr]) for averaging profile data must be less or equal to the averaging interval (set by [../runtime_parameters#averaging_interval_pr averaging_interval_pr]). Adjust settings of these variables appropriately in the parameter file. || ||[=#PA0090 PA0090] ||precipitation_amount_interval = ... must not be larger than dt_do2d_xy = ... ||Choose a value for [../runtime_parameters#precipitation_amount_interval precipitation_amount_interval] smaller than or equal to [../runtime_parameters#dt_do2d_xy dt_do2d_xy]. Adjust the settings of [../runtime_parameters#precipitation_amount_interval precipitation_amount_interval] appropriately in the parameter file.|| ||[=#PA0091 PA0091] ||wrong component of Stokes force: ... ||Only the two Cartesian components 2 and 3 are allowed for the Stokes force in ocean mode. || ||[=#PA0092 PA0092] ||data_output_pr = ... is not implemented for humidity = .FALSE. ||The listed entries in the parameter file under [../runtime_parameters#data_output_pr data_output_pr] are only available for [../initialization_parameters#humidity humidity]= .T.. There could also be a typo in [../runtime_parameters#data_output_pr data_output_pr] (an output variable was used that does not exist in PALM). || ||[=#PA0093 PA0093] ||data_output_pr = ... is not implemented for passive_scalar = .FALSE. ||The listed entries in the parameter file under [../runtime_parameters#data_output_pr data_output_pr] are only available for [../initialization_parameters#passive_scalar passive_scalar]= .T.. There could also be a typo in [../runtime_parameters#data_output_pr data_output_pr] (an output variable was used that does not exist in PALM).|| ||[=#PA0094 PA0094] ||data_output_pr = ... is not implemented for bulk_cloud_model = .FALSE. ||The listed entries in the parameter file under [../runtime_parameters#data_output_pr data_output_pr] are only available for [../bulk_cloud_parameters#bulk_cloud_model bulk_cloud_model]= .T.. There could also be a typo in [../runtime_parameters#data_output_pr data_output_pr] (an output variable was used that does not exist in PALM). || ||[=#PA0095 PA0095] ||data_output_pr = ... is not implemented for bulk_cloud_model = .FALSE. and humidity = .FALSE. ||The listed entries in the parameter file under [../runtime_parameters#data_output_pr data_output_pr] are only available for [../bulk_cloud_parameters#bulk_cloud_model bulk_cloud_model]= .T. or [../bulk_cloud_parameters#bulk_cloud_model bulk_cloud_model]= .F. and [../initialization_parameters#humidity humidity]=.T.. There could also be a typo in [../runtime_parameters#data_output_pr data_output_pr] (an output variable was used that does not exist in PALM).|| ||[=#PA0096 PA0096] ||data_output_pr = ... is not implemented for bulk_cloud_model = .FALSE. and cloud_droplets = .FALSE. ||The listed entries in the parameter file under [../runtime_parameters#data_output_pr data_output_pr] are only available for [../initialization_parameters#cloud_droplets cloud_droplets]= .T. or [../bulk_cloud_parameters#bulk_cloud_model bulk_cloud_model]=.T.. There could also be a typo in [../runtime_parameters#data_output_pr data_output_pr] (an output variable was used that does not exist in PALM). || ||[=#PA0097 PA0097] ||illegal value for data_output_pr or data_output_pr_user = "..." ||No matching variable was found for the given identifier in the parameter file. Possible reasons are: (a) a typo in the parameter file, (b) a user-defined variable has not been defined in {{{user_check_data_output.f90}}}, (c) the string length of the user-defined variable exceeds the current limits (see [../userint/output here]). || ||[=#PA0098 PA0098] ||illegal value for data_output_pr = "..." ||No matching variable was found for the given identifier in the parameter file. This error is most likely related to a typo in the parameter file (a output variable was used that does not exist in PALM). || ||[=#PA0100 PA0099] ||netCDF: netCDF4 parallel output requested but no cpp-directive !__netcdf4_parallel given, switch back to netCDF4 non-parallel output ||[../runtime_parameters#netcdf_data_format netcdf_data_format ] > 4 has been set. This requires netCDF4 features including parallel file support, which have to be activated by setting the cpp-switches {{{-D__netcdf4}}} '''and''' {{{-D__netcdf4_parallel}}} in the configuration file ({{{%cpp_options}}}). It also requires a netCDF4 library which supports parallel I/O. Set {{{-I}}}, {{{-L}}} and {{{-l}}} options in compile ({{{%compiler_options}}}) and load ({{{%linker_options}}}) options of the configuration file appropriately. \\\\ Job will be continued with {{{netcdf_data_format = netcdf_data_format - 2}}}. || ||[=#PA0100 PA0100] ||momentum_advec of the restart run differs from momentum_advec of the initial run ||The advection scheme for the momentum equations [../initialization_parameters#momentum_advec momentum_advec] used in the restart run differs from the advection scheme used in the corresponding initial run. The advection scheme that is used in a restart run must be the same as the one that was used in the initial run. || ||[=#PA0101 PA0101] ||scalar_advec of the restart run differs from scalar_advec of the initial run ||The advection scheme for scalar quantities [../initialization_parameters#scalar_advec scalar_advec] used in the restart run differs from the advection scheme used in the corresponding initial run. The advection scheme that is used in a restart run must be the same as the one that was used in the initial run. || ||[=#PA0102 PA0102] ||number of output quantities given by data_output and data_output_user exceeds the limit of 500 || The total number of output quantities listed in [../runtime_parameters#data_output data_output] and [../user_parameters#data_output_user data_output_user] exceeds the maximum of 500. To increase this limit, the standard PALM code has to be modified. In case you have little experience with the PALM code use a [/newticket trouble ticket] for a query to increase the maximum output number. || ||[=#PA0103 PA0103] ||output of "e" requires constant_diffusion = .FALSE. ||Output of the subgrid TKE e listed in the parameter file under [../runtime_parameters#data_output data_output] or [../runtime_parameters#data_output_masks data_output_masks] is only available for [../initialization_parameters#constant_diffusion constant diffusion]= .F.. || ||[=#PA0104 PA0104] ||output of "..." requires a "particles_par"-NAMELIST in the parameter file (PARIN) ||Output of the particle concentration pc and/or particle radius pr listed in the parameter file under [../runtime_parameters#data_output data_output] or [../runtime_parameters#data_output_masks data_output_masks] is only available in case the [http://palm.muk.uni-hannover.de/wiki/doc/app/particle_parameters particle_parameters] namelist is set in the parameter file || ||[=#PA0105 PA0105] ||output of "..." requires humidity = .TRUE. ||Output of humidity (q and/or vpt) listed in the parameter file under [../runtime_parameters#data_output data_output] or [../runtime_parameters#data_output_masks data_output_masks] is only available for [../initialization_parameters#humidity humidity]= .T.. || ||[=#PA0106 PA0106] ||output of "ql" requires bulk_cloud_model = .TRUE. or cloud_droplets = .TRUE. ||Output of liquid water content ql listed in the parameter file under [../runtime_parameters#data_output data_output] or [../runtime_parameters#data_output_masks data_output_masks] is only available for [../bulk_cloud_parameters#bulk_cloud_model bulk_cloud_model]= .T. or [../initialization_parameters#cloud_droplets cloud_droplets]= .T.. || ||[=#PA0107 PA0107] ||output of "..." requires cloud_droplets = .TRUE. || The quantities ql_c, ql_v, ql_vp are only calculated in case of [../initialization_parameters#cloud_droplets cloud_droplets] = ''.T.''. || ||[=#PA0108 PA0108] ||output of "..." requires bulk_cloud_model = .TRUE. || For the output of some quantities related to clouds and humidity [../bulk_cloud_parameters#bulk_cloud_model bulk_cloud_model]= ''.T.'' must be set. For example, the water vapor mixing ratio qv requires [../bulk_cloud_parameters#bulk_cloud_model bulk_cloud_model]= ''.T.''. Also, [../initialization_parameters#humidity humidity] = ''.T.'' must be set. If you want to simulate the humidity without condensation/evaporation processes, use only [../initialization_parameters#humidity humidity] = ''.T.'' and choose output quantity q for output of the water vapor mixing ratio. || ||[=#PA0109 PA0109] ||output of "..." requires ocean mode || The quantities rho_ocean and sa are only calculated in case that ocean mode has been activated by giving the {{{&ocean_parameters}}} namelist. || ||[=#PA0110 PA0110] ||output of "s" requires passive_scalar = .TRUE. || The output of the passive scalar s is only available if the prognostic equation for a passive scalar is solved by setting [../initialization_parameters#passive_scalar passive_scalar] = ''.T.''. || ||[=#PA0111 PA0111] ||illegal value for data_output: "..." only 2d-horizontal cross sections are allowed for this value ||The listed quantities are pure two-dimensional xy-cross-sections. They are not available as 3d data or xz/yz cross-sections. Note that these quantities are always marked by an asterisk as last character. See also [../runtime_parameters#data_output data_output]. || ||[=#PA0112 PA0112] ||output of "..." requires cloud_scheme = kessler or seifert_beheng ||The quantities pra* and prr* are only calculated if [../initialization_parameters#cloud_scheme cloud_scheme] = kessler or [../initialization_parameters#cloud_scheme cloud_scheme] = seifert_beheng. || ||[=#PA0113 PA0113] ||temporal averaging of precipitation amount "pra*" is not possible ||The quantity precipitation_amount pra* listed in [../runtime_parameters#data_output data_output] contains already the summed precipitation of the last [../runtime_parameters#precipitation_amount_interval precipitation_amount_interval]. Therefore, remove the substring _av of pra*. || ||[=#PA0114 PA0114] ||illegal value for data_output or data_output_user = "..." || No matching variable was found for the given identifier in the parameter file. Possible reasons are: (a) a typo in the parameter file, (b) a user-defined variable has not been defined in {{{user_check_data_output.f90}}}, (c) the string length of the user-defined variable exceeds the current limits (see [../userint/output here]). || ||[=#PA0115 PA0115] ||illegal value for data_output = "..." || No matching variable was found for the given identifier in the parameter file. This error is most likely related to a typo in the parameter file (a output variable was used that does not exist in PALM). For possible output quantities see [../runtime_parameters#data_output data_output]. || ||[=#PA0116 PA0116] || to_netcdf = .True. requires parallel NetCDF || surface output with NetCDF requires parallel NetCDF || ||[=#PA0117 PA0117] ||pointer for array ".." can't be associated ||This is an internal error message from the pmc (PALM model coupler) which is responsible for data exchange in nested runs. Please submit a trouble ticket if you are sure that you did not modify the source code of the model coupler ({{{pmc_interface_mod.f90}}}). || ||[=#PA0118 PA0118] ||using the beta function for the construction of the leaf area density profile requires both alpha_lad and beta_lad to be /= 9999999.9 ||If the lad (leaf area density) profile of a vegetation canopy is to be constructed using a beta distribution, parameters [/wiki/doc/app/plant_canopy_parameters#alpha_lad alpha_lad], [/wiki/doc/app/plant_canopy_parameters#beta_lad beta_lad] must be set and [/wiki/doc/app/plant_canopy_parameters#lai_beta lai_beta] must be given a non-zero value. || ||[=#PA0119 PA0119] ||using the beta function for the construction of the leaf area density profile requires a non-zero lai_beta, but given value is lai_beta = 0.0 ||If the lad (leaf area density) profile of a vegetation canopy is to be constructed using a beta distribution, parameters [/wiki/doc/app/plant_canopy_parameters#alpha_lad alpha_lad], [/wiki/doc/app/plant_canopy_parameters#beta_lad beta_lad] must be set and [/wiki/doc/app/plant_canopy_parameters#lai_beta lai_beta] must be given a non-zero value. || ||[=#PA0120 PA0120] ||simultaneous setting of alpha_lad /= 9999999.9 combined with beta_lad /= 9999999.9 and lad_surface /= 0.0 is not possible, use either vertical gradients or the beta function for the construction of the leaf area density profile ||The lad (leaf area density) profile of a vegetation canopy can be either constructed with a beta function by prescribing parameters [/wiki/doc/app/plant_canopy_parameters#alpha_lad alpha_lad], [/wiki/doc/app/plant_canopy_parameters#beta_lad beta_lad] and [/wiki/doc/app/plant_canopy_parameters#lai_beta lai_beta]; or from piecewise linear segments by prescribing [/wiki/doc/app/plant_canopy_parameters#lad_surface lad_surface], [/wiki/doc/app/plant_canopy_parameters#lad_vertical_gradient lad_vertical_gradient] and [/wiki/doc/app/plant_canopy_parameters#lad_vertical_gradient_level lad_vertical_gradient_level]. || ||[=#PA0121 PA0121] ||km_constant = ... < 0.0 ||The eddy-diffusivity km has to be positive definite. Change the value of [../initialization_parameters#km_constant km_constant] accordingly. || ||[=#PA0122 PA0122] ||prandtl_number = ... < 0.0 ||The Prandtl number Pr has to be positive definite. Change the value of [../initialization_parameters#prandtl_number prandtl_number] accordingly. || ||[=#PA0123 PA0123] ||constant_flux_layer is not allowed with fixed value of km ||For laminar flows with a constant eddy diffusivity [../initialization_parameters#km_constant km_constant]= ..., the constant flux layer has to be switched off via [../initialization_parameters#constant_flux_layer constant_flux_layer]=.F.. || {{{#!tr {{{#!td [=#PA0124 PA0124] }}} {{{#!td pt_damping_width out of range }}} {{{#!td In case of non-cyclic lateral boundary conditions, the parameter [../initialization_parameters#pt_damping_width pt_damping_width] should not be lesser than zero or greater than the model domain length in the respective direction. \\ In case of bc_lr /= 'cyclic', [../initialization_parameters#pt_damping_width pt_damping_width] must satisfy: {{{#!Latex 0 <= pt\_damping\_width <= (nx+1) * dx \; , }}} and in case of bc_ns /= 'cyclic': {{{#!Latex 0 <= pt\_damping\_width <= (ny+1) * dy \; . }}} ([../initialization_parameters#nx nx]+1), ([../initialization_parameters#ny ny]+1) are the total number of grid points and [../initialization_parameters#dx dx], [../initialization_parameters#dy dy] the grid lengths in the x-, y-direction, respectively. }}} }}} ||[=#PA0125 PA0125] ||zeta_min = ... must be less than zeta_max = ... ||The stability parameter {{{zeta=z_mo/L}}} ({{{z_mo}}}: height of the constant flux layer, {{{L}}}: Obukhov length) that is calculated interactively in PALM can be limited to prevent reaching unrealistic values under certain circumstances. Make sure that [../initialization_parameters#zeta_min zeta_min] is smaller than [../initialization_parameters#zeta_max zeta_max]. || ||[=#PA0126 PA0126] ||disturbance_level_b = ... must be >= ... (zu(3)) ||Due to technical reasons the lower disturbance level given by [../runtime_parameters#disturbance_level_b disturbance_level_b] has to be larger than or equal zu(3). || ||[=#PA0127 PA0127] ||disturbance_level_b = ... must be <= ... (zu(nzt-2)) ||Due to technical reasons the lower disturbance level given by [../runtime_parameters#disturbance_level_b disturbance_level_b] has to be smaller than or equal zu(nzt-2). || ||[=#PA0128 PA0128] ||disturbance_level_t = ... must be <= ... (zu(nzt-2)) ||Due to technical reasons the upper disturbance level given by [../runtime_parameters#disturbance_level_t disturbance_level_t] has to be smaller than or equal zu(nzt-2). || ||[=#PA0129 PA0129] ||disturbance_level_t = ... must be >= disturbance_level_b = ... ||Ensure that [../runtime_parameters#disturbance_level_t disturbance_level_t] is larger than or equal [../runtime_parameters#disturbance_level_b disturbance_level_b] to obtain at least one layer where disturbances are added. || ||[=#PA0130 PA0130] ||disturbance_level_ind_t =... must be >= disturbance_level_ind_b = ... ||This error may occur when the lower and upper disturbance levels [../runtime_parameters#disturbance_level_b disturbance_level_b] and [../runtime_parameters#disturbance_level_t disturbance_level_t] are calculated automatically and there are two few grid points in the vertical direction. There have to be at least seven vertical levels. || ||[=#PA0131 PA0131] ||inflow_disturbance_begin out of range || The parameter [../initialization_parameters#inflow_disturbance_begin inflow_disturbance_begin] gives the number of grid points (counted horizontally from the inflow) from which on perturbations are imposed on the horizontal velocity field. This value must not be smaller than zero or larger than nx (in case of non-cyclic lateral boundary conditions along the x-direction) or ny (in case of non-cyclic lateral boundary conditions along the y-direction). || ||[=#PA0132 PA0132] ||inflow_disturbance_end out of range || The parameter [../initialization_parameters#inflow_disturbance_end inflow_disturbance_end] gives the number of grid points (counted horizontally from the inflow) up to which perturbations are imposed on the horizontal velocity field. This value must not be smaller than zero or larger than nx (in case of non-cyclic lateral boundary conditions along the x-direction) or ny (in case of non-cyclic lateral boundary conditions along the y-direction). || ||[=#PA0133 PA0133] ||turbulent_inflow = .T. requires a Dirichlet condition at the inflow boundary || In case of turbulent inflow the turbulence signal is added to a time-constant horizontal mean wind profile at the left inflow boundary at each timestep. The use of a time-constant mean wind profile requires a Dirichlet boundary condition at the left inflow boundary. For further information please see: [../../tec/noncyclic nonclyclic boundary conditions] as well as [../examples/turbinf turbulent inflow]. || ||[=#PA0134 PA0134] ||illegal value for recycling_width: ... || See parameter [../initialization_parameters#recycling_width recycling_width] for allowed values, and appropriately correct your parameter file. || ||[=#PA0135 PA0135] ||unknown random generator: random_generator = "..." ||See parameter [../initialization_parameters#random_generator random_generator] for allowed values, and appropriately correct your parameter file. || ||[=#PA0136 PA0136] ||damp_level_1d = ... must be >= 0.0 and <= ... (zu(nzt+1)) ||The value of [../initialization_parameters#damp_level_1d damp_level_1d] must be within the range [0, zu(nzt+1)] || ||[=#PA0137 PA0137] ||mixing_length_1d = "..." is unknown ||See parameter [../initialization_parameters#mixing_length_1d mixing_length_1d] for allowed values, and appropriately correct your parameter file. || ||[=#PA0138 PA0138] ||dissipation_1d = "..." is unknown ||See parameter [../initialization_parameters#dissipation_1d dissipation_1d] for allowed values, and appropriately correct your parameter file. || ||[=#PA0139 PA0139] ||'pavement_type = 0 (user_defined) requires setting of pavement_heat_conduct /= 9999999.9 ||In case of a user-defined pavement type, the heat conductivity of the pavement must be given || ||[=#PA0140 PA0140] || invalid soil layer configuration found (dz_soil_center(k) <= 0.0) ||By setting zs (the center of the soil layers), the depths of the individual layers is calculated by PALM itself. This errors points towards a misconfiguration because a soil level is set within an already established soil layer. Check [../land_surface_parameters#dz_soil dz_soil]. || ||[=#PA0142 PA0142] ||absolute temperature < 0.0 at zu(...) = ... || Within the PALM code (in {{{bcm_init}}}), the hydrostatic pressure profile is calculated for a neutrally stratified temperature profile {{{t(z) = t_surface-g/c_p*z(k)}}}. If the height of the model domain is too large, the absolute temperature will become negative, which is not allowed. This error usually appears when both grid stretching is switched on and too many grid points along z are used. Try to reduce the number of grid points ([../initialization_parameters#nz nz]), switch on the grid stretching at larger heights (see [../initialization_parameters#dz_stretch_level dz_stretch_level]) or reduce the grid stretching factor ([../initialization_parameters#dz_stretch_factor dz_stretch_factor]). || ||[=#PA0143 PA0143] || k=... j=... i=... ql_c=... part(...)%wf=... delta_r=... ||This error occurs due to a spurious interaction of the production and depletion of supersaturations if the applied time step is too large. Please re-run the simulation with a shorter time step. || ||[=#PA0144 PA0144] || #1 k=... j=... i=... e_s=... e_a=... t_int=... delta_r=... particle_radius=... ||This error occurs if the droplet radius becomes negative. This might be related to a too long time step or an (artificial?) accumulation of super-droplets in one grid cell. || ||[=#PA0145 PA0145] || illegal value for outflow_source_plane:... || The position of the source plane for the turbulent outflow method is not given or outside the model domain. Assign a value inside the model domain: dx <= [../initialization_parameters#outflow_source_plane outflow_source_plane] <= nx*dx || ||[=#PA0146 PA0146] ||unknown splitting mode = "..." || See parameter [../particle_parameters#splitting_mode splitting_mode] for allowed values, and appropriately correct your parameter file. || ||[=#PA0147 PA0147] ||unknown splitting function = "..." || See parameter [../particle_parameters#splitting_function splitting_function] for allowed values, and appropriately correct your parameter file. || ||[=#PA0148 PA0148] ||particle too fast. n = ... || Particle has moved further than the length of one PE subdomain within on timestep. This is not allowed, since particles can only be transferred from one subdomain to the neighboring subdomain. Please check if subdomains are too small or velocities are unrealistically high. || ||[=#PA0149 PA0149] || no value specified for initializing_actions || You must specify a value for [../initialization_parameters#initializing_actions initializing_actions]. || ||[=#PA0150 PA0150] ||Both dp_external and conserve_volume_flow are .TRUE., but one of them must be .FALSE. || Simultaneous use of an external pressure gradient forcing ([../initialization_parameters#dp_external dp_external] = .TRUE.) and [../initialization_parameters#conserve_volume_flow conserve_volume_flow] is not allowed. Please correct your parameter file appropriately. || ||[=#PA0151 PA0151] ||dp_level_b = ... is out of range [zu(nzb), zu(nzt)] || [../initialization_parameters#dp_level_b dp_level_b] is outside of the vertical bounds of the model domain. Please check the prescribed value for [../initialization_parameters#dp_level_b dp_level_b] in your parameter file. || ||[=#PA0152 PA0152] ||dp_external is .TRUE. but dpdxy is zero, i.e. the external pressure gradient will not be applied || If the flow forcing shall be accomplished by an external pressure gradient, i.e. [../initialization_parameters#dp_external dp_external] is .TRUE., [../initialization_parameters#dpdxy dpdxy] must be set to a non-zero value in your parameter file. || ||[=#PA0153 PA0153] ||dpdxy is nonzero but dp_external is .FALSE., i.e. the external pressure gradient will not be applied || If the flow forcing shall be accomplished by an external pressure gradient, i.e. [../initialization_parameters#dpdxy dpdxy] is set to a non-zero value, [../initialization_parameters#dp_external dp_external] = .TRUE. must be set in your parameter file. || ||[=#PA0154 PA0154] ||unknown conserve_volume_flow_mode: ... || See parameter [../initialization_parameters#conserve_volume_flow_mode conserve_volume_flow_mode] for allowed values, and appropriately correct your parameter file. || ||[=#PA0155 PA0155] ||noncyclic boundary conditions require conserve_volume_flow_mode = "initial_profiles" || See parameter [../initialization_parameters#conserve_volume_flow_mode conserve_volume_flow_mode] for allowed values. [../initialization_parameters#conserve_volume_flow_mode conserve_volume_flow_mode] = 'bulk_velocity' is not allowed when you are using non-cyclic boundary conditions. || ||[=#PA0156 PA0156] || The number of values for dz = ... has to be the same than the number of values for dz_stretch_level_end + 1 = ... || Self-explanatory. Please add/remove values for [../initialization_parameters#dz dz] or for [../initialization_parameters#dz_stretch_level_end dz_stretch_level_end] appropriately. || ||[=#PA0157 PA0157] ||nonzero bulk velocity requires conserve_volume_flow = .T. and conserve_volume_flow_mode = "bulk_velocity" || The bulk velocity is used to prescribe a volume flow which then should be conserved. This, however, requires [../initialization_parameters#conserve_volume_flow conserve_volume_flow] = .T. and [../initialization_parameters#conserve_volume_flow_mode conserve_volume_flow_mode] = "bulk_velocity". || ||[=#PA0158 PA0158] ||no vertical boundary condition for variable "..." || Routine {{{advec_s_bc}}} which calculates the advection term for scalar quantities using the Bott-Chlond scheme was called for a variable, which does not have a specific boundary condition implemented (Adding top and bottom boundaries according to the relevant boundary conditions is not possible). This should not happen. Please submit a [/newticket trouble ticket]. || ||[=#PA0159 PA0159] ||no term for component "..." || Routine {{{buoyancy}}} was called for a different wind component than the u/w-component while an inclined surface was used. In case of an inclined surface (see [../initialization_parameters#alpha_surface alpha_surface]) the buoyancy term appears in the equation of motion of the w-component and u-component. There is no buoyancy term implemented for the v-component as the surface can only be inclined in x-direction and no buoyancy term is required for the v-component. This should not happen. Please submit a [/newticket trouble ticket]. || ||[=#PA0160 PA0160] ||non-cyclic lateral boundaries along x do not allow calculation of spectra along x || In case of non-cyclic conditions spectra would be largely affected by the non-cyclic lateral boundaries since this conflicts with the basic assumption used for the FFT that the spatial extention in the x and y-direction are infinitely large. See also [../spectra_parameters#data_output_sp data_output_sp]. || ||[=#PA0161 PA0161] ||sorry, calculation of spectra in non parallel mode is still not realized || Calculation of spectra in non-parallel mode is not implemented. || ||[=#PA0162 PA0162] ||non-cyclic lateral boundaries along y do not allow calculation of spectra along y || In case of non-cyclic conditions spectra would be largely affected by the non-cyclic lateral boundaries since this conflicts with the basic assumption used for the FFT that the spatial extention in the x and y-direction are infinitely large. See also [../spectra_parameters#data_output_sp data_output_sp]. || ||[=#PA0163 PA0163] ||run will be terminated because it is running out of job cpu limit remaining time: ... s termination time needed: ... s ||In case that [../runtime_parameters#restart_time restart_time] has not been set manually, PALM determines internally when a new restart run has to be carried out depending on the setting of [../runtime_parameters#termination_time_needed termination_time_needed]. Within the remaining time PALM will, for example, copy binary files for restart runs, archive or transfer result data. Have a look at [../runs Initialization and restart runs] for further information. || ||[=#PA0164 PA0164] ||run will be terminated due to user settings of restart_time / dt_restart, new restart time is: ... s ||A restart run is established by PALM due to the setting of [../runtime_parameters#restart_time restart_time] and/or [../runtime_parameters#dt_restart dt_restart] and the new restart time is calculated. Have a look at [../runs Initialization and restart runs] for further information. || ||[=#PA0165 PA0165] ||re-open of unit 14 is not verified. Please check results! ||The file with unit number 14 contains the binaries [../iofiles#BINOUT BINOUT]. It was opened at least a second time by user specific settings. This is not verified, so check the results carefully. || ||[=#PA0166 PA0166] ||re-opening of file-id ... is not allowed || It was tried to re-open a file, which had already been opened once during the simulation. Only certain files are allowed to be re-opened to prevent errors. If you are sure that the file can be re-opened without causing any errors, you may add the file-id to the list in routine {{{check_open}}}. See also the list of [../iofiles I/O-files]. || ||[=#PA0167 PA0167] ||opening file-id ... not allowed for PE ... || Certain files are only allowed to be opened on a certain PE (in most cases only on PE0). Please check if your file can be opened on this PE and choose a different file-id. || ||[=#PA0168 PA0168] ||opening file-id ... is not allowed since it is used otherwise || Certain file-ids are reserved for files used temporarily outside of the main program. Please refer to the list of [../iofiles I/O-files] and choose an unused file-id. || ||[=#PA0169 PA0169] ||current user-interface revision "..." does not match the required revision r.... ||You are using a user-interface which does not match the installed PALM revision. One reason might be that the default user-interface of the newest PALM revision has been changed by the PALM developers (e.g. because some parameters have been added to parameter-lists of subroutine calls). Please carefully read the [wiki:doc/tec/changelog source code change log], where these kind of changes are announced, and where also hints will be given for how to adjust existing user-interfaces. || ||[=#PA0170 PA0170] ||pointer for array ".." can't be associated ||This is an internal error message from the pmc (PALM model coupler) which is responsible for data exchange in nested runs. Please submit a trouble ticket if you are sure that you did not modify the source code of the model coupler ({{{pmc_interface_mod.f90}}}). || ||[=#PA0171 PA0171] ||netCDF: netCDF4 format requested but no cpp-directive !__netcdf4 given switch back to 64-bit offset format ||[../runtime_parameters#netcdf_data_format netcdf_data_format ] > 2 has been set. This requires netCDF4 features, which have to be activated by setting the cpp-directive {{{__netcdf4}}} in the configuration file ({{{%cpp_options}}}). It also requires a netCDF4 library. Set {{{-I}}}, {{{-L}}} and {{{-l}}} options in compile ({{{%compiler_options}}}) and load ({{{%linker_options}}}) options of the configuration file appropriately. || ||[=#PA0172 PA0172] ||no OPEN-statement for file-id ... || Routine {{{check_open}}} was called with an unknown file-id. Please check the file-id for a typo or open the file manually using an OPEN(...) statement. || ||[=#PA0173 PA0173] ||wrong component: ... || Routine {{{coriolis}}} can only be called for component 1, 2 and 3, which correspond to the wind speed components u, v and w. Other components do not exist. || ||[=#PA0174 PA0174] ||wrong argument expected: ... given: ||Internal code error in routine {{{cpu_log}}} which can measure the CPU-time of a specific code segment. This error occurs when {{{cpu_log}}} is used again with the same id for a specific code segment (first input parameter) but with a different name describing this segment (second input parameter). When you did not change the source code by yourself please inform the PALM developers. || ||[=#PA0175 PA0175] ||Tunnel width too small ||[../initialization_parameters#tunnel_width_x tunnel_width_x] - 2.0*[../initialization_parameters#tunnel_wall_depth tunnel_wall_depth] must be > 2*[../initialization_parameters#dx dx] || ||[=#PA0176 PA0176] ||negative time interval occured PE ... L=PAUSE "..." new=... last=... || The time measurement via routine {{{cpu_log}}} gave a negative time interval. This error could be caused when {{{cpu_log}}} was called with option "pause" before the corresponding {{{cpu_log}}} was initialised with option "start". || ||[=#PA0177 PA0177] ||negative time interval occured PE ... L=STOP "..." new=... last=... isum=... || The time measurement via {{{cpu_log}}} gave a negative time interval. This error could be caused when {{{cpu_log}}} was called with option "stop" before the corresponding {{{cpu_log}}} was initialised with option "start" or before it was continued with option "continue". || ||[=#PA0178 PA0178] ||negative time interval occured PE ... L=STOP "..." sum=... mtime=... || The time measurement via {{{cpu_log}}} gave a negative time interval. This error could be caused when {{{cpu_log}}} was called with option "stop" before the corresponding {{{cpu_log}}} was initialised with option "start" or before it was continued with option "continue". || ||[=#PA0179 PA0179] ||unknown modus of time measurement: ... || Possible options for {{{cpu_log}}} are "start", "pause", "continue" and "stop". Please refer to the description in the header of {{{cpulog_mod.f90}}}. || ||[=#PA0180 PA0180] ||unknown cross-section: ... || Cross sections are only possible for xy-, xz- or yz-sections. Please check your variable list in your [../runtime_parameters#data_output data_output] and [../user_parameters#data_output_user data_output_user] parameter for correct spelling. || ||[=#PA0181 PA0181] ||no output provided for: ... || There is no 2D data output available for the selected variable. Please check your variable list in your [../runtime_parameters#data_output data_output] and [../user_parameters#data_output_user data_output_user] parameter for correct spelling. || ||[=#PA0182 PA0182] ||no output provided for: ... || There is no 3D data output available for the selected variable. Please check your variable list in your [../runtime_parameters#data_output data_output] and [../user_parameters#data_output_user data_output_user] parameter for correct spelling. || ||[=#PA0183 PA0183] ||end_time of the simulation exceeds the time dimension in the dynamic input file || time dimension in dynamic input file must cover the entire simulation time. || ||[=#PA0184 PA0184] || unknown recycling method: ... || Allowed input for recycling_method is 'turbulent_fluctuation', 'absolute_value', or 'absolute_value_thermodynamic'. || ||[=#PA0185 PA0185] || data_output_pr = s*2 is not implemented for passive_scalar = .FALSE. ||The listed entry s*2 in the parameter file under [../runtime_parameters#data_output_pr data_output_pr] is only available for [../initialization_parameters#passive_scalar passive_scalar]= .T.. || ||[=#PA0186 PA0186] || no spectra data available || This message occurs if the {{{data_output_spectra}}} routine is called but no spectra data was calculated through the routine {{{calc_spectra}}}. Check your [../spectra_parameters#SpectraParameters spectra settings] in the parameter file. || ||[=#PA0187 PA0187] ||fft method "system-specific" currently does not work on NEC ||Usage of system-specific fft has been switched on with parameter [../initialization_parameters#fft_method fft_method], but the relevant part of the PALM code where the NEC-fft-library calls (e.g. DZFFT or DZFFTM) are used contains bugs which still require to be solved. You may submit a [/newticket trouble ticket] and ask for help. || ||[=#PA0188 PA0188] ||no system-specific fft-call available ||You have set [../initialization_parameters#fft_method fft_method] = ''system-specific''. In this case you additionally have to set the cpp-preprocessor switches {{{-D__ibm}}} or {{{-D__nec}}} to specify the fft-library that you like to use. Calls to IBM/NEC-libraries are the only one implemented so far in the PALM code. Probably you forgot to set such a switch. Set the switch and do not forget to recompile the code. || ||[=#PA0189 PA0189] ||fft method "..." not available ||See [../initialization_parameters#fft_method fft_method] for the availabe methods that are implemented in PALM and modify the initialization-parameter {{{fft_method}}} in your NAMELIST file appropriately.|| ||[=#PA0190 PA0190] ||flow_statistics is called two times within one timestep || Routine flow_statistics computes average profiles and further average flow quantities. It is only allowed to call this routine once during a time step (one timestep consists of several intermediate steps due to the selected time integration scheme). Please submit a [/newticket trouble ticket] if you have run into this error. || ||[=#PA0191 PA0191] ||unknown action(s): ... || The initializing action given by [../initialization_parameters#initializing_actions initializing_actions] in your parameter file is unknown. Please check for correct spelling. || ||[=#PA0192 PA0192] ||timestep has exceeded the lower limit dt_1d = ... s simulation stopped! || The time step of the 1D model is determined according to the diffusion criterion to assure a stable numerical solution. This error message means that the required minimum time step is several orders of magnitude smaller than dt_max_1d. The error message may indicate for unrealistic settings of e.g. [../initialization_parameters#bc boundary conditions] or other NAMELIST parameters. Please also check if this error appears if you run without USERCODE. To compile and run the PALM and USERCODE with DEBUG-options might also give sometimes valuable hints. || ||[=#PA0193 PA0193] ||unknown initializing problem || This should not happen during the initialization of the model variables in the routine {{{init_3d_model}}}. Please submit a [/newticket trouble ticket] if you have run into this error. || ||[=#PA0194 PA0194] ||number of time series quantities exceeds its maximum of dots_max = ... Please increase dots_max in modules.f90. ||In case that the output of user defined [../userint/output/#part_2 timeseries] is done and the number of the user defined timeseries exceeds the maximum number, the maximum number {{{dots_max}}}, which is currently set to 100, has to be increased. Please increase {{{dots_max}}} in [[source:palm/trunk/SOURCE/modules.f90| modules.f90]] according to your needs. || ||[=#PA0195 PA0195] ||In case of external radiation forcing both, rad_sw_in and rad_lw_in are required. || || ||[=#PA0196 PA0196] ||In case of external radiation forcing dimension time_rad is required. || || ||[=#PA0197 PA0197] ||External radiation forcing: rad_sw_in must not contain any fill values. || || ||[=#PA0198 PA0198] ||External radiation forcing: rad_lw_in must not contain any fill values. || || ||[=#PA0199 PA0199] ||External radiation forcing: rad_sw_in_dif must not contain any fill values. || || ||[=#PA0200 PA0200] ||missing dz || No value for [../initialization_parameters#dz dz] was given in the parameter file. || ||[=#PA0201 PA0201] ||dz=... <= 0.0 || The value given for [../initialization_parameters#dz dz] must be greater than 0.0. || ||[=#PA0202 PA0202] ||grid anisotropy exceeds threshold given by only local horizontal reduction of near_wall mixing length l_wall starting from height level k = ... . ||The grid-dependent mixing length {{{l_grid}}} ( ''= '''Δ''' = (Δx Δy Δz)^1/3^'' ) becomes larger than 2.7 * dx or 2.7 * dy starting from the reported height level {{{k}}}. Although PALM will not abort due to this warning, the chosen grid setup might lead to untrustworthy results. The reason for this is an unfavourable choise of grid anisotropy. To avoid this, make sure that the values of [../initialization_parameters#dx dx], [../initialization_parameters#dy dy], and [../initialization_parameters#dz dz] do not differ too much from each other. In case of grid stretching, the settings of [../initialization_parameters#dz_stretch_level dz_stretch_level] and/or [../initialization_parameters#dz_stretch_factor dz_stretch_factor] should be changed to ensure a smaller difference between {{{dz(k)}}} and {{{dx}}} and {{{dy}}} at the reported height level. || ||[=#PA0203 PA0203] ||inconsistent building parameters: index_left_bwall=... index_right_bwall=... index_south_bwall=... index_north_bwall=... nx=... ny=... || The setup of the single building ([../initialization_parameters#topography topography] = '' 'single_building' '') yields a too narrow building or the building walls are positioned outside of the model domain. Please check the [../initialization_parameters#topo building parameters] in your parameter file. || ||[=#PA0204 PA0204] ||no street canyon width given || If [../initialization_parameters#topography topography] = '' 'single_street_canyon' '' is given, also a canyon width must be given by either specifying [../initialization_parameters#canyon_width_x canyon_width_x] or [../initialization_parameters#canyon_width_y canyon_width_y] in the parameter file. || ||[=#PA0205 PA0205] ||inconsistent canyon parameters: index_left_cwall=... index_right_cwall=... ngp_cx=... ch=... nx=... ny=... || Due to [../initialization_parameters#canyon_width_x canyon_width_x] the setup of the single street canyon ([../initialization_parameters#topography topography] = '' 'single_street_canyon' '') yields a too narrow canyon or the canyon walls are outside of the model domain. Please check the [../initialization_parameters#topo canyon parameters] in your parameter file. || ||[=#PA0206 PA0206] ||inconsistent canyon parameters:... cys=... cyn=... cwy=... ch=... nx=... ny=... || Due to [../initialization_parameters#canyon_width_y canyon_width_y] the setup of the single street canyon ([../initialization_parameters#topography topography] = '' 'single_street_canyon' '') yields a too narrow canyon or the canyon walls are outside of the model domain. Please check the [../initialization_parameters#topo canyon parameters] in your parameter file. || ||[=#PA0207 PA0207] ||inconsistent canyon parameters: street canyon can only be oriented either in x- or in y-direction || Please do not specify [../initialization_parameters#canyon_width_x canyon_width_x] and [../initialization_parameters#canyon_width_y canyon_width_y] in the parameter file at the same time. || ||[=#PA0208 PA0208] ||file [../iofiles#TOPOGRAPHY_DATA TOPOGRAPHY_DATA] does not exist || Make sure that the topography data is available in the job directory (JOBS//INPUT/) and named correctly (_topo). For remote jobs it might be possible that the automatic transfer of the topography file to the host computer did not work. In this case the topography file must be transfered manually to the host. Carefully check the messages in the terminal output / job protocol file that follows line {{{*** providing INPUT-files:}}}, If there is no line like {{{>>> INPUT: /... to TOPOGRAPHY_DATA}}}, the topography file hasn't been provided. || ||[=#PA0209 PA0209] ||error reading line ... of file [../iofiles#TOPOGRAPHY_DATA TOPOGRAPHY_DATA] ||File contains illegal characters. Check the respective line given by the error message. || ||[=#PA0210 PA0210] ||nzb_local values are outside the model domain MINVAL( nzb_local ) = ... MAXVAL( nzb_local ) = ... || This error occurs during grid consistency checks of the index arrays when using non-flat topography with regard to the vertical dimension. Please submit a [/newticket trouble ticket] if you have run into this error because this should not happen. || ||[=#PA0211 PA0211] || The number of values for dz = ... has to be the same as or one more than the number of values for dz_stretch_level_start = ... || Self-explanatory. Please add/remove values for [../initialization_parameters#dz dz] or for [../initialization_parameters#dz_stretch_level_start dz_stretch_level_start] appropriately. || ||[=#PA0212 PA0212] ||Overhanging topography do not work with particles || When you have defined an overhanging structure in your topography data the simultaneous use of the Lagrangian particle model could be dangerous because reflection boundary conditions (as well as subgrid-scale velocities) are not realized for downward-facing walls so far. || ||[=#PA0213 PA0213] || max_number_of_particle_groups = ... number_of_particle_groups reset to reset to ... || If the [../particle_parameters#number_of_particle_groups number_of_particle_groups] > 10 then is reset to the maximum number of particle groups (at maximum 10 are allowed) || ||[=#PA0214 PA0214] ||version mismatch concerning data from prior run version on file = ... version in program = ... || This error occurs when particle data from the [../iofiles#PARTICLE_RESTART_DATA_OUT restart file] is read and the precursor run was carried out with a different particle binary version than the main run. Repeat the precurser with the current version or carry out the main run with the same version as the precursor. You can check the particle binary version number which is required for the main run in {{{lpm_read_restart_file.f90}}}. || ||[=#PA0215 PA0215] ||particle group # ... has a density ratio /= 0 but radius = 0 || Particles with mass but without radius are not allowed. Please appropriately correct [../particle_parameters#radius radius] or [../particle_parameters#density_ratio density_ratio] || ||[=#PA0216 PA0216] || The number of values for dz_stretch_level_start = ... has to be the same or one more than the number of values for dz_stretch_level_end = ... || Self-explanatory. Please add/remove values for [../initialization_parameters#dz_stretch_level_start dz_stretch_level_start] or for [../initialization_parameters#dz_stretch_level_end dz_stretch_level_end] appropriately. || ||[=#PA0217 PA0217] ||unknown boundary condition bc_par_b = "..." || See parameter [../particle_parameters#bc_par_b bc_par_b] for allowed values, and appropriately correct your parameter file. || ||[=#PA0218 PA0218] ||unknown boundary condition bc_par_t = "..." || See parameter [../particle_parameters#bc_par_t bc_par_t] for allowed values, and appropriately correct your parameter file. || ||[=#PA0219 PA0219] ||unknown boundary condition bc_par_lr = "..." || See parameter [../particle_parameters#bc_par_lr bc_par_lr] for allowed values, and appropriately correct your parameter file. || ||[=#PA0220 PA0220] ||unknown boundary condition bc_par_ns = "..." || See parameter [../particle_parameters#bc_par_ns bc_par_ns] for allowed values, and appropriately correct your parameter file. || ||[=#PA0221 PA0221] ||number of PEs of the prescribed topology (...) does not match the number of PEs available to the job (...) ||In case that the number of PEs along the x- and y-direction of the virtual processor grid is set via [../runtime_parameters#npex npex] and [../runtime_parameters#npey npey], the product npey*npex has to match exactly the total number of processors which is assigned by the '''palmrun'''-option -X. || ||[=#PA0222 PA0222] ||if the processor topology is prescribed by the user, both values of "npex" and "npey" must be given in the NAMELIST-parameter file || In case that only one number of processors along x- or y- direction [../runtime_parameters#npex npex] or [../runtime_parameters#npey npey] is set in the [../runtime_parameters#pgrid &runtime_parameters-Namelist], the remaining, so far not assigned, number of processors has to be set, too. || ||[=#PA0223 PA0223] ||errors in \$nesting_parameters ||An unvalid variable name or value has been given in the nestpar-NAMELIST. Carefully check your nestpar-NAMELIST and compare with the parameters given and explained in the [wiki:doc/app/nesting_parameters Nesting]-section of the model steering parameters. || ||[=#PA0224 PA0224] || Each dz_stretch_level_end has to be ... than its corresponding value for dz_stretch_level_start ... 4*MAX(dz(n),dz(n+1)) to allow for smooth grid stretching || To allow for a smooth stretching, the distance between [../initialization_parameters#dz_stretch_level_start dz_stretch_level_start] and [../initialization_parameters#dz_stretch_level_end dz_stretch_level_end] has to be large enough. Please increase the stretching region appropriately. || ||[=#PA0225 PA0225] ||x-direction: gridpoint number (...) is not an integral multiple of the number of processors (...) || The division of the number of grid points along the x-direction given by [../initialization_parameters#nx nx]+1 by the number of processors along the x-direction has a rest and is therefore not an integral multiple of the number of processors. To solve this problem you must ensure that the aforementioned division is without rest for example by setting the number of PEs in x-direction manually (see [../runtime_parameters#npex npex]) or by changing [../initialization_parameters#nx nx]. It might also be the case that you did not think about that [../initialization_parameters#nx nx]+1 is the total number of gridpoints along the x-direction instead of [../initialization_parameters#nx nx]. || ||[=#PA0226 PA0226] || Each dz_stretch_level_start has to be ... than ... || The stretching region has to be defined above the first two grid points (Prandtl-layer). In case of ocean mode the stretching region muss below the two highest grid points (surface). Please adjust [../initialization_parameters#dz_stretch_level_start dz_stretch_level_start] accordingly. || ||[=#PA0227 PA0227] ||y-direction: gridpoint number (...) is not an integral multiple of the number of processors (...) || The division of the number of grid points along the y-direction given by [../initialization_parameters#ny ny]+1 by the number of processors along the y-direction has a rest and is therefore not an integral multiple of the number of processors. To solve this problem you must ensure that the aforementioned division is without rest for example by setting the number of PEs in y-direction manually (see [../runtime_parameters#npey npey]) or by changing [../initialization_parameters#ny ny]. It might also be the case that you did not think about that [../initialization_parameters#ny ny]+1 is the total number of gridpoints along the y-direction instead of [../initialization_parameters#ny ny]. || ||[=#PA0228 PA0228] || Two adjacent values of dz must be different || It is necessary to specify different values for [../initialization_parameters#dz dz] if they are adjacent. || ||[=#PA0229 PA0229] ||nesting-setup requires different number of MPI procs (...) than provided (...) ||This message appears for nested runs, if the total number of MPI processes for all nested domains given in the nestpar-NAMELIST is larger than the number of MPI processes which has been allowed for the run, e.g. with palmrun-option -X. (Attention: For hybrid OpenMP/MPI-runs the number of MPI processes allowed for the run is the number given by -X divided by the number of threads per MPI-task, as given with palmrun-option -O.) You either have to provide the run more resources (i.e. more cores) or you have to decrease the number of MPI processes in $nestpar. || ||[=#PA0230 PA0230] ||transposition z --> x: nz=... is not an integral multiple of npex= ... ||Due to restrictions in data transposition, the division of [../initialization_parameters#nz nz] by the number of processors in x-direction has to be without rest. Please ensure this by changing [../initialization_parameters#nz nz] or setting the number of gridpoints in x-direction (npex) manually by [../runtime_parameters#npex npex]. || ||[=#PA0231 PA0231] ||transposition x --> y: nx+1=... is not an integral multiple of npey= ... || Due to restrictions in data transposition, the division of [../initialization_parameters#nx nx]+1 by the number of processors in y-direction has to be without rest. Please ensure this by changing [../initialization_parameters#nx nx] or setting the number of gridpoints in y-direction (npey) manually by [../runtime_parameters#npey npex]. || ||[=#PA0232 PA0232] ||transposition y --> z: ny+1=... is not an integral multiple of npex=... ||Due to restrictions in data transposition, the division of [../initialization_parameters#ny ny]+1 by the number of processors in x-direction has to be without rest. Please ensure this by changing [../initialization_parameters#ny ny] or setting the number of gridpoints in x-direction (npex) manually by [../runtime_parameters#npex npex]. || ||[=#PA0233 PA0233] ||transposition x --> y: ny+1=... is not an integral multiple of npex=... ||Due to restrictions in data transposition, the division of [../initialization_parameters#ny ny]+1 by the number of processors in x-direction has to be without rest. Please ensure this by changing [../initialization_parameters#ny ny] or setting the number of gridpoints in x-direction (npex) manually by [../runtime_parameters#npex npex]. || ||[=#PA0234 PA0234] ||direct transposition z --> y (needed for spectra): nz=... is not an integral multiple of npey=... || Due to restrictions in data transposition, the division of [../initialization_parameters#nz nz] by the number of processors in y-direction has to be without rest. Please ensure this by changing [../initialization_parameters#nz nz] or setting the number of gridpoints in y-direction (npey) manually by [../runtime_parameters#npey npey]. || ||[=#PA0235 PA0235] ||mg_switch_to_pe0_level out of range and reset to 0 || mg_switch_to_pe0_level was manually set out of range. It was reset to 0, so that the gathering level is determined automatically and displayed in file RUN_CONTROL. See [../initialization_parameters#mg_switch_to_pe0_level mg_switch_to_pe0_level] for details. || ||[=#PA0236 PA0236] ||grid coarsening on subdomain level cannot be performed || The multigrid pressure solver halfs the number of grid points in each direction to get coarser grid levels. This is done for the subdomains on each PE until one of the directions cannot be divided by 2 without rest. If this is the case, the coarsest grid level of each subdomain are gathered on each PE for further coarsening. Before gathering, the coarsening must be done for the subdomain at least one time. You get this error messages for example with the following combination: \\ [../initialization_parameters#nx nx ] = 60, [../initialization_parameters#ny ny ] = 60, [../initialization_parameters#nz nz ] = 60, \\ [../runtime_parameters#npex npex ] = 4, [../runtime_parameters#npey npey ] = 2. \\ With this combination, the subdomain on each PE has the size: \\ nx = 15, ny = 30, nz = 60. \\ The number of grid points in the x-direction of the subdomain cannot be divided by 2 and no coarsening is possible for the subdomains in this example. \\\\ To avoid this error ensure that the number of grid points in each direction can be divided by 2 without rest on the subdomain of an PE at least one time. Therefor vary the number of grid points for the direction which does not fit by changing [../initialization_parameters#nx nx ], [../initialization_parameters#ny ny ] or [../initialization_parameters#nz nz ] or adjust the number of processors by modifying the parameters [../runtime_parameters#npex npex ] or [../runtime_parameters#npey npey ] in order to get other subdomain sizes. \\ In the example given above, you can avoid the error by changing nx or npex. For example setting [../initialization_parameters#nx nx ] = 64 leads to a subdomain of \\ nx = 16, ny = 30, nz = 60. \\ All numbers are now divisible by 2 without rest and the first coarser grid on the subdomain is then: \\ nx = 8, ny = 15, nz = 30. || ||[=#PA0237 PA0237] ||multigrid gather/scatter impossible in non parallel mode ||You are using the multigrid-solver and are running PALM in non-parallel mode (i.e. on a single processor core), but you have set a multigrid level (using parameter [../initialization_parameters#mg_switch_to_pe0_level mg_switch_to_pe0_level]) from where on data shall be collected on core 0 in order to allow for a further coarsening of the grid. Obviously, this does not make sense if only one core is used. Remove this parameter from your NAMELIST-file or set it to value ''-1'' to switch of collection. || ||[=#PA0238 PA0238] ||more than 10 multigrid levels ||You have selected the multigrid Poisson-solver ([../initialization_parameters#psolver psolver] = ''"multigrid"'') and a numerical grid which allows for more than 10 coarsening levels. This may happen for very large grids where the grid point numbers along x,y,z are given by 2^n^ with n>10. The smallest grid which may cause this error would have 2048^3^ points. However, depending on the chosen domain decomposition, much larger grids might be possible. Choose a different number of grid points to circumvent this problem. || ||[=#PA0239 PA0239] ||The value for "topography_grid_convention" is not set. Its default value is only valid for "topography" = "single_building", "tunnel" "single_street_canyon" or "read_from_file" Choose "cell_edge" or "cell_center". || See [../initialization_parameters#topography_grid_convention topography_grid_convention] for details. || ||[=#PA0240 PA0240] ||The value for "topography_grid_convention" is not recognized. Choose "cell_edge" or "cell_center". || See [../initialization_parameters#topography_grid_convention topography_grid_convention] for details. || ||[=#PA0241 PA0241] ||netcdf_precision must contain a "_" netcdf_precision(...)="..." || Output types can be assigned a NETCDF precision. For that, the output type has to be connected with the precision via "_". See [../initialization_parameters#netcdf_precision netcdf_precision] for details. || ||[=#PA0242 PA0242] ||illegal netcdf precision: netcdf_precision( ...)="..." || See [#PA0241 PA0241]. Allowed NETCDF precisions are 'NF90_REAL4' (single precision) or 'NF90_REAL8' (double precision) . || ||[=#PA0243 PA0243] ||unknown variable in initialization_parameters assignment: netcdf_precision(...)="..." || See [#PA0241 PA0241]. Allowed outputs are 'xy', 'xz', 'yz', '2d', '3d', 'pr', 'ts', 'sp', 'prt' or 'all'. || ||[=#PA0244 PA0244] ||no grid defined for variable ... || All output quantities need a grid on which they are then output. See [../userint/output user-defined] output documentation for a detailed description on how to output your own quantities. If you did not define your own output quantities and if you did not change the code please submit a [/newticket trouble ticket]. || ||[=#PA0245 PA0245] ||netCDF file for volume data ... from previous run found, but this file cannot be extended due to variable mismatch. New file is created instead. ||This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, its 3d variables do not match the ones of the current run. Therefore a new file is created instead. || ||[=#PA0246 PA0246] ||netCDF file for volume data ... from previous run found, but this file cannot be extended due to mismatch in number of vertical grid points (nz_do3d). New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, the number of vertical grid points of the 3d variables do not match the one of the current run. Therefore a new file is created instead. || ||[=#PA0247 PA0247] ||netCDF file for volume data ... from previous run found, but this file cannot be extended because the current output time is less or equal than the last output time on this file. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, its last output time is greater than the first output time of the current run. Therefore a new file is created instead. || ||[=#PA0248 PA0248] ||netCDF file for volume data ... from previous run found. This file will be extended. || This is just an informative message and self-explanatory. || ||[=#PA0249 PA0249] ||netCDF file for cross-sections ... from previous run found, but this file cannot be extended due to variable mismatch. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, its 2D variables do not match the ones of the current run. Therefore a new file is created instead. || ||[=#PA0250 PA0250] ||netCDF file for cross-sections ... from previous run found, but this file cannot be extended due to mismatch in number of cross sections. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, the number of cross sections do not match the one of the current run. Therefore a new file is created instead. || ||[=#PA0251 PA0251] ||netCDF file for cross-sections ... from previous run found but this file cannot be extended due to mismatch in cross section levels. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, the specified cross section levels which shall be outputted do not match the ones of the current run. Therefore a new file is created instead. || ||[=#PA0252 PA0252] ||netCDF file for cross sections ... from previous run found, but this file cannot be extended because the current output time is less or equal than the last output time on this file. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, its last output time is greater than the first output time of the current run. Therefore a new file is created instead. || ||[=#PA0253 PA0253] ||netCDF file for cross-sections ... from previous run found. This file will be extended. || This is just an informative message and self-explanatory. || ||[=#PA0254 PA0254] ||netCDF file for vertical profiles from previous run found, but this file cannot be extended due to variable mismatch. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, its 1D variables do not match the ones of the current run. Therefore a new file is created instead. || ||[=#PA0255 PA0255] ||netCDF file for vertical profiles from previous run found, but this file cannot be extended because the current output time is less or equal than the last output time on this file. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, its last output time is greater than the first output time of the current run. Therefore a new file is created instead. || ||[=#PA0256 PA0256] ||netCDF file for vertical profiles from previous run found. This file will be extended. || This is just an informative message and self-explanatory. || ||[=#PA0257 PA0257] ||netCDF file for (flight) time series from previous run found but this file cannot be extended due to variable mismatch. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, its time dependent variables do not match the ones of the current run. Therefore a new file is created instead. || ||[=#PA0258 PA0258] ||netCDF file for (flight) time series from previous run found, but this file cannot be extended because the current output time is less or equal than the last output time on this file. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, its last output time is greater than the first output time of the current run. Therefore a new file is created instead. || ||[=#PA0259 PA0259] ||netCDF file for (flight) time series from previous run found. This file will be extended. || This is just an informative message and self-explanatory. || ||[=#PA0260 PA0260] ||netCDF file for spectra from previous run found, but this file cannot be extended due to variable mismatch. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, its variables do not match the ones of the current run. Therefore a new file is created instead. || ||[=#PA0261 PA0261] ||netCDF file for spectra from previous run found, but this file cannot be extended due to mismatch in number of vertical levels. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, the number of vertical levels which shall be outputted do not match the ones of the current run. Therefore a new file is created instead. || ||[=#PA0262 PA0262] ||netCDF file for spectra from previous run found, but this file cannot be extended due to mismatch in heights of vertical levels. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, the specified vertical levels (heights) which shall be outputted do not match the ones of the current run. Therefore a new file is created instead. || ||[=#PA0263 PA0263] ||netCDF file for spectra from previous run found, but this file cannot be extended because the current output time is less or equal than the last output time on this file. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, its last output time is greater than the first output time of the current run. Therefore a new file is created instead. || ||[=#PA0264 PA0264] ||netCDF file for spectra from previous run found. This file will be extended. || This is just an informative message and self-explanatory. || ||[=#PA0265 PA0265] ||unused || || ||[=#PA0266 PA0266] ||unused || || ||[=#PA0267 PA0267] ||unused || || ||[=#PA0268 PA0268] ||unused || || ||[=#PA0269 PA0269] ||unused || || ||[=#PA0270 PA0270] ||mode "..." not supported || The mode which steers the netcdf output can not be processed in [source:palm/trunk/SOURCE/netcdf_interface_mod.f90 netcdf_interface_mod.f90]). Possible modes are 3d, ma (mask), xy, xz, yz, pr (profiles), ps (particle timeseries), fl (flight data), ts (timeseries), sp (spectra). In addition, the extension (_ext) and the creation of netcdf files is possible. If you run into this error please submit a [/newticket trouble ticket]. || ||[=#PA0271 PA0271] ||Error(s) in namelist \\Reading fails on line at\\ ||There is an error in your INPUT file in the given line. Most likely this is a typo or outdated steering parameter. \\ **NOTE:** According to the Fortran Standard, the line on which reading stops in case of an error is not clearly defined. To our knowledge the current implementation works, but it is not guaranteed to do so. If you encounter this error message and you are sure that the given line is correct, please submit a [/newticket trouble ticket]. || ||[=#PA0272 PA0272] ||no &initialization_parameters-namelist found || Your parameter file must contain an &initialization_parameters-namelist. Parameters given in this namelist are required for model steering. Please take a look at our [wiki:doc/tut/palm#Exercisepresentations beginners' simulation examples] and appropriately correct your parameter file. One possible error might be a typo in the NAMELIST name, e.g. ''inialization_parameters'' instead of ''initialization_parameters''. || ||[=#PA0273 PA0273] ||no value or wrong value given for nx: nx=... || See parameter [../initialization_parameters#nx nx] for allowed values, and check the &initialization_parameters-namelist in your parameter file. || ||[=#PA0274 PA0274] ||no value or wrong value given for ny: ny=... || See parameter [../initialization_parameters#ny ny] for allowed values, and check the &initialization_parameters-namelist in your parameter file. || ||[=#PA0275 PA0275] ||no value or wrong value given for nz: nz=... || See parameter [../initialization_parameters#nz nz] for allowed values, and check the &initialization_parameters-namelist in your parameter file. || ||[=#PA0276 PA0276] ||local file ENVPAR not found Some variables for steering may not be properly set. || Some model steering parameters are passed to PALM through a namelist {{{&envpar}}} which is stored in local file {{{ENVPAR}}}. This file is created by the script [source:palm/trunk/SCRIPTS/palmrun palmrun] which can be used to start model runs. This message appears, if {{{ENVPAR}}} could not be found because it was not created by palmrun. Check if you changed anything in the script. || ||[=#PA0277 PA0277] ||errors in local file ENVPAR within line: ... Some variables for steering may not be properly set. || The namelist {{{&envpar}}} expects certain model steering parameters (see [source:palm/trunk/SOURCE/parin.f90 parin.f90]). Some of these parameters have not been properly set or are missing entirely. This should only happen if (1) you didn't use palmrun to start your run, (2) you used an old version of palmrun that is not compatible with your model version anymore (then please update) or (3) you changed palmrun manually and set some parameters of the {{{&envpar}}} namelist incorrectly. (Also see [#PA0276 PA0276]) || ||[=#PA0278 PA0278] ||no envpar-NAMELIST found in local file ENVPAR Some variables for steering may not be properly set. || Some model steering parameters are passed to PALM through a namelist {{{&envpar}}} which is stored in local file {{{ENVPAR}}}. This file is created by the script [source:palm/trunk/SCRIPTS/palmrun palmrun] which can be used to start model runs. The {{{&envpar}}} namelist was not found. This is possible if you (1) did not use palmrun to start your run or (2) changed palmrun manually so that the namelist is not properly created. || ||[=#PA0279 PA0279] ||wrong component: ... || This message is produced by the procedure pcm_tendency of the plant canopy model. It calculates drag for velocity components and scalar quantities. The calculated components are: u, v, w, pt, q, e, s (1-7). The subroutine is only called for these 7 quantities. If this error occured, you called the routine from your own code for a component that is out of range. If you wish to do this, you must adjust procedures pcm_tendency and pcm_tendency_ij in file [source:palm/trunk/SOURCE/plant_canopy_model_mod.f90 plant_canopy_model_mod.f90] accordingly. || ||[=#PA0280 PA0280] ||No tunnel width is given. || This error occurs if you have set [../initialization_parameters#topography topography]='' 'tunnel' '' in you parameter file but you did not specify [../initialization_parameters#tunnel_width_x tunnel_width_x] or [../initialization_parameters#tunnel_width_y tunnel_width_y] || ||[=#PA0281 PA0281] ||Inconsistent tunnel parameters: tunnel can only be oriented either in x- or in y-direction. ||Please do not specify [../initialization_parameters#tunnel_width_x tunnel_width_x] and [../initialization_parameters#tunnel_width_y tunnel_width_y] in the parameter file at the same time. || ||[=#PA0282 PA0282] ||Tunnel width too large ||[../initialization_parameters#tunnel_width_x tunnel_width_x] must be <= ([../initialization_parameters#nx nx]+1)*[../initialization_parameters#dx dx] || ||[=#PA0283 PA0283] ||no sufficient convergence within 1000 cycles || Still after 1000 cycles of the multigrid-solver the divergence residual is larger than the residual limit given by [../initialization_parameters#residual_limit residual_limit]. Try to increase the residual limit, or fix the number of multigrid cycles (see [../initialization_parameters#mg_cycles mg_cycles]). In any case, carefully check if the divergence of the velocity field is sufficiently reduced by the multigrid solver. This can be done by comparing the divergence before and after the call of the multigrid solver which is printed in the RUN_CONTROL file. \\\\ If this error appears during the initial phase of a run (before the first timestep), the number of subdomain gridpoints along x/y/z probably do not allow sufficient coarsening of the grid. The number of gridpoints should allow for a division by two (without rest) at least 2-3 times. || ||[=#PA0284 PA0284] ||data from subdomain of previous run mapped more than 1000 times || The model domain of the precursor run was much smaller than that of the main run. It was reused more than 1000 times in one direction. Try a smaller main run domain or a larger precursor. || ||[=#PA0285 PA0285] ||number of PEs or virtual PE-grid changed in restart run. Set debug_output =.T. to get a list of files from which the single PEs will read respectively || Either the model domain of the precursor run is smaller than that of the main run and has been copied one or multiple times or the number of processors has been changed during restart runs. This informative message is only printed out for PE0 but is also valid for the other processors. Set runtime parameter debug_output = .T. to see from which files the respective PEs will read. || ||[=#PA0286 PA0286] ||version mismatch concerning binary_version_local: version on file = "..." version in program = "..." || The precursor run was carried out with a different version than the main run. Repeat the precurser with the current version or carry out the main run with the same version as the precursor. || ||[=#PA0287 PA0287] ||problem with index bound nxl on restart file "..." nxl = ... but it should be = ... from the index bound information array ||The processor grid was changed between this and the previous run. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. || ||[=#PA0288 PA0288] ||problem with index bound nxr on restart file "..." nxr = ... but it should be = ... from the index bound information array || The processor grid was changed between this and the previous run. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. || ||[=#PA0289 PA0289] ||problem with index bound nys on restart file "..." nys = ... but it should be = ... from the index bound information array || The processor grid was changed between this and the previous run. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. || ||[=#PA0290 PA0290] ||problem with index bound nyn on restart file "..." nyn = ... but it should be = ... from the index bound information array || The processor grid was changed between this and the previous run. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. || ||[=#PA0291 PA0291] ||mismatch between actual data and data from prior run on PE ... \\nzb on file = ... \\nzb = ... || The vertical extent of the model domain must be the same in precursor and main run. In this case, there is a mismatch in the respective topography. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. || ||[=#PA0292 PA0292] ||mismatch between actual data and data from prior run on PE ... \\nzt on file = ... \\nzt = ... || The vertical extent of the model domain must be the same in precursor and main run. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. || ||[=#PA0293 PA0293] || data_output_pr = ... is not implemented for air_chemistry = .FALSE. || || ||[=#PA0294 PA0294] || vegetation_type = 1 (bare soil) requires vegetation_coverage = 0 || Self-explanatory. Change the value of [../land_surface_parameters#vegetation_type vegetation_type] or [../land_surface_parameters#vegetation_coverage vegetation_coverage]. || ||[=#PA0295 PA0295] || complex_terrain requires topography = 'read_from_file' || Self-explanatory. See [../initialization_parameters#complex_terrain complex_terrain] and [../initialization_parameters#topography topography]. || ||[=#PA0296 PA0296] ||version mismatch concerning binary_version_global: version on file = "..." version on program = "..." || The precursor run was carried out with a different version than the main run. Repeat the precurser with the current version or carry out the main run with the same version as the precursor. || ||[=#PA0297 PA0297] ||numprocs not found in data from prior run on PE ... || Number of processors are not written out or read in correctly during restarts. Please submit a [/newticket trouble ticket]. || ||[=#PA0298 PA0298] ||hor_index_bounds not found in data from prior run on PE ... || Field that stores the horizontal index bounds of each processor are not written out or read in correctly during restarts. Please submit a [/newticket trouble ticket]. || ||[=#PA0299 PA0299] ||nz not found in data from prior run on PE ... || Vertical number of gridpoints are not written out or read in correctly during restarts. Please submit a [/newticket trouble ticket]. || ||[=#PA0300 PA0300] ||max_pr_user not found in data from prior run on PE ... || Number of user-defined profiles (must not change within a job chain) are not written out or read in correctly during restarts. Please submit a [/newticket trouble ticket]. || ||[=#PA0301 PA0301] ||statistic_regions not found in data from prior run on PE ... || Number of statistic regions are not written out or read in correctly during restarts. Please submit a [/newticket trouble ticket]. || ||[=#PA0302 PA0302] ||unknown variable named "..." found in ... data from prior run on PE ... || During the initial run, a variable was written to [../iofiles#BINOUT BINOUT], that is not recognized during read-in of the restart run. Note that user variables have to be written in [[source:palm/trunk/SOURCE/user_module.f90|user_wrd global/user_wrd_local]] (not in [[source:palm/trunk/SOURCE/write_restart_data_mod.f90| write_restart_data_mod]] where standard output is written). It has to be read accordingly in [[source:palm/trunk/SOURCE/user_module.f90|user_rrd_global/user_rrd_local]]. Also see: [../userint/output#part_3 user output]. || ||[=#PA0303 PA0303] ||nz not found in restart data file || nz is necessary for the main run to continue. This will happen if the [../initialization_parameters initialization parameter] list was altered between precursor and main run. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. Also check if you altered [../initialization_parameters#nz nz] between precursor and main run. || ||[=#PA0304 PA0304] ||mismatch concerning number of gridpoints along z: nz on file = "..." nz from run = "..." || The main run must have the same number of grid points in z-direction as the precursor run. x- and y-directions may differ. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. || ||[=#PA0305 PA0305] ||max_pr_user not found in restart data file || max_pr_user is necessary for the main run to continue. This will happen if the [../initialization_parameters initialization parameter] list was altered between precursor and main run. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. Also check if you altered [../user_parameters#data_output_pr_user data_output_pr_user] between precursor and main run. || ||[=#PA0306 PA0306] ||number of user profiles on restart data file differs from the current run: max_pr_user on file = "..." max_pr_user from run = "..." || This message is informative, the run will continue nonetheless. This will only happen in case the number of user [../user_parameters#data_output_pr_user profiles] was changed from precursor to main run. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. || ||[=#PA0307 PA0307] ||statistic_regions not found in restart data file || [../initialization_parameters#statistic_regions statistic_regions] are necessary for the main run to continue. This will happen if the [../initialization_parameters initialization parameter] list was altered between precursor and main run. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. || ||[=#PA0308 PA0308] ||statistic regions on restart data file differ from the current run: statistic regions on file = "..." statistic regions from run = "..." statistic data may be lost! || This message is a warning, the run will continue nonetheless. This will only happen in case the statistic [../initialization_parameters#statistic_regions regions] were changed from precursor to main run. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. || ||[=#PA0309 PA0309] ||inflow profiles not temporally averaged. Averaging will be done now using ... samples. || The [../examples/turbinf tubulent inflow] method needs time averaged inflow profiles. This warning occurs if the output of time averaged profiles ([../runtime_parameters#skip_time_dopr skip_time_dopr] + [../runtime_parameters#dt_dopr dt_dopr]) is not an integral divisor of the [../runtime_parameters#end_time end_time] which is specified for the precursor run or if [../runtime_parameters#skip_time_dopr skip_time_dopr] + [../runtime_parameters#dt_dopr dt_dopr] is larger than this [../runtime_parameters#end_time end_time]. || ||[=#PA0310 PA0310] ||unused || || ||[=#PA0311 PA0311] ||number of gridpoints along x or/and y contain illegal factors only factors 2, 3, 5 are allowed ||In case that [../initialization_parameters#fft_method fft_method]='temperton-algorithm', the number of horizontal grid points ([../initialization_parameters#nx nx]+1, [../initialization_parameters#ny ny]+1) must be composed of prime factors 2,3 and 5. Higher prime factors such as 7 are not allowed. Please ensure that these restrictions are fulfilled or use 'singleton-algorithm' as [../initialization_parameters#fft_method fft_method]. || ||[=#PA0312 PA0312] ||Time step has reached minimum limit. \\dt = ... s Simulation is terminated.\\old_dt = ... s\\dt_u = ... s\\dt_v = ... s\\dt_w = ... s\\dt_diff = ... s\\u_max = ... m/s k=... j=... i=...\\v_max = ... m/s k=... j=... i=...\\w_max = ... m/s k=... j=... i=... ||The time step is determined according to the CFL criterion to assure a stable numerical solution. This error message means that the required minimum time step, determined from the three velocity components, is several orders of magnitude smaller than [../runtime_parameters#dt_max dt_max], or, in other words, that at least one of the velocity components got too large. Due to the large number of complex reasons it should be noted that this list is not complete, but it is intended to give general hints how to proceed in case of this error message. First, check for a unrealistic value of [../runtime_parameters#dt_max dt_max] in the NAMELIST file. Moreover, this error message may indicate for unrealistic settings of e.g. [../initialization_parameters#bc boundary conditions] or other NAMELIST parameters. For very small vertical grid spacing [../initialization_parameters#dz dz] this error might also occur if [../initialization_parameters#roughness_length roughness_length] >= [../initialization_parameters#dz dz]. Please also check if this error appears if you run without USERCODE. To compile and run the PALM and USERCODE with DEBUG-options might also give sometimes valuable hints. In case the [../land_surface_parameters land-surface model] or the [../urban_surface_parameters building-surface model] is employed, surface temperatures might had become unstable during the time-integration. One known issue is e.g. the presence of metal surfaces {{{pavement_type = 7}}}, where the integration of surface tempertures can become unstable, producing unrealistically high or low surface sensible heat fluxes. Please check for possibly mis-represented settings in your static input file. List to be continued.|| ||[=#PA0313 PA0313] ||Resolved plant-canopy is defined on top of an artificially created building grid point (emerged from the filering) - LAD profile is omitted at this grid point ||Due to numerical reasons one-grid point cavities in topography are filtered, so that building geometries might be changed on this scale. In case tall canopy is directly adjacent to the building before, it may happen that building and plant canopy overlap after the filtering. In order to avoid that LAD is mistakenly mapped on top of buildings, which may significantly affect the downstream flow and radiation properties, LAD profiles are ommitted at these artificially-created building grid points. || ||[=#PA0314 PA0314] ||External radiation forcing does not cover the entire simulation time. || || ||[=#PA0315 PA0315] ||In case of external radiation forcing a dynamic input file is required. If no dynamic input for the child domain(s) is provided, at least one for the root domain is needed. || || ||[=#PA0316 PA0316] || pavement-surfaces are not allowed in combination with a non-default setting of dz_soil || || ||[=#PA0317 PA0317] ||ocean mode does not allow coupling_char = ... set by palmrun-option "-y" || The palmrun option "-y" must not be used for atmosphere runs. The option is only required for ocean precursor runs, which are followed by [../examples/coupled atmosphere-ocean coupled] restart runs. || ||[=#PA0318 PA0318] ||inflow_damping_height must be explicitly specified because the inversion height calculated by the prerun is zero ||See [../initialization_parameters#inflow_damping_height inflow_damping_height]. || ||[=#PA0319 PA0319] ||section_xy must be <= nz + 1 = ... || You specified a height through the grid index that is larger than the vertical model domain. Adjust [../runtime_parameters#section_xy section_xy]. || ||[=#PA0320 PA0320] ||section_xz must be <= ny + 1 = ... || You specified a y position through the grid index that is larger than the horizontal model domain. Adjust [../runtime_parameters#section_xz section_xz]. || ||[=#PA0321 PA0321] ||section_yz must be <= nx + 1 = ... || You specified a x position through the grid index that is larger than the horizontal model domain. Adjust [../runtime_parameters#section_yz section_yz]. || ||[=#PA0322 PA0322] ||output of qsws* requires humidity=.TRUE. || Variables connected with humidity, e.g. the surface latent heatflux qsws*, can only be output if the moist version of PALM is used, i.e. if [../initialization_parameters#humidity humidity] = '''.TRUE.''' || ||[=#PA0323 PA0323] ||output of averaged quantity "..." requires to set a non-zero averaging interval || If 2d or 3d data shall be output as a time average over a certain time interval, the parameter [../runtime_parameters#averaging_interval averaging_interval] must be set to a non-zero value. The default is [../runtime_parameters#averaging_interval averaging_interval] = 0.0, i.e. by default no averaging is applied to the output variables. || ||[=#PA0324 PA0324] ||applying large scale vertical motion is not allowed for ocean mode ||Large scale subsidence is only reasonable and implemented for atmospheric runs. The setting of [../initialization_parameters#subs_vertical_gradient subs_vertical_gradient] and [../initialization_parameters#subs_vertical_gradient_level subs_vertical_gradient_level] is not available for the ocean mode. || ||[=#PA0325 PA0325] ||illegal value: masks must be >= 0 and <= "..."(=max_masks) || If more than max_masks are needed, the value for max_maskes can be changed in [[source:palm/trunk/SOURCE/modules.f90| modules.f90]]. See documentation of the [../userint user interface] and [../runtime_parameters#data_output_masks data_output_masks]. || ||[=#PA0326 PA0326] ||illegal value: mask_scale_x, mask_scale_y and mask_scale_z must be > 0.0 || [../runtime_parameters#mask_scale_x mask_scale_x] (or [../runtime_parameters#mask_scale_y y] or [../runtime_parameters#mask_scale_z z]) || ||[=#PA0327 PA0327] ||no masked output available for: "..." || See [../runtime_parameters#data_output_masks data_output_masks] for allowed variables. If you want to have user-defined masked output check also [[source:palm/trunk/SOURCE/user_data_output_mask.f90| user_data_output_mask.f90]] and add the respective CASE. || ||[=#PA0328 PA0328] ||netCDF file formats 5 and 6 (with parallel I/O support) are currently not supported. || Parallel mask output not yet supported. Choose another value for [../runtime_parameters#netcdf_data_format netcdf_data_format]. || ||[=#PA0329 PA0329] ||number of output quantitities given by data_output_mask and data_output_mask_user exceeds the limit of 100 || Check [../runtime_parameters#data_output_masks data_output_masks] and [../user_parameters#data_output_masks_user data_output_masks_user] and reduced the quantities you want to output Otherwise you have to change the limit of 100 in the code. || ||[=#PA0330 PA0330] ||illegal value for data_output_masks: "..." || This error is most likely related to a typo in the parameter file (a output variable was used that does not exist in PALM). For possible output quantities see [../runtime_parameters#data_output_masks data_output_masks] || ||[=#PA0331 PA0331] ||"..." in mask "..." along dimension "..." exceeds "..." = "..." || Your masked output exeeds the model domain in x-, y- or z- direction. Check the documentation of [../maskedoutput masked output] and [../runtime_parameters#mask_x mask_x] (or [../runtime_parameters#mask_y y] or [../runtime_parameters#mask_z z]) || ||[=#PA0332 PA0332] ||mask_loop(...,...,1)=... and/or mask_loop(...,...,2)=... exceed (...+1)*.../mask_scale(...)=... || Your looped output mask exeeds the model domain in x- or y-direction. Check [../runtime_parameters#mask_x_loop mask_x_loop] ([../runtime_parameters#mask_y_loop or y]) and [../runtime_parameters#mask_scale_x mask_scale_x] ([../runtime_parameters#mask_scale_y or y]). || ||[=#PA0333 PA0333] ||mask_loop(...,...,1)=... and/or mask_loop(...,...,2)="..." exceed zu(nz+1)/mask_scale(...)=... || Your looped output mask exeeds the model domain in z-direction. Check [../runtime_parameters#mask_z_loop mask_z_loop] and [../runtime_parameters#mask_scale_z mask_scale_z]. || ||[=#PA0334 PA0334] ||mask_loop(...,3,2)=... exceeds dz_stretch_level=... or dz_stretch_level_ground=.... Vertical mask locations will not match the desired heights within the stretching region. || Recommendation: use mask instead of mask_loop. || ||[=#PA0335 PA0335] ||netCDF file for "..." data for mask "..." from previous run found but this file cannot be extended due to variable mismatch. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, its masked variables do not match the ones of the current run. Therefore a new file is created instead. || ||[=#PA0336 PA0336] ||netCDF file for "..." data for mask "..." from previous run found but this file cannot be extended due to mismatch in number of vertical grid points. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, the number of vertical grid points of the masked variables do not match the one of the current run. Therefore a new file is created instead. || ||[=#PA0337 PA0337] ||netCDF file for "..." data for mask "..." from previous run found but this file cannot be extended because the current output time is less or equal than the last output time on this file. New file is created instead. || This is a warning. A netCDF file from a previous run exist which is tried to be opened for extension. However, its last output time is greater than the first output time of the current run. Therefore a new file is created instead. || ||[=#PA0338 PA0338] ||netCDF file for "..." data for mask "..." from previous run found. This file will be extended. ||This is just an informative message and self-explanatory. || {{{#!tr {{{#!td [=#PA0339 PA0339] }}} {{{#!td nx+1 in ocean is not divisible by nx+1 in atmosphere without remainder }}} {{{#!td For coupling of atmosphere and ocean, a smaller grid length in the x-direction can be chosen for the ocean, so that the ocean has more grid points along x than the atmosphere. In that case, data must be interpolated from the atmosphere to the ocean grid. Therefore, it must be ensured that each atmosphere grid interval contains the same number of ocean gridpoints. This is ensured if the following holds: {{{#!Latex \[ (nx_o + 1) - INT \left( \frac{nx_o + 1}{nx_a + 1} \right) * (nx_a + 1) = 0 \; , \] }}} with {{{#!Latex \[ nx_o, nx_a \] }}} the number of grid points along x for the ocean and atmosphere model, respectively. \\ To avoid this error ensure that the above equation is fulfilled, i.e. that nx_o+1 is a multiple of nx_a+1. }}} }}} {{{#!tr {{{#!td [=#PA0340 PA0340] }}} {{{#!td coupling mode "...": ny+1 in ocean is not divisible by ny+1 in atmosphere without remainder }}} {{{#!td For coupling of atmosphere and ocean, a smaller grid length in the y-direction can be chosen for the ocean, so that the ocean has more grid points along y than the atmosphere. In that case, data must be interpolated from the atmosphere to the ocean grid. Therefore, it must be ensured that each atmosphere grid interval contains the same number of ocean gridpoints. This is ensured if the following holds: {{{#!Latex \[ (ny_o + 1) - INT \left( \frac{ny_o + 1}{ny_a + 1} \right) * (ny_a + 1) = 0 \; , \] }}} with {{{#!Latex \[ ny_o, ny_a \] }}} the number of grid points along y for the ocean and atmosphere model, respectively. \\ To avoid this error ensure that the above equation is fulfilled, i.e. that ny_o+1 is a multiple of ny_a+1. }}} }}} ||[=#PA0341 PA0341] || non-default setting of dz_soil does not allow to use pavement_type /= 0) ||Currently it is not possible to assign a user-defined number of soil layers when using pavement_type /= 0 as the individual depths of the pavements are fixed values. || ||[=#PA0342 PA0342] ||pavement_type = 0 (user_defined) requires setting of pavement_heat_conduct /= 9999999.9 || In case of a user-defined pavement type, the heat conductivity of the pavement must be given || ||[=#PA0343 PA0343] ||initializing_actions = 'initialize_vortex' is not allowed with conserve_volume_flow = .T. || Self-explanatory. Check [../initialization_parameters#conserve_volume_flow conserve_volume_flow] and/or [../initialization_parameters#initializing_actions initializing_actions] for different values. || ||[=#PA0344 PA0344] ||psolver must be called at each RK3 substep when 'ws-scheme' is used for momentum_advec. || The use of 5th-order advection scheme for the momentum equations requires a sufficiently large reduction of flow divergence to minimize numerical errors. Set [../initialization_parameters#call_psolver_at_all_substeps call_psolver_at_all_substeps] to true. || ||[=#PA0345 PA0345] ||uv_heights(1) must be 0.0 || See [../initialization_parameters#uv_heights uv_heights] for further instructions. || ||[=#PA0346 PA0346] ||u_profile(1) and v_profile(1) must be 0.0 || See [../initialization_parameters#u_profile u_profile] and [../initialization_parameters#v_profile v_profile] for further instructions. || ||[=#PA0347 PA0347] ||Coriolis force is switched on (omega /= 0.0) and initial profiles u_profile and v_profile are prescribed ||Per default the initial wind profile (u- and v-profile) is set to the geostrophic wind profile. However, the initial wind profile can also be set to a different profile with the initialization parameters ''u_profile'' and ''v_profile''. An initial wind profile that deviates too much from the geostrophic wind profile will cause strong inertia oscillations and thus the mean flow will take a long time to become steady state. The strength of the inertia oscillation can be significantly reduced, when the initial wind profile is set to the steady-state wind profile that might be obtained by a low-cost precursor simulation with a small domain and coarser grid spacing. || ||[=#PA0348 PA0348] || radiation_interactions_on is set to .FALSE. although vertical surfaces and/or trees exist. The model will run without RTM (no shadows, no radiation reflections) || This is just a warning (self-explanatory). Maybe you should change the namelist parameter radiation_interactions_on to TRUE to get more realistic results. || ||[=#PA0349 PA0349] || Incorrect type of plant canopy. Allowed values 0 <= pctype <= 10, but pctype is ... || Description will follow. || ||[=#PA0350 PA0350] ||unknown collision kernel: collision_kernel = "..." ||see package parameter [../particle_parameters#collision_kernel collision_kernel] for allowed values. || ||[=#PA0351 PA0351] ||heatflux must not be set for pure neutral flow ||Initialization parameter [../initialization_parameters#neutral neutral] = .TRUE. has been set, but non-zero values for parameters [../initialization_parameters#surface_heatflux surface_heatflux] and / or [../initialization_parameters#top_heatflux top_heatflux] are given at the same time. This is not allowed for simulating a flow with pure neutral stratification where the temperature equation is switched off. Check your parameter file. || ||[=#PA0352 PA0352] ||pavement_type = 0 (user_defined) requires setting of z0_pavement /= 9999999.9 || In case of a user-defined pavement type, the roughness length for momentum must be given by the user. || ||[=#PA0353 PA0353] ||pavement_type = 0 (user_defined) requires setting of z0h_pavement /= 9999999.9 || In case of a user-defined pavement type, the roughness length for heat must be given by the user. || ||[=#PA0354 PA0354] || It is not allowed to arrange more than 100 profiles with cross_profiles. Apart from that, all profiles are saved to the netCDF file. || This is just an informative message. All profiles are written to the netCDF file. Only the first 100 profiles will be plotted by palmplot pr with var=cross_profiles (default). To see all profiles, add the parameter var=all to palmplot pr. || ||[=#PA0355 PA0355] ||netcdf_deflate out of range \\ given value: ..., allowed range: 0-9 ||Set runtime-parameter [../runtime_parameters#netcdf_deflate netcdf_deflate] to a value within the allowed range || ||[=#PA0356 PA0356] ||netcdf_deflate reset to 0 ||You have set [../runtime_parameters#netcdf_data_format netcdf_data_format] /= 3 and [../runtime_parameters#netcdf_deflate netcdf_deflate] > 0 in the runtime_parameters-NAMELIST. However, data compression only works for the NetCDF4/HDF5 non-parallel format ([../runtime_parameters#netcdf_data_format netcdf_data_format] = 3). || ||[=#PA0357 PA0357] ||unknown cloud microphysics scheme cloud_scheme = "..." || Unknown cloud microphysics scheme. Allowed [../initialization_parameters#cloud_scheme cloud microphysics] schemes are "saturation_adjust", "kessler", "seifert_beheng" or "morrison". || ||[=#PA0358 PA0358] ||data_output_pr = '...' is not implemented for cloud_scheme /= ... || Output of profiles of rain drop number density (nr) or rain water mixing ratio (qr) is only allowed for [../initialization_parameters#cloud_scheme cloud_scheme] = "seifert_beheng". Output of profiles of cloud drop number density (nc) is only allowed for [../initialization_parameters#cloud_scheme cloud_scheme] = "morrison". || ||[=#PA0359 PA0359] ||output of "..." requires cloud_scheme = seifert_beheng || Output of 3d-data, cross-sections or masked data of rain drop number concentration (nr) or rain water content (qr) is only allowed for [../initialization_parameters#cloud_scheme cloud_scheme] = "seifert_beheng". Output of cloud drop number density (nc) is only allowed for [../initialization_parameters#cloud_scheme cloud_scheme] = "morrison". || ||[=#PA0360 PA0360] ||plant_canopy = .TRUE. requires cloud_scheme /= seifert_beheng || It is not allowed to use [../plant_canopy_parameters plant_canopy] with the [../initialization_parameters#cloud_scheme cloud_scheme] = "seifert_beheng". || ||[=#PA0361 PA0361] || output of ssws* requires passive_scalar=.TRUE. || Variables connected with passive_scalar, e.g. like the resolved-scale turbulent scalar flux w*s*, can only be output if [../initialization_parameters#passive_scalar passive_scalar] = '''.TRUE.''' || ||[=#PA0362 PA0362] ||nz >= 14 is required ||Due to an internal restriction, PALM currently requires more than 13 vertical grid levels. Increase the number of vertical grid levels in the initialization_parameters namelist (parameter nz). || ||[=#PA0363 PA0363] ||No time dependent surface variables in LSF_DATA for end of run found ||PALM detected an end-of-file condition for the surface values in [../../app/iofiles#LSF_DATA LSF_DATA] and aborts. Possible reasons could be that no or too less time dependent surface variables are provided in the large scale forcing file. || ||[=#PA0364 PA0364] ||zu(k) = ... m is higher than the maximum height in NUDING_DATA which is ...m. Interpolation on PALM grid is not possible. || [../../app/iofiles#NUDGING_DATA NUDGING_DATA] has a maximum vertical height that is smaller than the vertical extent of the grid used in PALM. Hence, interpolation of the [../../app/iofiles#NUDGING_DATA NUDGING_DATA] onto the PALM grid is not possible. Reduce either the vertical extent of the PALM modeling domain or enlarge the NUDING_DATA file correspondingly. Note: it is also possible that your file [../../app/iofiles#NUDGING_DATA NUDGING_DATA] is not formatted correctly and that there has been an error while reading it. || ||[=#PA0365 PA0365] ||file NUDGING_DATA does not exist ||Make sure that the file ''basename_nudge'' containing the nudging profiles as described in [../../app/iofiles#NUDGING_DATA NUDGING_DATA] is provided in the INPUT folder of the respective run on the host where the job is running. || ||[=#PA0366 PA0366] ||errors in file NUDGING_DATA ||PALM has problems reading the file ''basename_nudge''. Possible reasons could be that the format described in [../../app/iofiles#NUDGING_DATA NUDGING_DATA] is not followed closely. || ||[=#PA0367 PA0367] ||unknown prognostic variable ... ||The tendency due to nudging can only be applied to the prognostic variable u, v, pt and q. Make sure that one of the variables is used. || ||[=#PA0368 PA0368] ||file LSF_DATA does not exist ||Make sure that the file ''basename_lsf'' containing surface fluxes, surface temperature, humidity and pressure as well as profiles of the geostrophic wind components and large scale subsidence described in [../../app/iofiles#LSF_DATA LSF_DATA] is provided in the INPUT folder of the respective run on the host where the job is running. || ||[=#PA0369 PA0369] ||errors in file LSF_DATA ||PALM has problems reading the file ''basename_lsf''. Possible reasons could be that the format described in [../../app/iofiles#LSF_DATA LSF_DATA] is not followed closely. || ||[=#PA0370 PA0370] ||Initial profiles of u, v, pt and q from NUDGING_DATA are used. ||Informative message that initial profiles from the nudging file are used. || ||[=#PA0371 PA0371] ||Time dependent surface variables in LSF_DATA set in after end of simulation - lsf_surf is set to FALSE ||This messages appears in the case that the first time step of the surface values read in from [../../app/iofiles#LSF_DATA LSF_DATA] is larger than the end time of the simulation. In this case the surface heat and water fluxes prescribed in [../../app/iofiles#LSF_DATA LSF_DATA] cannot be used. || ||[=#PA0372 PA0372] ||No time dependent vertical profiles in LSF_DATA for end of run found ||PALM detected an end-of-file condition for the profile data in [../../app/iofiles#LSF_DATA LSF_DATA] and aborts. Possible reasons could be that no time dependent profile data is provided in the large scale forcing file. || ||[=#PA0373 PA0373] ||Time dependent large scale profile forcing from LSF_DATA sets in after end of simulation - lsf_vert is set to FALSE ||This messages appears in the case that the first time step of the profile data read in from [../../app/iofiles#LSF_DATA LSF_DATA] is larger than the end time of the simulation. In this case the geostrophic wind profiles and large scale subsidence profile prescribed in [../../app/iofiles#LSF_DATA LSF_DATA] cannot be used. || ||[=#PA0374 PA0374] ||Nudging requires large_scale_forcing = .T.. Surface fluxes and geostrophic wind should be prescribed in file LSF_DATA ||In order to use nudging it is required to use [../initialization_parameters#large_scale_forcing large_scale_forcing] = .T., too. The surface values and profiles needed in [../../app/iofiles#LSF_DATA LSF_DATA] should correspond to the data provided in [../../app/iofiles#NUDGING_DATA NUDGING_DATA]. || ||[=#PA0375 PA0375] ||Non-cyclic lateral boundaries do not allow for the usage of large scale forcing from external file. ||Large scale [../initialization_parameters#large_scale_forcing forcing] (and also nudging) are not implemented/tested for non-cyclic boundary conditions so far. || ||[=#PA0376 PA0376] ||The usage of large scale forcing from external file [../../app/iofiles#LSF_DATA LSF_DATA] requires humidity = .T.. ||If you want to use [../initialization_parameters#large_scale_forcing large_scale_forcing] (and also nudging) from an external file, you need to run PALM with [../initialization_parameters#humidity humidity]. || ||[=#PA0377 PA0377] ||The usage of large scale forcing from external file LSF_DATA is not implemented for non-flat topography ||Please use [../initialization_parameters#topography topography] = 'flat' or refrain from using large scale [../initialization_parameters#large_scale_forcing forcing]. || ||[=#PA0378 PA0378] ||The usage of large scale forcing from external file [../../app/iofiles#LSF_DATA LSF_DATA] is not implemented for ocean runs ||Please use [../initialization_parameters#ocean ocean] = .F. or refrain from using large scale [../initialization_parameters#large_scale_forcing forcing]. || ||[=#PA0379 PA0379] ||water_type = 0 (user_defined) requires setting of water_temperature /= 9999999.9 || When the [../land_surface_parameters#water_type water_type] is set to be user-defined, a water temperature must be prescribed. || ||[=#PA0380 PA0380] ||There is no default large scale vertical velocity profile set. Specify the subsidence velocity profile via subs_vertical_gradient and subs_vertical_gradient_level. ||With [../initialization_parameters#large_scale_subsidence large_scale_subsidence] = .T. but without [../initialization_parameters#large_scale_forcing large_scale_forcing] a profile for the subsidence velocity w_subs has to be prescribed. See [../initialization_parameters#subs_vertical_gradient_level subs_vertical_gradient_level]. || ||[=#PA0381 PA0381] ||Enable usage of large scale subsidence by setting large_scale_subsidence = .T.. ||[../initialization_parameters#subs_vertical_gradient_level subs_vertical_gradient_level] requires [../initialization_parameters#large_scale_subsidence large_scale_subsidence] = .T.. || ||[=#PA0382 PA0382] ||data_output_pr = w_subs is not implemented for large_scale_subsidence = .FALSE. ||w_subs can only be part of the profile output if [../initialization_parameters#large_scale_subsidence large_scale_subsidence] = .T.. || ||[=#PA0383 PA0383] ||netCDF file formats 5 (parallel netCDF 4) and 6 (parallel netCDF 4 Classic model) are currently not supported (not yet tested) for masked data. Using respective non-parallel output for masked data. ||So far, parallel NetCDF output is not available for masked data. If the user is setting the parameter [wiki:doc/app/runtime_parameters#netcdf_data_format netcdf_data_format] to five or six for getting parallel output, [wiki:doc/app/runtime_parameters#netcdf_data_format netcdf_data_format] is set internally to three or four for masked data. || {{{#!tr {{{#!td [=#PA0384 PA0384] }}} {{{#!td Output of xy cross-sections is not given at t='...' because the maximum number of output time levels is exceeded. }}} {{{#!td In case of parallel NetCDF output, the time dimension is limited for increasing the performance. The number of time levels is calculated at the beginning of the simulation by the formula: {{{#!Latex \[ \frac{end\_time - skip\_time\_do2d\_xy}{dt\_do2d\_xy} \; . \] }}} The parameters [wiki:doc/app/runtime_parameters#end_time end_time], [wiki:doc/app/runtime_parameters#skip_time_do2d_xy skip_time_do2d_xy] and [wiki:doc/app/runtime_parameters#dt_do2d_xy dt_do2d_xy] can be set by the user. If this limit is exceeded, this warning is given and an output of xy-sections is not done anymore. \\ This could be the case if the simulated time exceeds the given end time by the length of the given output interval. In this case, the user can start a restart run and give an output at the beginning. }}} }}} {{{#!tr {{{#!td [=#PA0385 PA0385] }}} {{{#!td Output of xz cross-sections is not given at t='...' because the maximum number of output time levels is exceeded. }}} {{{#!td In case of parallel NetCDF output, the time dimension is limited for increasing the performance. The number of time levels is calculated at the beginning of the simulation by the formula: {{{#!Latex \[ \frac{end\_time - skip\_time\_do2d\_xz}{dt\_do2d\_xz} \; . \] }}} The parameters [wiki:doc/app/runtime_parameters#end_time end_time], [wiki:doc/app/runtime_parameters#skip_time_do2d_xz skip_time_do2d_xz] and [wiki:doc/app/runtime_parameters#dt_do2d_xz dt_do2d_xz] can be set by the user. If this limit is exceeded, this warning is given and an output of xz-sections is not done anymore. \\ This could be the case if the simulated time exceeds the given end time by the length of the given output interval. In this case, the user can start a restart run and give an output at the beginning. }}} }}} {{{#!tr {{{#!td [=#PA0386 PA0386] }}} {{{#!td Output of yz cross-sections is not given at t='...' because the maximum number of output time levels is exceeded. }}} {{{#!td In case of parallel NetCDF output, the time dimension is limited for increasing the performance. The number of time levels is calculated at the beginning of the simulation by the formula: {{{#!Latex \[ \frac{end\_time - skip\_time\_do2d\_yz}{dt\_do2d\_yz} \; . \] }}} The parameters [wiki:doc/app/runtime_parameters#end_time end_time], [wiki:doc/app/runtime_parameters#skip_time_do2d_yz skip_time_do2d_yz] and [wiki:doc/app/runtime_parameters#dt_do2d_yz dt_do2d_yz] can be set by the user. If this limit is exceeded, this warning is given and an output of yz-sections is not done anymore. \\ This could be the case if the simulated time exceeds the given end time by the length of the given output interval. In this case, the user can start a restart run and give an output at the beginning. }}} }}} {{{#!tr {{{#!td [=#PA0387 PA0387] }}} {{{#!td Output of 3d data is not given at t='...' because the maximum number of output time levels is exceeded. }}} {{{#!td In case of parallel NetCDF output, the time dimension is limited for increasing the performance. The number of time levels is calculated at the beginning of the simulation by the formula: {{{#!Latex \[ \frac{end\_time - skip\_time\_do3d}{dt\_do3d} \; . \] }}} The parameters [wiki:doc/app/runtime_parameters#end_time end_time], [wiki:doc/app/runtime_parameters#skip_time_do3d skip_time_do3d] and [wiki:doc/app/runtime_parameters#dt_do3d dt_do3d] can be set by the user. If this limit is exceeded, this warning is given and an output of 3d data is not done anymore. \\ This could be the case if the simulated time exceeds the given end time by the length of the given output interval. In this case, the user can start a restart run and give an output at the beginning. }}} }}} {{{#!tr {{{#!td [=#PA0388 PA0388] }}} {{{#!td netCDF file for volume data "..." from previous run found, but this file cannot be extended because the number of output time levels has been increased compared to the previous simulation. New file is created instead.' }}} {{{#!td In case of parallel NetCDF output, the time dimension is limited for increasing the performance. The number of time levels is calculated at the beginning of the simulation by the formula: {{{#!Latex \[ \frac{end\_time - skip\_time\_do3d}{dt\_do3d} \; . \] }}} The parameters [wiki:doc/app/runtime_parameters#end_time end_time], [wiki:doc/app/runtime_parameters#skip_time_do3d skip_time_do3d] and [wiki:doc/app/runtime_parameters#dt_do3d dt_do3d] can be set by the user. If the calculated number of maximum time levels between the initial run and a restart run changed by modifing on of the parameters above, a new output file is created. }}} }}} {{{#!tr {{{#!td [=#PA0389 PA0389] }}} {{{#!td netCDF file for cross sections "..." from previous run found, but this file cannot be extended because the number of output time levels has been increased compared to the previous simulation. New file is created instead.' }}} {{{#!td In case of parallel NetCDF output, the time dimension is limited for increasing the performance. The number of time levels is calculated at the beginning of the simulation by the formula: {{{#!Latex \[ \frac{end\_time - skip\_time\_do2d\_xy}{dt\_do2d\_xy} \; . \] }}} The parameters [wiki:doc/app/runtime_parameters#end_time end_time], [wiki:doc/app/runtime_parameters#skip_time_do2d_xy skip_time_do2d_xy] and [wiki:doc/app/runtime_parameters#dt_do2d_xy dt_do2d_xy] can be set by the user. If the calculated number of maximum time levels between the initial run and a restart run changed by modifying on of the parameters above, a new output file is created. }}} }}} {{{#!tr {{{#!td [=#PA0390 PA0390] }}} {{{#!td netCDF file for cross sections "..." from previous run found, but this file cannot be extended because the number of output time levels has been increased compared to the previous simulation. New file is created instead.' }}} {{{#!td In case of parallel NetCDF output, the time dimension is limited for increasing the performance. The number of time levels is calculated at the beginning of the simulation by the formula: {{{#!Latex \[ \frac{end\_time - skip\_time\_do2d\_xz}{dt\_do2d\_xz} \; . \] }}} The parameters [wiki:doc/app/runtime_parameters#end_time end_time], [wiki:doc/app/runtime_parameters#skip_time_do2d_xz skip_time_do2d_xz] and [wiki:doc/app/runtime_parameters#dt_do2d_xz dt_do2d_xz] can be set by the user. If the calculated number of maximum time levels between the initial run and a restart run changed by modifing on of the parameters above, a new output file is created. }}} }}} {{{#!tr {{{#!td [=#PA0391 PA0391] }}} {{{#!td netCDF file for cross sections "..." from previous run found, but this file cannot be extended because the number of output time levels has been increased compared to the previous simulation. New file is created instead.' }}} {{{#!td In case of parallel NetCDF output, the time dimension is limited for increasing the performance. The number of time levels is calculated at the beginning of the simulation by the formula: {{{#!Latex \[ \frac{end\_time - skip\_time\_do2d\_yz}{dt\_do2d\_yz} \; . \] }}} The parameters [wiki:doc/app/runtime_parameters#end_time end_time], [wiki:doc/app/runtime_parameters#skip_time_do2d_yz skip_time_do2d_yz] and [wiki:doc/app/runtime_parameters#dt_do2d_yz dt_do2d_yz] can be set by the user. If the calculated number of maximum time levels between the initial run and a restart run changed by modifing on of the parameters above, a new output file is created. }}} }}} ||[=#PA0392 PA0392] ||water_type = 0 (user_defined) requires setting of z0h_water /= 9999999.9' ||If the [../land_surface_parameters#water_type water_type] is set to be user-specific, it is essential to prescribe a roughness length for heat (in m) for water surface types. || {{{#!tr {{{#!td [=#PA0393 PA0393] }}} {{{#!td data_output_pr = ... is not implemented for large_scale_forcing = .FALSE. }}} {{{#!td The listed entries in the parameter file under [../runtime_parameters#data_output_pr data_output_pr] are only avialable for [../initialization_parameters#large_scale_forcing large_scale_forcing] = .T.. }}} }}} {{{#!tr {{{#!td [=#PA0394 PA0394] }}} {{{#!td data_output_pr = ... is not implemented for nudging = .FALSE. }}} {{{#!td The listed entries in the parameter file under [../runtime_parameters#data_output_pr data_output_pr] are only avialable for [../initialization_parameters#nudging nudging] = .T.. }}} }}} ||[=#PA0395 PA0395] ||zu(...) = ... m is higher than the maximum height in LSF_DATA which is ...m. Interpolation on PALM grid is not possible. || [../../app/iofiles#LSF_DATA LSF_DATA] has a maximum vertical height that is smaller than the vertical extent of the grid used in PALM. Hence, interpolation of the [../../app/iofiles#LSF_DATA LSF_DATA] onto the PALM grid is not possible. Reduce either the vertical extent of the PALM modeling domain or enlarge the [../../app/iofiles#LSF_DATA LSF_DATA] file correspondingly. Note: it is also possible that your file [../../app/iofiles#LSF_DATA LSF_DATA] is not formatted correctly and that there has been an error while reading it. || ||[=#PA0396 PA0396] ||The usage of use_subsidence_tendencies requires large_scale_subsidence = .T.. || If [../initialization_parameters#use_subsidence_tendencies use_subsidence_tendencies] is used, subsidence tendencies for temperature and humidity are read in from the external file [../../app/iofiles#LSF_DATA LSF_DATA]. However, these tendencies can only be applied to the prognostic variables if [../initialization_parameters#large_scale_subsidence large_scale_subsidence] = .T.. || ||[=#PA0397 PA0397] ||The usage of use_subsidence_tendencies requires large_scale_forcing = .T.. || If [../initialization_parameters#use_subsidence_tendencies use_subsidence_tendencies] is used, subsidence tendencies for temperature and humidity are read in from the external file [../../app/iofiles#LSF_DATA LSF_DATA]. This requires [../initialization_parameters#large_scale_forcing large_scale_forcing] = .T.. || ||[=#PA0398 PA0398] ||run will be terminated because user forced a job finialization using a flag file: DO_STOP_NOW: "..." DO_RESTART_NOW: "..." ||The user can force an unscheduled termination/restart of the running job by creating one of the flag files {{{DO_STOP_NOW}}} or {{{DO_RESTART_NOW}}} in the temporary directory of the job. || ||[=#PA0399 PA0399] ||lsm requires setting of [../initialization_parameters#bc_pt_b bc_pt_b] = "dirichlet" and [../initialization_parameters#bc_q_b bc_q_b] = "dirichlet" ||In case the land surface model (LSM) is used, the surface fluxes have to be calculated by means of surface values of potential temperature and humidity (that are provided by the LSM), which reflects setting dirichlet boundary conditions. || ||[=#PA0400 PA0400] ||lsm requires ...||When using the LSM it is required to use a [../initialization_parameters#constant_flux_layer constant_flux_layer] and the [../radiation_parameters#RadiationParameters radiation model]. || ||[=#PA0401 PA0401] ||vegetation_type = 0 (user defined) requires setting of ...||In case a user-defined vegetation is used, all LSM parameters must be explicitly set by the user. See [../land_surface_parameters#vegetation_type vegetation_type] || ||[=#PA0402 PA0402] ||data_output_pr = ... is not implemented for land_surface = .FALSE. ||The chosen quantity is related to the LSM, but the LSM was not activated. || ||[=#PA0403 PA0403] ||soil_type = 0 (user_defined) requires setting of ...||In case a user-defined soil type is used, all soil parameters must be explicitly set by the user. See [../land_surface_parameters#soil_type soil_type] || ||[=#PA0404 PA0404] ||output of ... requires land_surface = .TRUE. (or urban_surface = .TRUE.) ||The requested output quantity is only available when using the LSM (or USM). || ||[=#PA0405 PA0405] ||unknown radiation_scheme = ... ||For a list of available radiation schemes, see [wiki:doc/app/radiation_parameters#radiation_scheme radiation_scheme]. || ||[=#PA0406 PA0406] ||output of ... requires radiation = .TRUE. and radiation_scheme = "rrtmg"||The requested output quantity is only available when using the RRTMG [../radiation_parameters#radiation_scheme radiation_scheme]. || ||[=#PA0407 PA0407] ||radiation_scheme = "rrtmg" requires compilation of PALM with pre-processor directive -D_rrtmg||In order to use RRTMG, the radiation code must be installed as external (shared or static) library and PALM must be compiled with {{{-D__rrtmg}}} listed in the {{{%cpp_options}}}. For further details, see [wiki:doc/tec/radiation#Installation here] || ||[=#PA0408 PA0408] ||data_output_pr = ... is not available for radiation = .FALSE. or radiation_scheme = "constant"||The desired output (here radiation fluxes) is only available for [../radiation_parameters#radiation_scheme radiation_scheme] = "clear-sky" or "rrtmg". || ||[=#PA0409 PA0409] ||output of ... requires radiation = .TRUE. and radiation_scheme = "rrtmg" || The desired output (here: surface albedos) is only available when using [../radiation_parameters#radiation_scheme radiation_scheme] = "rrtmg" || ||[=#PA0410 PA0410] ||radiation_scheme = "clear-sky" in combination with albedo_type = 0 requires setting of albedo /= 9999999.9' ||The choice of a user-defined albedo requires manual setting of the albedo as there is no default value set. See [../radiation_parameters#radiation_scheme radiation_scheme] || ||[=#PA0411 PA0411] ||radiation_scheme = "rrtmg" in combination with albedo_type = 0 requires setting of albedo_lw_dif /= 9999999.9, albedo_lw_dir /= 9999999.9, albedo_sw_dif /= 9999999.9 and albedo_sw_dir /= 9999999.9 ||The choice of a user-defined albedo requires manual setting of all four albedos for direct/diffuse longwave/shortwave radiation as there is no default value set. See [../radiation_parameters#radiation_scheme radiation_scheme] || ||[=#PA0412 PA0412] ||radiation_scheme = "rrtmg" requires the use of NetCDF (preprocessor directive -D_netcdf' ||The RRTMG library reads atmospheric profiles unsing NetCDF by default. Therefore NetCDf must be activated when using RRTMG. || ||[=#PA0413 PA0413] ||data_output_pr = "..." is not avalable for radiation = .FALSE. or radiation_scheme /= "rrtmg" ||Radiative heating rates are only available when using the full RRTMG radiation scheme. || ||[=#PA0414 PA0414] ||nested child domain lower left corner [and upper right corner and height] must match its parent grid lines ||nested child domain lower left corner (x,y) [and upper right corner (x,y) and top (z)] coordinates must match the parent grid lines, i.e. they must be integer divisible by the parent grid spacings in the respective coordinate direction || ||[=#PA0415 PA0415] ||water_type = 0 (user_defined) requires setting of z0_water /= 9999999.9' ||If the [../land_surface_parameters#water_type water_type] is set to be user-specific, it is essential to prescribe a roughness length for momentum (in m) for water surface types. || ||[=#PA0416 PA0416] ||nesting grid-spacing ratio ( parent dx / child dx [or dy or dz, respectively] ) must have an integer value [for each z-level] || Parent / child grid spacing ratios in each coordinate direction must be integer valued. This also implies that vertical grid stretching is not allowed in nested runs except in the root domain above the top level of the highest nest-domain || ||[=#PA0417 PA0417] ||illegal nesting mode: ... ||Allowed values for [../nesting_parameters#nesting_mode nesting_mode] are 'one-way' or 'two-way'. || ||[=#PA0418 PA0418] ||illegal nesting datatransfer mode: ... ||Allowed values for [../nesting_parameters#nesting_datatransfer_mode nesting_datatransfer_mode] are 'cascade', 'mixed' or 'overlap'. || ||[=#PA0419 PA0419] ||mismatch between root model and child settings: \\ (root) = ... \\ (child) = ... \\ child value is set to root value ||The displayed parameter has been assigned different values for the root domain and a child domain (the id of the child domain is listed in the first line of the message) but it must have the same value for all domains. PALM automatically adjusts the child domain value to the one given for the root domain. In order to get rid of this warning message, adjust the parameter in the respective NAMELIST-parameter file of the child (or root) domain.|| ||[=#PA0420 PA0420] ||Number of agents exceeds agent dimension. \\ Starting at time_since_reference_point = s, \\ data may be missing. \\ Number of agents: \\ Agent dimension size: ||This is a result of the user manually setting either [../agent_parameters#dim_size_agtnum_manual dim_size_agtnum_manual] or [../agent_parameters#dim_size_factor_agtnum dim_size_factor_agtnum] or both, resulting in the agent-number dimension of [../iofiles#DATA_AGT_NETCDF DATA_AGT_NETCDF] becoming smaller than the number of agents the MAS tries to ouput. Please adjust the parameters accordingly. || ||[=#PA0421 PA0421] ||Using synthetic turbulence generator requires random_generator = random-parallel.|| || ||[=#PA0422 PA0422] ||data_output_pr = ... is not available for cloud_scheme = saturation_adjust || If the output is not necessary, delete the variable from the namelist. If it is necessary, use [../initialization_parameters#cloud_scheme cloud_scheme] = kessler, seifert_beheng or morrison. || ||[=#PA0423 PA0423] ||output of "..." is not available for cloud_scheme = saturation_adjust || If the output is not necessary, delete the variable from the namelist. If it is necessary, use [../initialization_parameters#cloud_scheme cloud_scheme] = kessler or seifert_beheng. || ||[=#PA0424 PA0424] ||roughness_length must be smaller than dz/2 || The roughness length has to be smaller than the constant flux layer, which is dz/2. || ||[=#PA0425 PA0425] ||nested child domain does not fit into its parent domain || A nest domain does not completely fit in its parent domain, or in case of vertical nesting mode, the horizontal boundaries of a nest domain do not exactly match the horizontal boundaries of its parent domain. In 3D-nesting mode, the vertical extent of the child must be smaller than that of the parent domain. || ||[=#PA0426 PA0426] ||nested parallel child domains overlap || Two or more parallel nest domains overlap each other in space. Parallel nest domains must never overlap. || ||[=#PA0427 PA0427] ||at least one dimension of lower left corner of one domain is not 0. All lower left corners were set to (0, 0) || In case of vertical nesting mode all domains must have lower left corner at x=0, y=0. If defined otherwise in PARIN, palm will reset it. || ||[=#PA0428 PA0428] ||bc_** changed to cyclic for "..." nesting || If a child extends over the complete root domain along x and/or y, it must use cyclic boundary conditions along that direction. If defined otherwise within the initializing_parameters namelist, palm will reset them, respectively. || ||[=#PA0429 PA0429] ||parent buffer too small ...|| Error happens in PALM model coupler for the parent domain ([source:palm/trunk/SOURCE/pmc_parent_mod.f90]): parent buffer too small. This should not happen. Please submit a [/newticket trouble ticket]. || ||[=#PA0430 PA0430] ||hole(s) resolved by only one grid point were filled || Topography was filtered, i.e. holes resolved by only one grid point are filled. These holes are suspected to possibly lead to a velocity blow-up. Moreover, continuity equation cannot be fulfilled in such holes on a discrete grid. || ||[=#PA0431 PA0431] || Start x position is outside the model domain || Start position for virtual flight must be within the model domain. || ||[=#PA0432 PA0432] || Start y position is outside the model domain || Start position for virtual flight must be within the model domain. || ||[=#PA0433 PA0433] || Cyclic flight leg does not match lateral boundary condition || Virtual flights can only be in cyclic-mode if lateral model boundary are cyclic. || ||[=#PA0434 PA0434] || Flight leg or parts of it are outside the model domain || End position must be within the model domain in case of return-legs. || ||[=#PA0435 PA0435] || Unknown flight mode || [../virtual_flight_parameters/#leg_mode leg_mode] can either be 'cyclic' or 'return'. || ||[=#PA0436 PA0436] || surface element at grid point (j,i) = ( ... ) is not a vegetation surface, so that information given in vegetation_pars is neglected. || || ||[=#PA0437 PA0437] || If topography information is provided (via Netcdf or ASCII input) topography = "read_from_file" is required. || || ||[=#PA0438 PA0438] || Flight level is outside the model domain || Flight level is above domain top or below 0. || ||[=#PA0439 PA0439] || The variable XXX is defined at least twice. Duplication(s) is removed || This warning appears if a variable is defined at least twice in the list [../surface_data_output_parameters/#data_output_surf data_output_surf]. Please avoid assigning variables multiple times in your output lists. || ||[=#PA0440 PA0440] || The usage of large scale forcing from external file LSF_DATA is not implemented for passive scalars || So far, large-scale forcing for passive scalars is not implemented. || ||[=#PA0441 PA0441] ||boundary condition: bc_s_t = "..." is not allowed with top_scalarflux /= 0.0' ||You have tried to set both, a Dirichlet boundary condition for scalar at the top (with [../initialization_parameters#bc_s_t bc_s_t] = '' 'dirichlet' ''), or an initial-gradient boundary condition, and a scalar flux at the top (with [../initialization_parameters#top_scalarflux top_scalarflux] /= ''0.0''). || ||[=#PA0442 PA0442] ||bulk_cloud_model = .TRUE. is not allowed with cloud_droplets = .TRUE. ||Either second-order moment adjustment scheme or Lagrangian cloud physics can be applied, not both at the same time || ||[=#PA0443 PA0443] ||wall_heatflux additionally requires setting of surface_heatflux ||As [../initialization_parameters#wall_heatflux wall_heatflux] only describes the kinematic flux at topography walls at non-zero height levels, additional setting of [../initialization_parameters#surface_heatflux surface_heatflux] is required for the kinematic flux at the surface. || ||[=#PA0444 PA0444] ||wall_humidityflux additionally requires setting of surface_waterflux ||As [../initialization_parameters#wall_humidityflux wall_humidityflux] only describes the kinematic flux at topography walls at non-zero height levels, additional setting of [../initialization_parameters#surface_waterflux surface_waterflux] is required for the kinematic flux at the surface. || ||[=#PA0445 PA0445] ||wall_scalarflux additionally requires setting of surface_scalarflux ||As [../initialization_parameters#wall_scalarflux wall_scalarflux] only describes the kinematic flux at topography walls at non-zero height levels, additional setting of [../initialization_parameters#surface_scalarflux surface_scalarflux] is required for the kinematic flux at the surface. || ||[=#PA0446 PA0446] ||unknown approximation: approximation = ... ||This error message appears if the parameter [../initialization_parameters#approximation approximation] is not set to one of the allowed values 'boussinesq' or 'anelastic'. || ||[=#PA0447 PA0447] ||Anelastic approximation requires momentum_advec = "ws-scheme ||The anelastic approximation requires: [../initialization_parameters#momentum_advec momentum_advec] = 'ws-scheme'. Currently no other advection scheme is allowed with [../initialization_parameters#approximation approximation] = 'anelastic'. || ||[=#PA0448 PA0448] ||Anelastic approximation currently only supports: psolver = "poisfft", psolver = "sor" and psolver = "multigrid_noopt" ||The anelastic approximation requires: [../initialization_parameters#psolver psolver] to be set to one of 'poisfft', 'sor' or 'multigrid_noopt'. Currently no other pressure solver is allowed with [../initialization_parameters#approximation approximation] = 'anelastic'. || ||[=#PA0449 PA0449] ||Anelastic approximation is not allowed with conserve_volume_flow = .TRUE. ||The anelastic approximation is not allowed with: [../initialization_parameters#conserve_volume_flow conserve_volume_flow] = .TRUE. || ||[=#PA0450 PA0450] ||unknown flux input mode: flux_input_mode = ... ||This error message appears if the parameter [../initialization_parameters#flux_input_mode flux_input_mode] is not set to one of the allowed values 'dynamic', 'kinematic' or 'application-specific'. || ||[=#PA0451 PA0451] ||unknown flux output mode: flux_output_mode = ... ||This error message appears if the parameter [../initialization_parameters#flux_output_mode flux_output_mode] is not set to one of the allowed values 'dynamic', 'kinematic' or 'application-specific'. || ||[=#PA0452 PA0452] || Soil type is out of the valid range || between 1 and 6 || ||[=#PA0453 PA0453] ||incompatible integer arithmetic: ... ||This error message appears if the compiler integer arithmetic is not compatible with the assumptions made for the parallel random number generator. If this is the case the internal checks that the kind value isp is in fact a 32-bit integer with the usual properties that we expect it to have (under negation and wrap-around addition) fail. || ||[=#PA0454 PA0454] ||problem in attempt to allocate memory ||This error message appears if the parallel random number generator is not able to allocate sufficient memory. || ||[=#PA0455 PA0455] ||Tunnel width too small ||[../initialization_parameters#tunnel_width_y tunnel_width_y] - 2.0*[../initialization_parameters#tunnel_wall_depth tunnel_wall_depth] must be > 2*[../initialization_parameters#dy dy] || ||[=#PA0456 PA0456] ||Tunnel width too large ||[../initialization_parameters#tunnel_width_y tunnel_width_y] must be <= ([../initialization_parameters#ny ny]+1)*[../initialization_parameters#dy dy] || ||[=#PA0457 PA0457] ||The maximumn number of agents durin this run was . Consider adjusting the INPUT parameter [../agent_parameters#dim_size_agtnum_manual dim_size_agtnum_manual] accordingly for the next run. ||This informative message is given at the end of every job that uses the [wiki:doc/tec/mas Multi Agent System]. In order to avoid unnecessarily large files, try to set [../agent_parameters#dim_size_agtnum_manual dim_size_agtnum_manual] as close to the maximum number of agents during the simulation. || ||[=#PA0458 PA0458] || soil_moisture must not exceed its saturation value ||This error can occur when the soil moisture is higher than the saturation moisture for the given vegetation type. Check and may adjust parameters [../land_surface_parameters#saturation_moisture saturation_moisture] or [../land_surface_parameters#soil_moisture soil_moisture]. || ||[=#PA0459 PA0459] || unknown aerosol type 'aero_type = ...' ||Chose an appropriate value for [../particle_parameters#aero_type aero_type]. || ||[=#PA0460 PA0460] || wrong settings for stokes_wavelength and/or stokes_waveheight || If you set parameters stokes_wavelength and stokes_waveheight to switch on the Stokes force in ocean mode, they must '''both''' be set > 0.0. Values < 0.0 are not allowed. || ||[=#PA0461 PA0461] || pitch_control = .TRUE. requires speed_control = .TRUE. || Self-explanatory. See [../wind_turbine_parameters#pitch_control pitch_control] and [../wind_turbine_parameters#speed_control speed_control]. || ||[=#PA0462 PA0462] || omega_rot < 0.0, Please set omega_rot to a value larger than or equal to zero || Self-explanatory. See [../wind_turbine_parameters#omega_rot omega_rot]. || ||[=#PA0463 PA0463] || rcx, rcy, rcz have to be given for each turbine. || The position of each turbine has to be specified. See [../wind_turbine_parameters#rcx rcx], [../wind_turbine_parameters#rcy rcy] and [../wind_turbine_parameters#rcz rcz]. || ||[=#PA0464 PA0464] || file WTM_DATA does not exist || Make sure that the file [../iofiles#WTM_DATA WTM_DATA] containing physical characteristics of the blades, as described in [[source:/palm/trunk/EXAMPLES/wind_turbine/example_wtm.txt| example_wtm.txt]], is provided in the INPUT folder of the respective run on the host where the job is running. || ||[=#PA0465 PA0465] || surface_type = netcdf requires static input file. || Either provide the file [../iofiles#PIDS_STATIC PIDS_STATIC] or change the value of [../land_surface_parameters#surface_type surface_type] to a value different than netcdf. || ||[=#PA0466 PA0466] || wrong component of wave breaking: ... || Only the two Cartesian components 1 and 2 are allowed for adding wave breaking effects in ocean mode. || ||[=#PA0467 PA0467] || y_shift /= 0 is only allowed for cyclic boundary conditions in both directions || y_shift defines a shift in the cyclic boundary conditions. It can therefore only be used with cyclic boundary conditions. See [../initialization_parameters#y_shift y_shift]. || ||[=#PA0468 PA0468] || y_shift /= 0 is only allowed for multigrid pressure solvers || y_shift defines a shift in the cyclic boundary conditions. The data then becomes not truly cyclic anymore. Therefore, the fft pressure solver is no longer viable. See [../initialization_parameters#y_shift y_shift]. || ||[=#PA0469 PA0469] || unknown aerosol species for bulk microphysics || aerosol species must be set to a known type. See [../initialization_parameters#aerosol_bulk aerosol_bulk]. || ||[=#PA0470 PA0470] || unknown aerosol species for lagrangian cloud microphysics || aerosol species must be set to a known type. See [../particle_parameters#aero_species aero_species]. || ||[=#PA0471 PA0471] || number of soil layers (...) does not match to the number of layers specified in soil_temperature (...) || For each soil layer an initial soil temperature must be prescribed (see [wiki:doc/app/land_surface_parameters#soil_temperature soil_temperature]). The number of soil layers is defined by [wiki:doc/app/land_surface_parameters#dz_soil dz_soil]. || ||[=#PA0472 PA0472] || deep_soil_temperature is not set but must be /= 9999999.9 || Since r2729 the [../land_surface_parameters#deep_soil_temperature deep_soil_temperature] is no longer part of the soil_temperature array and must be specific separately. The deep soil temperature serves as bottom boundary condition for heat diffusion in the soil model. Note that there is no analogous value for soil moisture as the bottom of the soil can either be set to bedrock (water accumulates) or free drainage (water is lost). || ||[=#PA0473 PA0473] || Vertical grid stretching is not allowed for complex_terrain = .T. || Self-explanatory. See [../initialization_parameters#complex_terrain complex_terrain] and [../initialization_parameters#dz_stretch_level dz_stretch_level]. || ||[=#PA0474 PA0474] ||pavement_type = 0 (user_defined) requires setting of pavement_depth_level /= 0 ||When a user-defined pavement is prescribed, a depth must be asigned that determines how deep the pavement extends into the ground. The [../land_surface_parameters#pavement_heat_capacity pavement heat capacity] and [../land_surface_parameters##pavement_heat_cond pavement heat conductivty] are then asigned to all those levels. || ||[=#PA0475 PA0475] || Particle violated CFL-criterion: particle with id ... will be deleted! || This is a warning that some of your particles moves too fast. Therefore they will be deleted. || ||[=#PA0476 PA0476] || Humidity has to be set to .T. in the _p3d file for coupled runs between ocean and atmosphere. || Set [../initialization_parameters#humidity humidity] = .T. in the _p3d. || ||[=#PA0477 PA0477] || not used || || ||[=#PA0478 PA0478] || not used || || ||[=#PA0479 PA0479] || not used || || ||[=#PA0480 PA0480] || RMA window too small on child || If particles pass the borders between the child and parent domain they will be exchanged using MPI windows (MPI window = memory that is made accessible to accesses by remote processes for one sided communication). Within this process it could happen that the size of the windows is too small due to a very large number of particles that need to be transferred between the domains. Either choose a smaller amount of particles or change the internal limit of max_nr_prts_in_rma_win from 100000 to a higher value. || ||[=#PA0481 PA0481] || RMA window too small on parent || If particles pass the borders between the child and parent domain they will be exchanged using MPI windows (MPI window = memory that is made accessible to accesses by remote processes for one sided communication). Within this process it could happen that the size of the windows is too small due to a very large number of particles that need to be transferred between the domains. Either choose a smaller amount of particles or change the internal limit of max_nr_prts_in_rma_win from 100000 to a higher value. || ||[=#PA0482 PA0482] || Version of binary SVF file "..." does not match the version of model "..." || This error occurs when radiation data from the file SVFIN is read and the precursor run was carried out with a different svf binary version than the main run. Repeat the precurser with the current version or carry out the main run with the same version as the precursor. You can check the svf binary version number which is required for the main run in [[source:palm/trunk/SOURCE/radiation_model_mod.f90| radiation_model_mod.f90]]. || ||[=#PA0483 PA0483] || Wrong number of SVF or CSF || This error can happen if svf data is read from file SVFIN (e.g. during manual restarts). The local number of sky view factors and canopy sink factors for calculating surface reflection of radiation has to be the same between the precursor run and the main run. Be sure that you create the svf binary data with the same version as the version of the main run. || ||[=#PA0484 PA0484] || The lowest level where vertical stretching is applied have to be greater than ... || The wind turbine model implemented in PALM does not consider a stretched grid. Therefore grid stretching should only be applied well above the region where the wind turbine model is active. Please adjust [../initialization_parameters#dz_stretch_level_start dz_stretch_level_start] accordingly. || ||[=#PA0485 PA0485] || dissipation_1d = "as_in_3d_model" requires mixing_length_1d = "as_in_3d_model" || The [../initialization_parameters#dissipation_1d dissipation rate] in the TKE equation of the 1d-model can be calculated the same way as in the 3D model only if the [../initialization_parameters#mixing_length_1d mixing_length] is also calculated as in the 3D model. || ||[=#PA0486 PA0486] || Usage of radiation module is only allowed if land-surface and/or urban-surface model is applied or if "radiation_only = .T.". || Either the namelist &land_surface_parameters has to be set in the _p3d file or &urban_surface_parameters (or both) to avoid this error. Alternatively, the parameter [../radiation_parameters#radiation_only radiation_only] can be set to .T.. || ||[=#PA0487 PA0487] || data_output_pr = ... is currently not implemented. Please output resolved- and subgrid-scale fluxes individually to obtain the total flux. || || ||[=#PA0488 PA0488] || ERROR: the surface type ... is not supported for calculating SVF || Allowed surface types are 0, 2, 3, 4, 5, 6, 7, 8, 9, 10. Their meaning can be identified in [[source:palm/trunk/SOURCE/radiation_model_mod.f90| radiation_model_mod.f90]]. This error should not occur. Please submit a [/newticket trouble ticket]. || ||[=#PA0489 PA0489] || In case of nesting, spinup_time and dt_spinup must be identical in all parent and child domains. || In case of spinup and nested run, the spinup end time must be identical in order to have synchronously running simulations. Adjust [../initialization_parameters#spinup_time spinup_time] and/or [../initialization_parameters#dt_spinup dt_spinup] in your steering files appropriately. || ||[=#PA0490 PA0490] || nsurfl from SVF file does not match calculated nsurfl from radiation_interaction_init. || Number of all local surface elements in sky-view factor file (SVFIN) does not match the calculated number of local surface elements. Be sure that you created the svf binary data with the same version as the version of the main run and that you did not introduce further surfaces in the meantime. Otherwise submit a [/newticket trouble ticket]. || ||[=#PA0491 PA0491] || A different number of processors between the run that has written the svf data and the one that will read it is not allowed. || Self-explanatory. || ||[=#PA0492 PA0492] || initializing_actions = "..." has been changed to 'interpolate_from_parent' in child domain. || This is an informative message. In a nested run, only 'read_restart_data' (in case of a restart) or 'interpolate_from_parent' are allowed for [../initialization_parameters#initializing_actions initializing_actions] in child domain even though the constant-profiles initializations for the prognostic variables will be overwritten by pmci_child_initialize and pmci_parent_initialize. This is, however, important e.g. to make sure that diagnostic variables are set properly. An exception is made in case of restart runs and if user decides to do everything by its own. || ||[=#PA0493 PA0493] || npcbl from SVF file does not match calculated npcbl from radiation_interaction_init || The number of the local plant canopy gridboxes in SVFIN does not match the one which is calculated during model initialization. Be sure that you created the svf binary data with the same version as the version of the main run. Otherwise submit a [/newticket trouble ticket]. || ||[=#PA0494 PA0494] || ndsidir from SVF file does not match calculated ndsidir from radiation_presimulate_solar_pos || The number of apparent solar directions in SVFIN does not match the one which is calculated during model initialization. Be sure that you created the svf binary data with the same version as the version of the main run. Otherwise submit a [/newticket trouble ticket]. || ||[=#PA0495 PA0495] || optimized multigrid method requires nz to be even || You are using the optimized multigrid method, which requires {{{nz}}} to have an even value. Change {{{nz}}} in your parameter file, or choose {{{psolver = 'multigrid_noopt'}}} (but be aware that with an uneven value of {{{nz}}} the multigrid solver can only use one grid level, so you will have no ''multi'' grid levels at all and hence convergence will be very low!). || ||[=#PA0496 PA0496] || The lowest level where vertical stretching is applied have to be greater than ... || The radiation model does not consider a stretched grid. The assumption of a uniform grid is necessary in parts below the top layer of urban surface (index height nzut). Please adjust [../initialization_parameters#dz_stretch_level_start dz_stretch_level_start] accordingly. || ||[=#PA0497 PA0497] || constant_heatflux = .TRUE. is not allowed with pt_surface_heating_rate (/=0) = ... || || ||[=#PA0498 PA0498] || bc_lr and/or bc_ns in the prerun was set /= "cyclic" || In case of initializing_actions = 'cyclic_fill', the prerun must use cyclic boundary conditions along x and y. Check settings of bc_lr / bc_ns in your prerun parameter file. || ||[=#PA0500 PA0500] || Unknown turbulence closure: ... || The variable [wiki:doc/app/initialization_parameters#turbulence_closure turbulence_closure] has an unknown value. || ||[=#PA0501 PA0501] || turbulent inflow/outflow is not yet implemented for RANS mode || Setting [wiki:doc/app/initialization_parameters#turbulent_inflow turbulent_inflow] or [wiki:doc/app/initialization_parameters#turbulent_outflow turbulent_outflow] is not allowed in RANS mode (see namelist parameter [wiki:doc/app/initialization_parameters#turbulence_closure turbulence_closure] to switch between LES/RANS mode). || ||[=#PA0502 PA0502] || || || ||[=#PA0503 PA0503] || z0 exceeds surface-layer height at horizontal/vertical natural/urban surface and is decreased appropriately || In PALM, Monin-Obukhov similarity is assumed between the surface and the first computational grid point normal to the surface. Because of the staggered grid, the distance between these two points is half of the grid spacing in the respective direction, i.e. dz/2 in vertical direction. The height z = dz/2 defines the top of the (analytical) logarithmic layer zs, which is called the surface layer height here. Now functions like {{{ln(zs/z0)}}}, where z0 is the roughness length, are used to calculate characteristic surface layer variables like u* or theta*. This mathematically requires that {{{zs > z0}}}, or in other words, that {{{z0 < dz/2}}}. In case you have run into this error, you either need to reduce the roughness length z0 or increase the grid spacing dz. \\ '''Attention:''' This message is given only once (for the first grid point where the exceedance has been detected). Be aware that there might be more grid points where z0 exceeds the surface-layer height. || ||[=#PA0504 PA0504] || A mixture of different LOD for the provided boundary data is not possible. || In case of mesoscale nesting (see [wiki:doc/app/nesting_offl_parameters#nesting_offline nesting_offline]) the boundary data can be provided as level-of-detail (LOD) 1 or as LOD 2. However, a mixture of both in one simulation is not possible. || ||[=#PA0505 PA0505] || unknown boundary condition: [wiki:doc/app/chemistry_parameters#bc_cs_l bc_cs_l] "..." || See parameter [wiki:doc/app/chemistry_parameters#bc_cs_l bc_cs_l] for allowed values, and appropriately correct your parameter file. || ||[=#PA0506 PA0506] || illegal Rosenbrock-solver type || See chemistry parameter [wiki:doc/app/chemistry_parameters#icntrl icntrl] . The value of {{{icntrl(3)}}} must be in range 0 < {{{inctrl(3)}}} < 7. Please correct your parameter file appropriately. || ||[=#PA0507 PA0507] || z0h exceeds surface-layer height at horizontal/vertical natural/urban surface and is decreased appropriately || See [wiki:doc/app/errmsg#PA0503 error PA0503] for detailed explanation. || ||[=#PA0508 PA0508] || z0 exceeds surface-layer height at sea surface and is decreased appropriately || See [wiki:doc/app/errmsg#PA0503 error PA0503] for detailed explanation. || ||[=#PA0509 PA0509] || salinityflux must not be set for ocean run without salinity || You have set parameters {{{top_salinityflux}}} or/and {{{bottom_salinityflux}}} to a non-zero value, and simulataneously switched off the salinity equation. Remove either the flux settings from your parameter file, or set {{{salinity = .TRUE.}}} || ||[=#PA0510 PA0510] || ocean mode not allowed for nesting || Nesting is not available for the ocean mode. || ||[=#PA0511 PA0511] || ocean mode does not allow cyclic-fill initialization || Main runs with [wiki:doc/app/initialization_parameters#initializing_actions initializing_actions] = 'cyclic_fill' cannot use ocean mode so far. || ||[=#PA0512 PA0512] || output of "..." requires uv_exposure = .TRUE. in namelist "biometeorology_parameters" || To output the requested variable, the UV exposure calculation must be switched on which is part of the biometeorology module. See the [wiki:doc/tec/biomet#UVExposureModelUVEM UVEM documentation] for more details. || ||[=#PA0513 PA0513] || uv_exposure = .TRUE. but input file "PIDS_UVEM" is not present. Calculating UV exposure impossible. || The UV exposure calculation requires an additional input file which is not given. See the [wiki:doc/tec/biomet#UVExposureModelUVEM UVEM documentation] for more details. || ||[=#PA0514 PA0514] || uv_exposure = .TRUE. but one or more required input varaibles are not present in file "PIDS_UVEM". Calculating UV exposure impossible. || The UV exposure calculation requires special input variables given in the input file PIDS_UVEM. See the [wiki:doc/tec/biomet#UVExposureModelUVEM UVEM documentation] for more details. || ||[=#PA0515 PA0515] || consider_obstructions = .TRUE. but varaible "obstruction" is not present in file "PIDS_UVEM". Calculating UV exposure impossible. || To consider obstruction, e.g. by buildings, for UV exposure, the obstruction must be pre-calculated for each grid point and be provided within the input file PIDS_UVEM. See the [wiki:doc/tec/biomet#UVExposureModelUVEM UVEM documentation] for more details. || ||[=#PA0516 PA0516] || Required input file "" does not exist! || A required netCDF file is not available. Either this file is not given in your INPUT folder or has a wrong name (check the .palm.iofiles file for the correct naming). || ||[=#PA0517 PA0517] || virtual PE grid has changed between previous and current run. npex_prev = ..., npey_prev = ..., npex_new = ..., npey_new = ..., svf will be re-calculated' || Reading sky view factors from file (created by a previous run) is only possible if the previous run has used the same virtual PE grid as the current run. This is not the case here, and so the sky view factors are re-calculated (which requires some computational resources). || ||[=#PA0518 PA0518] || total number of grid points along x and y in file SVFIN do not match current run. nx_on_file = ..., ny_on_file = ..., nx = ..., ny = ... || Your sky view factor input file (SVFIN) contains data for a computational grid with gridpoint numbers nx and/or ny different from your current run. This is not allowed. || ||[=#PA0519 PA0519] || If building_type is provided, also building_id is required || || ||[=#PA0520 PA0520] || Synthetic turbulence generator is required if offline nesting is applied and PALM operates in LES mode. || In order to trigger turbulence, synthetic turbulence need to be imposed at the lateral boundaries, else very larger adjustment zones in the order of O(10 km) are required. || ||[=#PA0522 PA0522] || Chemistry is calculated at all meteorology time-step || || ||[=#PA0523 PA0523] || Incorrect photolysis scheme selected, please check spelling || || ||[=#PA0524 PA0524] || Synthetic turbulence generator is required when nesting is applied and parent operates in RANS-mode but current child in LES mode. || || ||[=#PA0526 PA0526] || Vegetation type is out of the valid range || between 1 and 18 || ||[=#PA0527 PA0527] || Pavement type is out of the valid range || between 1 and 15 || ||[=#PA0528 PA0528] || Water type is out of the valid range || between 1 and 5 || ||[=#PA0529 PA0529] || Building type is out of the valid range || between 1 and 7 || ||[=#PA0531 PA0531] || error opening file PLANT_CANOPY_DATA_3D || ASCII file for reading plant-canopy information is not available. This message is triggered if canopy_mode = 'read_from_file' is switched-on. With this setting, PALM searches for canopy information in the static input file first. If this is not available, PALM tries to open an ASCII file for plant-canopy information. This file has not been provided in the respective INPUT folder. || ||[=#PA0531 PA0531] || error reading file PLANT_CANOPY_DATA_3D || Mis-configured ASCII file || ||[=#PA0533 PA0533] || If virtual measurements are taken, a setup input file is required || || ||[=#PA0534 PA0534] || If virtual measurements are taken, a static input file is required || || ||[=#PA0535 PA0535] || Attribue featureType = ... is not allowed. || only 'timeseries', 'timeseriesProfile', or 'trajectory' is allowed. || ||[=#PA0536 PA0536] || averaging_interval_surf must be <= dt_dosurf_av || || ||[=#PA0537 PA0537] || Variable is not yet implemented in the surface output || || ||[=#PA0538 PA0538] || Variable is not part of the surface output || || ||[=#PA0539 PA0539] || Output of surface data is not given at t= ' ' because the maximum number of output time levels is exceeded. || see e.g. PA0384 for more explanation on this || ||[=#PA0540 PA0540] || NetCDF attribute lod is not set properly for buildings_2d. || only LoD = 1 possible || ||[=#PA0541 PA0541] || NetCDF attribute lod is not set properly for buildings_2d. || only LoD = 2 possible || ||[=#PA0542 PA0542] || If building heigths are prescribed in static input file, also an ID is required. || || ||[=#PA0543 PA0543] || Number of vertical grid points in dynamic input file does not match the number of numeric grid points. || Dimensions in dynamic input file must match the dimension of prognostic grid points for the respective variable. || ||[=#PA0544 PA0544] || Missing initial data for ... || Data is missing in dynamic input file. || ||[=#PA0545 PA0545] || NetCDF input for ... must not contain any _FillValues || Data is dynamic input file must not contain any _FillValues. || ||[=#PA0546 PA0546] || nesting_offline = .TRUE. requires dynamic input file || || ||[=#PA0547 PA0547] || initializing_actions = 'read_from_file' requires dynamic requires dynamic input file || || ||[=#PA0548 PA0548] || Static input file: horizontal dimension in x- and/or y-direction do not match the respective model dimension || || ||[=#PA0549 PA0549] || Static input file: horizontal grid spacing in x- and/or y-direction do not match the respective model dimension || || ||[=#PA0550 PA0550] || NetCDF variable zt is not allowed to have missing data || || ||[=#PA0551 PA0551] || Incorrect chemistry mechanism selected, check spelling in namelist and/or chem_gasphase_mod || || ||[=#PA0552 PA0552] || Reading 3D building data - too much data points along the vertical coordinate || || ||[=#PA0553 PA0553] || Reading 3D building data - vertical coordinate do not match numeric grid at z(k= ... ). || The z-dimension in the static input file needs to match with the vertical numerical grid of the scalar grid points (center of the grid volume). The vertical grid for 3D buildings starts at the surface, i.e. at z=0. || ||[=#PA0554 PA0554] || Minimum requirement for surface classification is not fulfilled. At least vegetation_type, pavement_type, soil_type and water_type are required. If urban-surface model is applied, also building_type ist required || || ||[=#PA0555 PA0555] || If vegetation_type = 0 at any location, vegetation_pars is required || || ||[=#PA0556 PA0556] || If vegetation_type = 0 at any location, root_area_dens_s is required || || ||[=#PA0557 PA0557] || If soil_type = 0 at any location, soil_pars is required || || ||[=#PA0558 PA0558] || If building_type = 0 at any location, building_pars is required || || ||[=#PA0559 PA0559] || If albedo_type = 0 at any location, albedo_pars is required || || ||[=#PA0560 PA0560] || If pavement_type = 0 at any location, pavement_pars is required || || ||[=#PA0561 PA0561] || If pavement_type = 0 at any location, pavement_subsurface_pars is required || || ||[=#PA0562 PA0562] || If water_type = 0 at any location, water_pars is required || || ||[=#PA0563 PA0563] || At least one of the parameters vegetation_type, pavement_type, building_type, or water_type must be set to a non-missing value. Grid point: || If the land-surface and building-surface model is employed at least one of the "_type" must be set to classify the surfaces accordingly. || ||[=#PA0564 PA0564] || soil_type is required for each location (y,x) where vegetation_type or pavement_type is a non-missing value || || ||[=#PA0565 PA0565] || More than one surface type (vegetation, pavement, water) is given at a location. Please note, this is not possible at the moment as no tile approach has been yet implemented. (i,j) = || || ||[=#PA0566 PA0566] || The sum of all land-surface fractions must equal 1. || || ||[=#PA0567 PA0567] || Mismatch in setting of surface_fraction. Vegetation-, pavement-, or water surface is given at (i,j) = ( , ), but surface fraction is 0 for the given type || || ||[=#PA0568 PA0568] || Mismatch in setting of surface_fraction. Vegetation-, pavement-, or water surface is not given at (i,j) = ( , ), but surface fraction is not 0 for the given type. || || ||[=#PA0569 PA0569] || If vegetation_type(y,x) = 0, all parameters of vegetation_pars at this location must be set || || ||[=#PA0570 PA0570] || If vegetation_type(y,x) = 0, all levels of root_area_dens_s must be set at this location || || ||[=#PA0571 PA0571] || If soil_type(y,x) = 0, all levels of soil_pars at this location must be set || || ||[=#PA0572 PA0572] || If building_type(y,x) = 0, all parameters of building_pars at this location must be set || || ||[=#PA0573 PA0573] || Each location where a building is set requires a type ( and vice versa ) in case the urban-surface model is applied. i, j = ( , ) ||Apart from the obvious inconsistent setting of building input data, please check if building_id has reasonable numbers. Even though building_id's can be set arbitrary, only values representable on a 32-bit integer can be used. For ids that cannot be represented, errors in the building processing can happen, causing this error. Another reason could be that the model domain is too shallow and thus the building and surface classification does not work properly. || ||[=#PA0574 PA0574] || Each location where a building is set requires an ID ( and vice versa ). i, j = ( , ) ||Apart from the obvious inconsistent setting of building input data, please check if building_id has reasonable numbers. Even though building_id's can be set arbitrary, only values representable on a 32-bit integer can be used. For ids that cannot be represented, errors in the building processing can happen, causing this error.|| ||[=#PA0575 PA0575] || Each building grid point requires an ID. || || ||[=#PA0576 PA0576] || If albedo_type(y,x) = 0, all parameters of albedo_pars at this location must be set || || ||[=#PA0577 PA0577] || If pavement_type(y,x) = 0, all parameters of pavement_pars at this location must be set || || ||[=#PA0578 PA0578] || If pavement_type(y,x) = 0, all parameters of pavement_subsurface_pars at this location must be set || || ||[=#PA0579 PA0579] || If water_type(y,x) = 0, all parameters of water_pars at this location must be set || || ||[=#PA0580 PA0580] || nsurface_fraction must not be larger than 3. || || ||[=#PA0581 PA0581] || If buildings are provided, also building_type is required. || || ||[=#PA0582 PA0582] || If buildings are provided, also building_id is required. || || ||[=#PA0583 PA0583] || Input file RRTMG_LW for rrtmg model missing. Please provide _rlw file in the INPUT directory. || You have switched on the RRTMG radiation model, but missed to provide the respective input file in your input folder. || ||[=#PA0584 PA0584] || Input file RRTMG_SW for rrtmg model missing. Please provide _rsw file in the INPUT directory. || You have switched on the RRTMG radiation model, but missed to provide the respective input file in your input folder. || ||[=#PA0585 PA0585] || maximum number of 2d/3d-array entries in restart file header exceeded || Internal error. Please contact the PALM developers. || ||[=#PA0586 PA0586] || For chemistry variables only LOD=1 is allowed. || Initialization of chemistry via dynamic input file is only allowed with profiles (LOD=1). || ||[=#PA0587 PA0587] || Child subdomain width in x[or y]-direction must not be smaller than its parent grid dx[or dy]. Change the PE-grid setting (npex, npey) to satisfy this requirement. || In nested runs child domain decomposition must be such that the subdomain size is never smaller than the parent grid-spacing in the respective direction. || ||[=#PA0589 PA0589] || bc_lr = "..." and bc_ns = "..." are not allowed to be set at the same time || Dirichlet/radiation boundary conditions are only allowed to be set along x '''or''' along y. Cyclic conditions must be set along the respective other direction. If you like to set non-cyclic conditions along x '''and''' y you need to use the offline-nesting feature. || ||[=#PA0591 PA0591] || dt_radiation must be > 0.0 || || ||[=#PA0593 PA0593] || unknown boundary condition: bc_cs_b = "..." || || ||[=#PA0594 PA0594] || salsa = .T. is not allowed with humidity = .F. ||Applying the salsa module requires running PALM in humid mode. See parameter [/wiki/doc/app/initialization_parameters#humidity humidity].|| ||[=#PA0595 PA0595] || unknown boundary condition: [wiki:doc/app/salsa_parameters#bc_aer_b bc_aer_b] = "..." || See parameter [wiki:doc/app/salsa_parameters#bc_aer_b bc_aer_b] for allowed values, and appropriately correct your parameter file. || ||[=#PA0596 PA0596] || unknown boundary condition: [wiki:doc/app/salsa_parameters#bc_aer_t bc_aer_t] = "..." || See parameter [wiki:doc/app/salsa_parameters#bc_aer_t bc_aer_t] for allowed values, and appropriately correct your parameter file. || ||[=#PA0597 PA0597] || unknown nj3 (must be 1-3) || See parameter [wiki:doc/app/salsa_parameters#nj3 nj3] for allowed values, and appropriately correct your parameter file. || ||[=#PA0598 PA0598] || [wiki:doc/app/salsa_parameters#salsa_emission_mode salsa_emission_mode] /= "no_emission" for requires [wiki:doc/app/salsa_parameters#bc_aer_b bc_aer_b] = "Neumann" || If aerosol surface emissions are given, a Neumann boundary condition should be set at the bottom. See parameter [wiki:doc/app/salsa_parameters#bc_aer_b bc_aer_b] for allowed values, and appropriately correct your parameter file. || ||[=#PA0599 PA0599] || SALSA is run together with chemistry but not all gaseous components are provided by kpp (H2SO4, HNO3, NH3, OCNV, OCSC). || Some gaseous compound(s) needed in the aerosol module SALSA are missing from the chemical mechanism applied. Check the {{{chem_gashase_mod.f90}}}. || ||[=#PA0600 PA0600] || Unknown aerosol species/component(s) given in the initialization || Unknown chemical components included in the parameter file. See parameter [wiki:doc/app/salsa_parameters#listspec listspec] for allowed components. || ||[=#PA0601 PA0601] || Number of horizontal grid points in dynamic input file does not match the number of numeric grid points. || Dimensions in dynamic input file must match the dimension of prognostic grid points for the respective variable. || ||[=#PA0602 PA0602] || None of the aerosol chemical components in PIDS_DYNAMIC... correspond to ones applied in SALSA. || If the initial aerosol concentrations are read from the dynamic input file (parameter [wiki:doc/app/salsa_parameters#isdtyp isdtyp] = 1), the chemical composition must include at least one chemical component applied in the model. || ||[=#PA0603 PA0603] || Currently only lod=1 accepted for init_atmosphere_aerosol || Initialization of the aerosol module via dynamic input file is only allowed with profiles (LOD=1). || ||[=#PA0604 PA0604] || The number of size bins in init_atmosphere_aerosol does not match with that applied in the model set-up. || The number of aerosol size bins in the dynamic input file does not correspond to the size distribution information given in the parameter file. See parameters [wiki:doc/app/salsa_parameters#nbin nbin] and [wiki:doc/app/salsa_parameters#reglim reglim], and appropriately correct the discrepancy. || ||[=#PA0605 PA0605] || Mean diameters of the aerosol size bins in PIDS_DYNAMIC... do not match with the sectional representation of the model. || The mean diameters of the aerosol size bins in the dynamic input file does not correspond to the size distribution information given in the parameter file. See parameters [wik:doc/app/salsa_parameters#nbin nbin] and [wiki:doc/app/salsa_parameters#reglim reglim], and appropriately correct the discrepancy. || ||[=#PA0606 PA0606] || Error in initialising mass fractions of chemical components. Check that all chemical components are included in parameter file! || The chemical composition in the dynamic input file does not overlap with the one applied in the model. See parameter [wiki:doc/app/salsa_parameters#listspec listspec] for allowed components. || ||[=#PA0607 PA0607] || Input file PIDS_DYNAMIC... for SALSA missing! || The initial aerosol size distribution is set to be read from the dynamic input file (parameter [wiki:doc/app/salsa_parameters#isdtyp isdtyp] = 1) but the file {{{_dynamic}}} is missing. || ||[=#PA0608 PA0608] || isdtyp = 1 but preprocessor directive __netcdf is not used in complicing! || You have set [wiki:doc/app/salsa_parameters#isdtyp isdtyp] = 1, but netcdf-code has not been activated by the corresponding cpp-preprocessor switch. Add {{{'-D__netcdf'}}} to the %cpp_options line in the configuration file and re-compile (i.e. call {{{palmbuild}}}. || ||[=#PA0609 PA0609] || Number of horizontal grid points in dynamic input file does not match the number of numeric grid points. || Dimensions in dynamic input file must match the dimension of prognostic grid points for the respective variable. || ||[=#PA0610 PA0610] || Input file PIDS_DYNAMIC... for SALSA missing! || The initial aerosol size distribution is set to be read from the dynamic input file (parameter [wiki:doc/app/salsa_parameters#isdtyp isdtyp] = 1) but the file {{{_dynamic}}} is missing. || ||[=#PA0611 PA0611] || igctyp = 1 but preprocessor directive __netcdf is not used in complicing! || You have set [wiki:doc/app/salsa_parameters#igctyp igctyp] = 1, but netcdf-code has not been activated by the corresponding cpp-preprocessor switch. Add {{{'-D__netcdf'}}} to the %cpp_options line in the configuration file and re-compile (i.e. call {{{palmbuild}}}. || ||[=#PA0612 PA0612] || Either OC or SO4 must be active for aerosol region 1a! || Either organic carbon (OC) or sulphates (SO4) have to be included as aerosol chemical components in parameter [wiki:doc/app/salsa_parameters#listspec listspec]. Correct your parameter file. || ||[=#PA0613 PA0613] || depo_pcm_type not set correctly. || See [wiki:doc/app/salsa_parameters#depo_pcm_type depo_pcm_type]. Correct your parameter file. || ||[=#PA0614 PA0614] || No vegetation type defined. || The land surface model is applied, but vegetation type needed for the dry deposition is not defined. Check the static input file.|| ||[=#PA0615 PA0615] || No pavement type defined. || The land surface model is applied, but pavement type needed for the dry deposition is not defined. Check the static input file.|| ||[=#PA0616 PA0616] || No water type defined. || The land surface model is applied, but water type needed for the dry deposition is not defined. Check the static input file.|| ||[=#PA0617 PA0617] || Subrange 1: no convergence! || The solution of the equilibrium subroutine does not converge for the subrange 1. This might be due to some error in initialising the aerosol mass concentrations. || ||[=#PA0618 PA0618] || Subrange 2: no convergence! || The solution of the equilibrium subroutine does not converge for the subrange 2. This might be due to some error in initialising the aerosol mass concentrations. || ||[=#PA0619 PA0619] || Horizontal / Vertical surface element at grid point i, j = ..., is neither a vegetation, pavement, nor a water surface. || The respective surface element is not correctly initialized, indicating inconsistencies in the static input file || ||[=#PA0620 PA0620] || Using synthetic turbulence generator is not allowed in LES-LES nesting. || || ||[=#PA0621 PA0621] || Using synthetic turbulence generator is not allowed in RANS-RANS nesting || || ||[=#PA0622 PA0622] || Offline nesting is only applicable in root model || || ||[=#PA0623 PA0623] || Invalid output value: nucleation rate > 10^6^ 1/cm^3^s || Calculated nucleation rate in the subroutine for ternary nucleation ({{{ternucl}}}) exceeds 1e6 cm^-3^s^-1^. || ||[=#PA0624 PA0624] || error: zvfrac < 0 || When updating the aerosol size distribution after aerosol processes, the volume fraction of aerosols to be moved to the larger bin has gone negative. || ||[=#PA0625 PA0625] || Error: Aerosol bin update not converged || When updating the aerosol size distribution after aerosol processes, the solution does not converge. || ||[=#PA0626 PA0626] || unknown boundary condition: [wiki:doc/app/salsa_parameters#bc_aer_l bc_aer_l] "..." || See parameter [wik:doc/app/salsa_parameters#bc_aer_l bc_aer_l] for allowed values, and appropriately correct your parameter file. || ||[=#PA0627 PA0627] || unknown boundary condition: [wiki:doc/app/salsa_parameters#bc_aer_r bc_aer_r] "..." || See parameter [wiki:doc/app/salsa_parameters#bc_aer_r bc_aer_r] for allowed values, and appropriately correct your parameter file. || ||[=#PA0628 PA0628] || Error in itype! || The input parameter in bin_mixrat is falsely set. Review the code. || ||[=#PA0629 PA0629] || Input file PIDS_SALSA... missing! || Emission information for the aerosol particles is set to be read from a NetCDF input file ([wiki:doc/app/salsa_parameters#salsa_emission_mode salsa_emission_mode] == 'read_from_file'), but the file {{{_salsa}}} is missing. || ||[=#PA0630 PA0630] || None of the aerosol chemical components in PIDS_SALSA... correspond to ones applied in SALSA. || If the aerosol emissions are read from {{{_salsa}}} (parameter [wiki:doc/app/salsa_parameters#salsa_emission_mode salsa_emission_mode] == 'read_from_file'), the chemical composition must include at least one chemical component applied in the model. || ||[=#PA0631 PA0631] || unknown unit for aerosol emissions: ... (lod1) || Aerosol emission values given in the NetCDF input file {{{_salsa}}} are incorrect when lod=1 is applied. \\\\ Aerosol emissions are given as total particulate mass concentrations per emission category and should be given in units: \\ kg/m^2^/yr or g/m^2^/yr. || ||[=#PA0632 PA0632] || None of the emission categories in PIDS_SALSA... match with the ones in the model. || Emission categories in {{{_salsa}}} do not match with ones applied in the model ('traffic exhaust', 'road dust', 'wood combustion', 'other'). || ||[=#PA0633 PA0633] || emission_time_factors should be given for each nhoursyear OR nmonthdayhour || Emission time factors for aerosol emissions (LOD=1) are not given or they are not correctly named in {{{_salsa}}}. || ||[=#PA0634 PA0634] || unknown unit for aerosol emissions: ... || Aerosol emission values given in the NetCDF input file {{{_salsa}}} are incorrect when lod=2 is applied. \\\\ Aerosol emissions are given as number emission per aersol size bin and should be given in units: \\ #/m^2^/s. || ||[=#PA0635 PA0635] || The number of size bins in aerosol input data does not match with that applied in the model set-up. || The number of aerosol size bins in {{{_salsa}}} does not correspond to the size distribution information given in the parameter file. See parameters [wiki:doc/app/salsa_parameters#nbin nbin] and [wiki:doc/app/salsa_parameters#reglim reglim], and appropriately correct the discrepancy. || ||[=#PA0636 PA0636] || Mean diameters of the aerosol size bins in PIDS_SALSA... do not mmatch with the ones in the model. || The mean diameters of the aerosol size bins in {{{_salsa}}} does not correspond to the size distribution information given in the parameter file. See parameters [wiki:doc/app/salsa_parameters#nbin nbin] and [wiki:doc/app/salsa_parameters#reglim reglim], and appropriately correct the discrepancy. || ||[=#PA0637 PA0637] || Unknown lod for aerosol_emission_values. || The level of detail (LOD) for aerosol_emission_values in {{{_salsa}}} should be either 1 or 2. || ||[=#PA0638 PA0638] || salsa_emission_mode = "read_from_file", but preprocessor directive __netcdf is not used in compiling! || You have set [wiki:doc/app/salsa_parameters#salsa_emission_mode salsa_emission_mode] = "read_from_file", but netcdf-code has not been activated by the corresponding cpp-preprocessor switch. Add {{{'-D__netcdf'}}} to the %cpp_options line in the configuration file and re-compile (i.e. call {{{palmbuild}}}. || ||[=#PA0639 PA0639] || unknown salsa_emission_mode: ... || The parameter [wiki:doc/app/salsa_parameters#salsa_emission_mode salsa_emission_mode] is not correctly set. || ||[=#PA0640 PA0640] || Input file PIDS_CHEM... missing! || Emission information for SALSA is set to be read from a NetCDF input file ([wiki:doc/app/salsa_parameters#salsa_emission_mode salsa_emission_mode] == 'read_from_file'), but the file {{{_chemistry}}} is missing. The chemistry module is not applied and therefore gaseous emissions are read in within salsa_mod.f90. || ||[=#PA0641 PA0641] || emission_time_factors should be given for each nhoursyear OR nmonthdayhour || Emission time factors for gaseous emissions (LOD=1) are not given or they are not correctly named in {{{_chemistry}}}. || ||[=#PA0642 PA0642] || Unknown lod for emission_values. || The level of detail (LOD) for emission_values (gaseous emissions) in {{{_chemistry}}} should be either 1 or 2. || ||[=#PA0643 PA0643] || salsa_emission_mode = "read_from_file", but preprocessor directive __netcdf is not used in compiling! || You have set [wiki:doc/app/salsa_parameters#salsa_emission_mode salsa_emission_mode] = "read_from_file", but netcdf-code has not been activated by the corresponding cpp-preprocessor switch. Add {{{'-D__netcdf'}}} to the %cpp_options line in the configuration file and re-compile (i.e. call {{{palmbuild}}}. || ||[=#PA0644 PA0644] || unknown unit for gaseous emissions: ... || Unknown units applied for the gaseous emissions in the NetCDF input file {{{_chemistry}}}. \\\\ Units should be:\\ #/m2/s or g/m2/s or ppm/m2/s or mumol/m2/s or kg/m2/yr or g/m2/yr\\\\ Note that gases are not imported to SALSA from the chemistry module since the chemistry module is not applied! || ||[=#PA0645 PA0645] || surface element at grid point (j,i) = ( ... ) is not a water surface, so that information given in water_pars is neglected. || || ||[=#PA0646 PA0646] || ''rad_sw_in'' / ''rad_lw_in'' / ''rad_sw_in_dif'' has no valid ''lod'' attribute || || ||[=#PA0647 PA0647] || surface element at grid point (j,i) = ( ... ) is not a pavement surface, so that information given in pavement_pars is neglected. || || ||[=#PA0648 PA0648] || No grid coarsening possible, multigrid approach effectively reduces to a Gauss-Seidel scheme. || The convergence of the pressure solver might be insufficient and the simulation can become unstable. You should try to adjust the number of subdomain grid points in a way that each of (nx+1)/npex, (ny+1)/npey, and nz contain power-of-two (2^n^) factors with at least n = 2 or larger. Be aware that you can change both, the total number of gridpoints of the total domain, and/or the number of PEs. Alternatively, in case that you cannot change your grid or virtual processor grid, you may try to increase the number of Gauss-Seidel iterations ([../initialization_parameters#ngsrb ngsrb]) to improve convergence, but this approach is very limited. || ||[=#PA0649 PA0649] || Invalid input value: prh || Relative humidity given to the subroutine for ternary nucleation ({{{ternucl}}}) is not within the allowed humidity range of 5-95 %. || ||[=#PA0650 PA0650] || Invalid input value: pc_sa || Number concentration of gaseous sulphuric acid given to the subroutine for ternary nucleation ({{{ternucl}}}) is not within the allowed range of 1e4-1e9 cm^-3^. || ||[=#PA0651 PA0651] || Invalid input value: pc_nh3 || Mixing ratio of gaseous ammonia given to the subroutine for ternary nucleation ({{{ternucl}}}) is not within the allowed range of 0.1-100 ppt. || ||[=#PA0652 PA0652] || Child domain too narrow [or shallow] for anterpolation in x- [or y- or z-]direction || In case of [../nesting_parameters#nesting_mode nesting_mode] = 'two-way', the child domain must cover a sufficient number of parent-grid cells in all directions. Otherwise anterpolation is not possible. The absolute minimum number of parent-grid cells covered in x- and y-directions is 3 + 2*[../nesting_parameters#anterpolation_buffer_width anterpolation_buffer_width], and 2 + [../nesting_parameters#anterpolation_buffer_width anterpolation_buffer_width] in z-direction. However, it is recommended that child domains cover much larger number of parent-grid cells. This error message is only given if [../nesting_parameters#nesting_mode nesting_mode] = 'two-way'. || ||[=#PA0653 PA0653] || Anterpolation_buffer_width value too high, reset to 0 || In case of a marginally small child domain (see PA0652 above), the user is warned and [../nesting_parameters#anterpolation_buffer_width anterpolation_buffer_width] is set to 0 (the default value is 2) so that the minimum criteria (see PA0652 above) for the child domain size in terms of the number of parent-grid cells covered are satisfied. However, it is recommended that child domains cover much larger number of parent-grid cells. This warning is only given if [../nesting_parameters#nesting_mode nesting_mode] = 'two-way'. || ||[=#PA0654 PA0654] || Anterpolation_buffer_width value too high, reset to the default value 2 || In case of too wide anterpolation buffer, the user is informed and [../nesting_parameters#anterpolation_buffer_width anterpolation_buffer_width] is reset to its default value 2 so that the minimum criteria (see PA0652 above) for the child domain size in terms of the number of parent-grid cells covered are satisfied. However, it is recommended that child domains cover much larger number of parent-grid cells. This informative message is only given if [../nesting_parameters#nesting_mode nesting_mode] = 'two-way'. || ||[=#PA0655 PA0655] || Multiple calls to palm_date_time_set detected. date and time must be set only once. || Routine palm_date_time_set was called multiple times. Please remove any additional calls to this routine from your user code. || ||[=#PA0656 PA0656] || Date and time are not set yet. Reset not possible. || palm_date_time_reset was called before palm_date_time_set which is not allowed. || ||[=#PA0657 PA0657] || Date and time are not set yet. Returning date/time information not possible. || palm_date_time_get was called before palm_date_time_set which is not allowed. || ||[=#PA0658 PA0658] || Date given in wrong format: "..." = ... is invalid! Check format of date_init. Format must be "YYYY-MM-DD hh:mm:ss (+-)hh". || An invalid date and/or time was detected. Please check the value and format of [/wiki/doc/app/initialization_parameters#date_init date_init]. || ||[=#PA0659 PA0659] || subrgrid scale velocities in combination with simple interpolation method is not implemented for passive particles || Set use_sgs_for_particles to FALSE or if you want to keep it set particle_interpolation to 'trilinear' || ||[=#PA0661 PA0661] || namelist file "PARIN" or "PARIN_O" not found! Please have a look at the online description of the error message for further hints. || The origin of this error can have several reasons. \\Most likely, the activation string of the palmrun command was incorrect. You have to assure that the correct activation string is set so that the parameter namelist is recognised by palmrun (per default, this is 'd3#' for normal runs or 'd3r' for restarts). If you use several strings within the list of activation strings, make sure that each string is separated by a blank, i.e. do not write 'd3#restart' but 'd3# restart'. \\If you used a modified version of .palm.iofiles, there is probably an incorrect linkage between the PARIN file and the actual file inside the INPUT directory. Please refer to the documentation of [/wiki/doc/app/palm_iofiles palm_iofiles] for how to correctly configure this file. || ||[=#PA0662 PA0662] || no output file type selected for surface-data output! Set at least either "to_vtk" or "to_netcdf" to .TRUE. || Surface-data output was requested without specifying a file type to store the data in. When requesting surface-data output, either '[/wiki/doc/app/surface_data_output_parameters#to_vtk to_vtk]' or '[/wiki/doc/app/surface_data_output_parameters#to_netcdf to_netcdf]' or both must be set to true. || ||[=#PA0663 PA0663] || The maxima of the standard deviation remain at the open edges of the model || The maxima of the standard deviation of u, v, w, pt or q remain at the open edges of the model (look vdi_internal_controls.f90). || ||[=#PA0664 PA0664] || The maxima of the standard deviation travel from the open edges into the interior of the domain with increasing simulation time || The maxima of the standard deviation of u, v, w, pt or q travel into the interior of the domain. Run does not fulfill VDI 3783 Part 9. || ||[=#PA0665 PA0665] || Monotonic decrease or increase with increasing simulation time for u/v/w/pt/q || The mean of u, v, w, pt or q decrease or increase in the last 90 % of time in the simulation. Maybe your simulation time is too short or there is a physical cause for this. || ||[=#PA0666 PA0666] || The mass is not conserved || conservation of mass is not fulfilled (look vdi_internal_controls) || ||[=#PA0667 PA0667] || A wind component have a magnitude greater than ten times the maximum wind velocity at the approach flow profile || The u, v or w component of the wind exceed a specified limit (vdi_internal_controls). || ||[=#PA0668 PA0668] || The potential temperature does not lie between 220 K and 330 K. || pt exceed a specified limit (vdi_internal_controls). || ||[=#PA0669 PA0669] || 2-delta t waves are generated || The u component at a control grid point or the means of the meteorological variables exhibit 2 delta t waves (vdi_internal_controls). || ||[=#PA0670 PA0670] || External radiation with ''lod'' = 2 is currently not possible with average_radiation = .T.. || || ||[=#PA0671 PA0671] || For non-pavement surfaces the combination of lai = 0.0 and c_veg = 1.0 is not allowed. || || ||[=#PA0672 PA0672] || Wind turbine model output requires NetCDF version 4. No output file will be created. ||Data output for the wind turbine model is realized only for NetCDF version 4. As a consequence the model output is deactivated if version 3 is used. Keep in mind that just providing a NetCDF4 library is not sufficient. You also need to re-compile the PALM code with preprocessor directive {{{-D__netcdf4}}} and runtime parameter [wiki:doc/app/runtime_parameters#netcdf_data_format netcdf_data_format] set to 4. || ||[=#PA0673 PA0673] || External radiation input should have the same ''lod''. || || ||[=#PA0674 PA0674] || Local vegetation height on top of topography exceeds height of model domain. || || ||[=#PA0675 PA0675] || unknown boundary condition: bc_c_t = "..." || || ||[=#PA0676 PA0676] || surface_fraction is given for more than one type. Please note, this is not possible at the moment as no tile approach has yet been implemented. (i, j) = || || ||[=#PA0677 PA0677] || No reference date-time defined. Returning date-time information is not possible. Either specify reference_date_time_str or set a reference via set_reference_date_time. || Routine get_date_time is either called without specifying any reference time (neither in the call itself nor via set_reference_date_time). Please check your user code for any calls to get_date_time. If you did not use any user code, please report this error via the ticket system. || ||[=#PA0678 PA0678] || Error while converting date-time string. Please check format of date-time string: "...". Format must be "YYYY-MM-DD hh:mm:ss ZZZ". || The date-time information given in [../initialization_parameters#origin_date_time origin_date_time] is given in a wrong format. Please check the format of the string. || ||[=#PA0679 PA0679] || Date-time values out of bounds: "..." is out of bounds. Please check date-time string: "...". Format must be "YYYY-MM-DD hh:mm:ss ZZZ". || The date-time information given in [../initialization_parameters#origin_date_time origin_date_time] has invalid values for the specified date or time component. Please check the setting of [../initialization_parameters#origin_date_time origin_date_time] || ||[=#PA0680 PA0680] || Multiple calls to set_reference_date_time detected. The reference date-time must be set only once. || Routine set_reference_date_time can only be called once per program execution. Please check your user code for any additional calls to this routine and remove it. If you did not use any user code, please report the appearance of the error in the ticket system. || ||[=#PA0681 PA0681] || section_xy/xz/yz not defined for requested xy/xz/yz-cross section output. At least one cross section must be given. || If you specified any data-output quantity for a xy-, xz-, or yz-cross section via [../runtime_parameters#data_output data_output], then you need to also specify the location of at least one corresponding cross section via [../runtime_parameters#section_xy section_xy], [../runtime_parameters#section_xz section_xz], or [../runtime_parameters#section_yz section_yz]. || ||[=#PA0684 PA0684] || Found building surface on non-building coordinates (xs, ys, zenith, azimuth): "xs, ys, zenith, azimuth" || If the variable building_surface_pars has been specified within a static driver, the coordinates xs/ys/zs define the location of a horizontal/vertical buildings surface, while zenith/azimuth define the orientantion of the surface (upward-, northward-, southward-, eastward-, westward-facing). In case this error message appears, the coordinates xs, ys, zs, zenith, and azimuth describing a surface element do not match with the location of a building. Even if xs, ys, zs, are prescribed correctly, mismatches in zenith and azimuth may cause this error. In such a case, please check carefully your pre-processor code that you used to create the static driver. Further information about the data input for surface elements can be found [wiki:doc/app/iofiles/pids/static here]. || ||[=#PA0686 PA0686] || The relative material fractions do not sum-up to one at horizotal/vertical surface. (i,j) = ... || If building_pars is specified within a static input file, all parameters indicating the relative fraction of wall / window / green surfaces must be given. || ||[=#PA0688 PA0688] || surface fractions at grid point (j,i) = ( ) are all zero. || || ||[=#PA0689 PA0689] || Invalid input value: ptemp || Air temperature given to the subroutine for ternary nucleation ({{{ternucl}}}) is not within the allowed temperature range of 240-300 K. || ||[=#PA0690 PA0690] || end_time of the simulation exceeds the time dimension in the dynamic input file. || Time dimension in {{{_dynamic}}} must cover the entire simulation time. || ||[=#PA0691 PA0691] || Offline nesting: time dimension must start at time_utc_init. || Time dimension in {{{_dynamic}}} must start at the start of the simulation in time utc. For example, for a simulation starting at 7 am in UTC+3 time, this is 14400. || ||[=#PA0692 PA0692] || end_time of the simulation exceeds the time dimension in the salsa input file. || Time dimension in {{{_salsa}}} must cover the entire simulation time. || ||[=#PA0693 PA0693] || None of the aerosol chemical components in {{{_dynamic}}} correspond to ones applied in SALSA. || None of the chemical components given in '''composition_name''' in {{{_dynamic}}} correspond to the ones applied in SALSA. Please check the file and spelling. || ||[=#PA0694 PA0694] || Missing emission_mass_fracs in {{{_salsa}}} || Variable '''emission_mass_fracs''' missing from {{{_salsa}}}. || ||[=#PA0695 PA0695] || salsa_emission_mode = "parameterized", but the street_type data is missing. || When salsa_emission_mode = "parameterized", the variable street_type must be provided in {{{_static}}}. || ||[=#PA0697 PA0697] || The mixing ratio exceeds the saturation mixing ratio || The mixing ratio must not exceed its saturation mixing ratio by more than 2 percent. Higher values are physically unrealistic and will not be observed in the atmosphere. In case cloud physics are considered, oversaturation would create strong convection leading to unpredictable model behavior. Further, oversaturated mixing ratios have implications in the land-surface model, where moisture might condense immediately at the surface, creating very high surface fluxes. Note, an error message is given in the initial run, while only a warning is given when moisture exceeds its saturation value in a restart run. || ||[=#PA0698 PA0698] || Unclassified surface element at grid point (k,j,i) = || Input data is not defined consistently. Please contact the Palm support. One reason for this could be that input data for land-surfaces and buildings are provided in the static driver, but one of the energy-balance models for buildings or land-surfaces are disabled. || ||[=#PA0699 PA0699] || Bottom and top boundary are treated equal || This is just an informative message. It tells you that the regions close to the bottom and top boundaries are treated physically and numerically equal. This is not necessarily the case for normal atmospheric runs. || ||[=#PA0700 PA0700] || dz should be equal close to the boundaries due to symmetrical problem || To get realistic results of a closed channel flow, it is necessary to treat bottom and top boudary region the same. This includes the grid spacing. || ||[=#PA0701 PA0701] || A constant flux layer is not allowed if a closed channel shall be used || So far, the constant flux layer approach is only implemented for the bottom boundary but bottom and top boundary shall be treated equal for closed channel flows. Therefore, it is not allowed. || ||[=#PA0702 PA0702] || The ocean mode is not allowed if a closed channel shall be used || self-explanatory || ||[=#PA0703 PA0703] || A closed channel requires the upwind scheme of Wicker and Skamarock as the advection scheme || Only the the upwind scheme of Wicker and Skamarock is realized and tested for a symmetric degradation of the advection scheme (from 5th, to 3rd to 1st order) close to the bottom and top boundary. || ||[=#PA0704 PA0704] || End of line or file detected for file [../iofiles#TOPOGRAPHY_DATA TOPOGRAPHY_DATA] at line ... ||File does not contain enough data. Check the respective line given in the error message. \\ a) The number of columns (`ncols`) is less than [../initialization_parameters#nx nx]+1. \\ b) The number of rows (`nrows`) is less than [../initialization_parameters#ny ny]+1. \\ Solution: Make sure that `ncols` matches `nx+1` and that `nrows` matches `ny+1`. || ||[=#PA0705 PA0705] || If virtual measurements are taken, the number of surrounding grid points must not be larger than the number of ghost points - 1 ||When virtual measurements are taken, data is sampled at given station grid coordinates. It is possible that also the adjoining grid points can be sampled, however, the number of grid points additionally sampled in each direction must not be larger than the number of ghost points - 1 to avoid any segmentations faults. In the future we will improve this to allow a more flexible number of offset grid points. || ||[=#PA0706 PA0706] || dt_virtual_measurement must be > 0.0 ||This parameter is used to estimate the number of output timesteps in the output NetCDF files. With zero-valued numbers this is not possible. || ||[=#PA0707 PA0707] || Run will be terminated because virtual measurement times index exceeds its maximum value in the output files. A restart run is forced. ||Please see comment under PA0706. || ||[=#PA0708 PA0708] || If virtual measurements are taken, parallel NetCDF is required. ||The PALM code need to be compiled with a parallel NetCDF library. || ||[=#PA0627 PA0709] || unknown boundary condition: [wiki:doc/app/salsa_parameters#bc_aer_n bc_aer_n] "..." || See parameter [wik:doc/app/salsa_parameters#bc_aer_n bc_aer_n] for allowed values, and appropriately correct your parameter file. || ||[=#PA0710 PA0710] || raytrace_mpi_rma = .T. not allowed in serial mode. ||You have compiled the PALM code for serial mode, i.e. without setting the preprocessor switch {{{-D __parallel}}} in the configuration file. Radiation calculations for the urban environment with ray tracing using one-sided MPI communication only works for the parallel mode. Either set the switch {{{-D __parallel}}} in your config file, or set raytrace_mpi_rma = .F. in your NAMELIST file. || ||[=#PA0711 PA0711] || unknown boundary condition: [wiki:doc/app/salsa_parameters#bc_aer_s bc_aer_s] "..." || See parameter [wiki:doc/app/salsa_parameters#bc_aer_s bc_aer_s] for allowed values, and appropriately correct your parameter file. || ||[=#PA0712 PA0712] || boundary conditions bc_aer_l and bc_aer_r must both be cyclic or non-cyclic. || See parameter descriptions under [wiki:doc/app/salsa_parameters#bc_aer_l bc_aer_l] and [wiki:doc/app/salsa_parameters#bc_aer_r bc_aer_r], and appropriately correct your parameter file. || ||[=#PA0713 PA0713] || boundary conditions bc_aer_n and bc_aer_s must both be cyclic or non-cyclic. || See parameter descriptions under [wiki:doc/app/salsa_parameters#bc_aer_n bc_aer_n] and [wiki:doc/app/salsa_parameters#bc_aer_s bc_aer_s], and appropriately correct your parameter file. || ||[=#PA0714 PA0714] || boundary conditions bc_cs_n and bc_cs_s must both be cyclic or non-cyclic || || ||[=#PA0715 PA0715] || Unused/incorrect input for initial surface value: ... || || ||[=#PA0716 PA0716] || Unused/incorrect input of chemical species for surface emission fluxes: ... || || ||[=#PA0717 PA0717] || The surface value of cs_heights must be 0.0 || || ||[=#PA0718 PA0718] || boundary conditions bc_cs_n and bc_cs_s must both be cyclic or non-cyclic. || See parameter descriptions under [wiki:doc/app/chemistry_parameters#bc_cs_n bc_cs_n] and [wiki:doc/app/chemistry_parameters#bc_cs_s bc_cs_s], and appropriately correct your parameter file. || ||[=#PA0719 PA0719] || ql must be larger than zero. || values smaller than zero can occur if the time-stpe is not appropiate. || ||[=#PA0720 PA0720] || illegal action "..." for opening restart files || Only actions "read" or "write" are allowed. This is a PALM internall conding problem. Please contact the PALM developers / submit a trouble ticket. || ||[=#PA0721 PA0721] || error opening restart file for posix I/O. || A serial run (on one core) was unable to open the restart file for reading or writing. In case of reading check your job log if the restart file has been copied to the temporary working directory before execution of PALM. || ||[=#PA0722 PA0722] || CHARACTER/INTEGER/REAL variable/array "..." not found in restart file. || The indicated variable was not found in the restart file. If you are doing restart I/O in your user-interface, please check that input- and output variables exactly match. || ||[=#PA0723 PA0723] || 2d-INTEGER(*8) array "..." to be read from restart file is defined with illegal dimensions in the PALM code. || This problem may appear in your user-interface, if you try to write/read 2d-INTEGER arrays with ghost boundaries to/from the restart file. 2d-INTEGER arrays in restart files are not allowed to have ghost boundaries so far. || ||[=#PA0724 PA0724] || illegal restart data format "..." || See parameter description under [wiki:doc/app/initialization_parameters#restart_data_format restart_data_format] for allowed values and correct your parameter file appropriately. || ||[=#PA0725 PA0725] || illegal restart input data format "..." || See parameter description under [wiki:doc/app/initialization_parameters#restart_data_format_input restart_data_format_input] for allowed values and correct your parameter file appropriately. || ||[=#PA0726 PA0726] || illegal restart output data format "..." || See parameter description under [wiki:doc/app/initialization_parameters#restart_data_format_output restart_data_format_output] for allowed values and correct your parameter file appropriately. || ||[=#PA0727 PA0727] || error opening restart file "..." for reading with MPI-IO || Check if you provided the activation string {{{d3r}}} with palmrun option {{{-a}}}. || ||[=#PA0728 PA0728] || error opening restart file "..." for writing with MPI-IO || There might be a problem with the directory that you have set in the configuration file (.palm.config...) via {{{%fast_io_catalog}}}. || ||[=#PA0729 PA0729] || prerun data is not allowed to contain soil information || In case of initializing_actions = 'cyclic_fill', it is not allowed to use the land surface model within the prerun. Change your prerun parameter file appropriately. || ||[=#PA0730 PA0730] || number of chem spcs exceeding the limit || || ||[=#PA0731 PA0731] || Incorrect mode_emiss option select. Please check spelling || || ||[=#PA0732 PA0732] || Invalid value for emiss_lod (0, 1, or 2) || || ||[=#PA0733 PA0733] || number of sky view factor values for .... = .... > 2^^*^^*31-1 || The number of sky view factor values for the given variable exceeds the mentioned upper limit. This may happen in case of a computation grid with extrem number of gridpoints and/or very complex 3D-topography. Please contact the PALM developer group. || ||[=#PA0734 PA0734] || emiss_lod undefined. Using existing mod_emiss setting. NOTE - mode_emis will be depreciated in future releases please use emiss_lod to define emission mode || || ||[=#PA0735 PA0735] || Legacy emission read mode activated. All emissions data will be loaded prior to start of simulation || || ||[=#PA0736 PA0736] || New emission read mode currently unavailable for LODs 0 and 1. Reverting to legacy emission read mode || || ||[=#PA0737 PA0737] || New emission read mode activated LOD 2 emissions will be updated on-demand according to indicated timestamps || || ||[=#PA0738 PA0738] || No lsm- ... type defined. Please define ... type to enable deposition calculation || || ||[=#PA0739 PA0739] || No pavement type defined. Please define pavement type to enable deposition calculation || || ||[=#PA0740 PA0740] || Component ... not supported || || ||[=#PA0741 PA0741] || nwet can only be 0 or 1 || || ||[=#PA0742 PA0742] || cylic-fill method does not allow more than one surface element per grid box ||You try to read prerun data from a model setup that contained topography. This is not allowed, i.e. the prerun must have a flat surface. || ||[=#PA0743 PA0743] || 'Values <= 0 in mask_k_over_surface sre not allowed. Only values >= 1 are allowed for terrain-following output. Please see index ... in mask ... ||Terrain-following masked data output is only valid for grid points above the terrain. This means that mask_k_over_surface must be >= 1. Values < 1 are not allowed. Temporary information: '''Please note''', in revisions < -r4895 also values = 0 were allowed and used in some example setups provided for the latest PALM seminar (March 18th). || ||[=#PA0744 PA0744] || Nr surface elements in ... does not match .... || Internal error. Please contact the PALM developers. || ||[=#PA0745 PA0745] || rad_angular_discretization can only be used together with raytrace_mpi_rma or when no parallelization is applied. || You try to use the angular discretization without setting raytrace_mpi_rma to TRUE or without parallelization settings. Please set raytrace_mpi_rma to TRUE and make sure that you use parallelization settings || ||[=#PA0746 PA0746] || In case of radiation scheme ='rrtmg' and the use of cloud droplets average radiation is not implemented || || ||[=#PA0747 PA0747] || Relatively coarse angular discretization settings are set: raytrace_discrete_elevs < 9 and/or raytrace_discrete_elevs < 18 || You have used coarse angular discretization settings which will result in inaccurate radiation fluxes || ||[=#PA0748 PA0748] || Incorrect component name given! || Incorrect name given for a chemical component in listspec in &salsa_parameters. Options are: SO4, OC, BC, DU, SS, NH and NO. || ||[=#PA0749 PA0749] || 2d-REAL array "..." to be written to/read from restart file is defined with illegal dimensions || This problem may appear in your user-interface, if you try to write/read 2d-REAL arrays without ghost boundaries to/from the restart file. 2d-REAL arrays in restart files must have ghost boundaries. || ||[=#PA0750 PA0750] || psolver = "poisfft" requires that boundary conditions along x and y are both either cyclic or non-cyclic . || Switch to psolver = 'multigrid' or set initialization parameters bc_lr = bc_ns. || ||[=#PA0751 PA0751] || nesting and atmosphere-ocean coupling not allowed together || Using nesting in coupled atmosphere-ocean runs is not realized. || ||[=#PA0752 PA0752] || surface_coupler_buffer_handling: illegal action ... || internal error: please contact the PALM developers || ||[=#PA0753 PA0753] || Using the synthetic turbulence generator in idealized setups (no mesoscale nesting or self nesting), requires a STG_PROFILES file to have proper information about turbulent length and time scales, as well as Reynolds stress components. || Please provide turbulence information (derived from a precursor simulation or observations) || ||[=#PA0765 PA0765] || Precalculated ... solar positions from ... timesteps || Informative message, saying how many different discrete solar positions are considered for the simulation. || ||[=#PA0767 PA0767] || Error while writing output: ... || An internal error occured while trying to write the respective variable to the output file. In case you did not try to add additional output via user code, please report this error via the ticket system. || ||[=#PA0768 PA0768] || Error while defining output: ... || An internal error occured while trying to define the respective variable in the output file. In case you did not try to add additional output via user code, please report this error via the ticket system. || ||[=#PA0769 PA0769] || Error while defining output: ... || An internal error occured while trying to define the respective variable in the output file. In case you did not try to add additional output via user code, please report this error via the ticket system. || ||[=#PA0770 PA0770] || Error while writing output: ... || An internal error occured while trying to write the respective variable to the output file. In case you did not try to add additional output via user code, please report this error via the ticket system. || ||[=#PA0771 PA0771] || Error while defining output: ... || An internal error occured while trying to define the respective variable in the output file. In case you did not try to add additional output via user code, please report this error via the ticket system. || ||[=#PA0772 PA0772] || Error while writing output: ... || An internal error occured while trying to write the respective variable to the output file. In case you did not try to add additional output via user code, please report this error via the ticket system. || ||[=#PA0773 PA0773] || Topography and surface-setup output requires parallel netCDF. No output file will be created. || This is an informative message. If you use PALM without parallel netCDF support, output is omitted of the topography and surface setup. || ||[=#PA0774 PA0774] || initializing_actions = "read_spinup_data" requires a spinup file within the working directory. || The file containing spinup surface data is missing. Please ensure that spinup surface data has been created in a previous run. Moreover, check if the file connection statement for the file {{{SPINUPIN}}} is defined in the {{{.palm.iofiles}}}. Finally, check if {{{spinin}}} has been given within the {{{palmrun -a}}} option. || ||[=#PA0775 PA0775] || read_spinup_data" requires spinup_time = 0.0. || If the simulation is initialized with spinup surface data from a previous run, {{{spinup_time}}} must be 0.0 || ||[=#PA0776 PA0776] || initializing_actions = "read_spinup_data read_restart_data" is not possible. || The combination of initializing actions 'read_spinup_data' and 'read_restart_data' is mutually exclusive. || ||[=#PA0777 PA0777] || Reading spinup data requires restart_data_format_input = "mpi" or "mpi_shared_memory". || Reading spinup data is not realized for restart_data_format_input = "fortran_binary". || ||[=#PA0778 PA0778] || Writing spinup data requires restart_data_format_input = "mpi" or "mpi_shared_memory". || Writing spinup data is not realized for restart_data_format_input = "fortran_binary". || ||[=#PA0779 PA0779] || Writing spinup data is enabled but surface_spinup is switched-off. || You have enabled output of spinup surface data with the {{{palmrun -a "... spinout"}}} option. This case, the prescribed spinup_time must be > 0.0. || ||[=#PA0780 PA0780] || Finding boarder surface id at i,j,k= ... failed. || || ||[=#PA0781 PA0781] || Surface albedo for diffuse/direct long-/shortwave are different. To continue using the broadband albedo please set use_broadband_albedo to TRUE. || || ||[=#PA0782 PA0782] || number of particles for output too large: ... || You try to output a number of particles larger than the upper limit of a 32bit INTEGER (i.e. > 2^32^ - 1). Try to reduce your particle output. || ||[=#PA0783 PA0783] || particle_parameters NAMELIST will be ignored for childs || In a nested run, the particle parameters can only be set via the particle_parameters namelist of the root model. || ||[=#PA0784 PA0784] || size of structure particle_groups_type has changed || Internal error. Please inform the PALM developers, e.g. by submitting a trouble-ticket. || ||[=#PA0785 PA0785] || particle I/O-id not in defined range ..., ..., ... || Internal error. Please inform the PALM developers, e.g. by submitting a trouble-ticket. || ||[=#PA0786 PA0786] || error while reading file PARTICLE_IDS in line ... || At least one line in the file containing the particle Ids to be scheduled for time series output has a wrong format. Only one INTEGER value per line is allowed. || ||[=#PA0787 PA0787] || newly released particles exceed maximum number of particles allocated for time series, allocated particles: ..., current output: ..., newly added output: ... || Try to reduce the number of particles scheduled for time series output, e.g. by decreasing [../particle_parameters#pts_increment pts_increment] or [../particle_parameters#pts_percentag pts_percentage], or increase the maximum allowed number of output particles (see [../particle_parameters#maximum_number_of_output_particles maximum_number_of_output_particles] or [../particle_parameters#extend_prts_filesize extend_prts_filesize]). || ||[=#PA0788 PA0788] || Output of surface radiation cross sections of: "..." is not allowed in radiation-only mode. || The listed quantities are pure two-dimensional xy-cross-sections and not available in radiation-only mode. || ||[=#PA0789 PA0789] || Usage of radiation model in radiation-only mode in combination with an energy-balance model (LSM/USM) is not allowed. || Either deactivate LSM and USM or set the parameter [../radiation_parameters#radiation_only radiation_only] to .F.. || ||[=#PA0790 PA0790] || Usage of radiation model in radiation-only mode in combination with "radiation_interactions_on = .T." is not allowed. || Set one of the parameters [../radiation_parameters#radiation_interactions_on radiation_interactions_on] or [../radiation_parameters#radiation_only radiation_only] to .F.. || ||[=#PA0791 PA0791] || Usage of radiation model in radiation-only mode is only allowed in combination with "radiation_scheme = rrtmg" || Either deactivate usage of [../radiation_parameters#radiation_only radiation_only] by setting it to .F. or use the RRTMG [../radiation_parameters#radiation_scheme radiation_scheme]. || ||[=#PA0792 PA0792] || Missing the building width (BUILD_PROP) in DCEP input file || Add the building width (BUILD_PROP) to DCEP input file || ||[=#PA0793 PA0793] || Missing fraction of urban class (FR_URBANCL) in DCEP input file || Add the fraction of urban class (FR_URBANCL) to DCEP input file || ||[=#PA0794 PA0794] || Input file PIDS_DCEP is missing || Add the input file PIDS_DCEP || ||[=#PA0795 PA0795] || The output of DCEP related output requires DCEP settings in the input file p3d || Add the settings to the input file p3d || ||[=#PA0796 PA0796] || Writting out the average of a DCEP related output is not implemented || Remove the variable from the output list || ||[=#PA0797 PA0797] || Wrong DCEP tendency component or not implemented yet for component (for developers) || Remove the component from the tendency routine or implement it in the code || ||[=#PA0798 PA0798] || DCEP is not implemented when urban-surface model is applied || Remove urban surfaces from the domain || ||[=#PA0799 PA0799] || DCEP is not implemented when vertical land surfaces exist || Remove vertical land surfaces from the domain || ||[=#PA0800 PA0800] || Wrong value of type of drag coefficient for walls ("iurb_cdrag") || Use 1 or 2 for "iurb_cdrag" || ||[=#PA0801 PA0801] || Inverse of longwave radiation matrix not correct || Review and check the variables in the DCEP input file || ||[=#PA0802 PA0802] || Inverse of shortwave radiation matrix not correct || Review and check the variables in the DCEP input file || ||[=#PA0803 PA0803] || The sum of SVFs at wall element at is not 1 || Review and check the variables in the DCEP input file || ||[=#PA0804 PA0804] || The sum of SVFs at ground element at is not 1 || Review and check the variables in the DCEP input file || ||[=#PA0805 PA0805] || The sum of SVFs at sky element at is not 1 || Review and check the variables in the DCEP input file || ||[=#PA0806 PA0806] || One or more Dimension of in DCEP input file does not match the inputs in parin file || Review and check the related variables in DCEP namelist and the DCEP input file || ||[=#PA0807 PA0807] || Missing the urban fraction (FR_URBAN) in the DCEP input file || Add the urban fraction (FR_URBAN) to the DCEP input file || ||[=#PA0808 PA0808] || Missing the fraction of street direction (FR_STREETD) in the DCEP input file || Add the fraction of street direction (FR_STREETD) to the DCEP input file || ||[=#PA0808 PA0808] || Missing the fraction of street direction (FR_STREETD) in the DCEP input file || Add the fraction of street direction (FR_STREETD) to the DCEP input file || ||[=#PA0809 PA0809] || Missing the street width (STREET_W) in the DCEP input file || Add the street width (STREET_W) to the DCEP input file || ||[=#PA0810 PA0810] || Missing the building width (BUILD_W) in the DCEP input file || Add the building width (BUILD_W) to the DCEP input file || ||[=#PA0811 PA0811] || Wrong value of type of urban length scale parametrization ("iurb_ls") || Use 1 "iurb_ls" || ||[=#PA0812 PA0812] || output of individual particle time series data requires preprocessor switches {{{-D__netcdf}}}, {{{-D__netcdf4}}}, and {{{-D__netcdf4_parallel}}} || Set the required switches in the configuration file .palm.config and re-compile. Be aware that you need a NetCDF-library with parallel I/O support. || ||[=#PA0817 PA0817] || Mesoscale nesting requires initializing_actions = "read_from_file". || If lateral and top boundary conditions are obtained from a mesoscale model simulation, the initial profiles of the velocity components, potential temperature and mixing ratio need to be in line with the mesoscale data. As boundary conditions from mesoscale model data are handed over via the dynamic input file, the initial profiles should also handed over this way. If other initial data is used instead, this could result in large discrepancies between the initial data and the boundary data at the inflow boundaries, which can lead to strong numerical oscillations. In particular for the mixing ratio, this could produce even values close to zero or supersaturated conditions, possibly leading to numerical instabilities in conjunction with the energy-balance schemes. || ||[=#PA0818 PA0818] || initializing_actions = "inifor" is deprecated and will be removed. Please use "read_from_file" instead. || || ||[=#PA0819 PA0819] || surface_type = "netcdf" is deprecated and will be removed. Please use "read_from_file" instead. || || ||[=#PA0820 PA0820] || Reading canopy data - too much data points along the vertical coordinate. || The size of the vertical canopy grid on the static input file exceeds the vertical model domain size. || ||[=#PA0821 PA0821] || Reading canopy data - vertical coordinate do not match numeric grid at zlad(k= ...). || The values of zlad differ from the vertical numeric grid. || ||[=#PA0822 PA0822] || Reading canopy data - vertical dimension "zlad" missing. || || ||[=#PA0823 PA0823] || Advanced flow-divergence correction is only possible with loop_optimization = 'vector'. || Please change setting of loop_optimization. || ||[=#PA0824 PA0824] || Advanced flow-divergence correction requires a smaller timestep. Please set cfl_factor to a value < 0.5. || || ||[=#UI0001 UI0001] ||unknown location "..." ||The location of the CALL of user_actions has to be one of 'before_timestep', 'after_integration', 'after_timestep', 'u_tendency' 'v_tendency', 'w_tendency', 'pt_tendency', 'sa_tendency', 'e_tendency', 'q_tendency', 's_tendency'. The location of the CALL of user_actions_ij has to be one of 'u_tendency' 'v_tendency', 'w_tendency', 'pt_tendency', 'sa_tendency', 'e_tendency', 'q_tendency', 's_tendency'. || ||[=#UI0002 UI0002] ||location "..." is not allowed to be called with parameters "i" and "j" || The location of the CALL of user_actions_ij must not be 'before_timestep', 'after_integration', 'after_timestep' || ||[=#UI0003 UI0003] ||unused || || ||[=#UI0004 UI0004] ||unused || || ||[=#UI0005 UI0005] ||topography "..." not available yet || There was no usable user-defined topography found. || ||[=#UI0006 UI0006] ||unknown topography "..." || This error message appears if the parameter [../initialization_parameters#topography topography] is not set to one of the allowed values 'flat', 'single_building', 'single_street_canyon', 'tunnel' or to a user defined value. This can happen if the parameter topography contains a wrong character string that is neither recognized in init_grid nor in user_init_grid. || ||[=#UI0007 UI0007] ||canopy_mode "..." not available yet || There was no usable user-defined plant canopy found. || ||[=#UI0008 UI0008] ||unknown canopy_mode "..." || The requested identifier for the canopy mode was not found in the user interface [source:palm/trunk/SOURCE/user_init_plant_canopy.f90]. Check if the spelling in your input file matches the defined canopy mode. || ||[=#UI0009 UI0009] ||the number of user-defined profiles given in data_output_pr (...) does not match the one found in the restart file (...) || This will only happen in case the number of user [../user_parameters#data_output_pr_user profiles] was changed from precursor to main run. See documentation of [../examples/turbinf tubulent inflow] for detailed information on the use of restart data for precursor runs. || ||[=#UI0010 UI0010] ||Spectra of ... can not be calculated || No CASE statement defined for '...' in [[source:palm/trunk/SOURCE/user_spectra.f90| user_spectra.f90]]. || ||[=#UI0011 UI0011] ||Spectra of ... are not defined || No CASE statement defined for '...' in [[source:palm/trunk/SOURCE/user_spectra.f90| user_spectra.f90]]. || ||[=#NC NC!**!**] ||!**!** contains numbers in the range from 1-521 ||Internally, PALM calls the netCDF function {{{NF90_STRERROR}}} which returns an error message string provided by netCDF. Hence, no exact assignment between PALM error number and netCDF error string can be given. Most of the netCDF errors should never appear if the default code is used. The following list gives errors which may be caused by wrong steering or errors due to problems in the user interface. || ||[=#NC0079 NC0079] ||String match to name in use ||A netCDF variable name has been used twice. Possible reasons: a variable in the parameter file has been listed twice (e.g. in [../runtime_parameters#data_output data_output]) or a variable name that has been defined in the user interface is already used by PALM. || ||[=#NC0253 NC0253] ||Name contains illegal characters ||netCDF variable names consist of arbitrary sequences of alphanumeric characters. These names are e.g. assigned by the user in the user-interface to variables {{{dots_label}}} or {{{dopr_label}}}. Due to the netCDF convention, they must not start with a digit. Also, usage of {{{/}}} as special character is not allowed. Older netCDF versions (before 3.6.3) have further restrictions on special characters. [[BR]][[BR]] Please check if your string settings in the user-interface follow the above rules. ||