Version 192 (modified by maronga, 10 years ago) (diff) |
---|
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 here?). The third column explains the error and possible reasons in more detail, and also gives suggestions how to solve the problem.
Identifier for messages in the PALM standard code | |
Identifier for messages in ''user_'' routines | |
Identifier for messages from the netCDF library |
Message identifier | Error message | Explanation |
---|---|---|
PA0001 | "host" is not set. Please check that environment variable "localhost" is set before running PALM | By default, PALM gets the "host" value from reading the NAMELIST envpar, which is automatically provided in a local file named ENVPAR, if PALM is run with scripts mrun or palm_simple_run. You may check the contents of file ENVPAR (e.g. by running mrun with option -B (preventing that the temporary working directory containing this file is automatically deleted when mrun is finished), or submit a trouble ticket. |
PA0002 | illegal coupling mode: ... | This message is related to the atmosphere-ocean coupling implemented in PALM. Internally, the variable coupling_mode defines the coupling setup used for the current respective model run. It may have one of the values "atmosphere_to_ocean" (atmospheric part of a coupled run), "ocean_to_atmosphere (ocean part of a coupled run), "precursor_atmos" (a precursor atmosphere run), "precursor_ocean" (a precursor ocean run), or "uncoupled" (atmosphere or ocean run without any intended coupling). This error message means that the initialization of the coupling did fail because coupling_mode has a value different from the ones mentioned before. Possible reasons might be trying a coupling between two atmosphere runs (or two ocean runs), or problems with the mrun script. |
PA0003 | dt_coupling is not set but required for coupling mode "..." | This error appears if the temporal interval for the data exchange dt_coupling is not explicitly set in case of runs with coupled models (e.g. atmosphere - ocean). |
PA0004 | coupling mode "...": dt_coupling = ... is not equal to dt_coupling_remote = ... | For coupled runs the temporal interval for the data exchange dt_coupling must be explicitly set and must have the same value in both models. |
PA0005 | coupling mode "...": dt_coupling <= 0.0 is not allowed and is reset to MAX(dt_max(A,O)) = ... | This error occurs if an invalid value for dt_coupling is used in the parameter file. dt_coupling must be > 0.0 and equal in both models. |
PA0006 | coupling mode "...": restart_time = ... is not equal to restart_time_remote = ... | restart_time has not been set properly (equal) in the atmosphere and ocean parameter file. See also coupled runs. |
PA0007 | coupling mode "...": dt_restart = ... is not equal to dt_restart_remote = ... | dt_restart has not been set properly (equal) in the atmosphere and ocean parameter file. See also coupled runs. |
PA0008 | coupling mode "...": simulation_time_since_reference = ... is not equal to simulation_time_since_reference_remote = ... | The simulated time is stored internally in the variable simulation_time_since_reference. 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 coupled runs for a detailed description of the setup for precursor runs. |
PA0009 | dx in atmosphere is not larger or equal than dx in ocean | Coupled runs allow to use different grid resolutions in atmosphere and ocean. It is, however, not possible to use a finer grid resolution in the atmosphere than in the ocean. |
PA0010 | Domain size in x-direction is not equal in ocean and atmosphere | Coupled runs are only possible, if the horizontal model domain size is equal in both, atmosphere and ocean. Check the settings for dx, dy, nx and ny to avoid this error. |
PA0011 | dy in atmosphere is not larger or equal than dy in ocean | Coupled runs allow to use different grid resolutions in atmosphere and ocean. However, it is not allowed to use a finer grid resolution in the atmosphere than in the ocean. |
PA0012 | Domain size in y-direction is not equal in ocean and atmosphere | Coupled runs are only possible, if the horizontal model domain size is equal in both, atmosphere and ocean. Have a look at the settings for dx, dy, nx and .ny? to avoid this error. |
PA0013 | illegal value given for loop_optimization: "..." | See parameter loop_optimization for allowed values, and check your parameter file. |
PA0014 | a non-flat topography does not allow ... | There are several features which do not work together with a non-flat topography. See parameter topography for possible restrictions and appropriately modify your parameter file. |
PA0015 | ocean = .T. does not allow ... | There are several features which do not work within PALM's ocean mode. See parameter ocean for possible restrictions and appropriately modify your parameter file. |
PA0016 | unknown solver for perturbation pressure: psolver = "..." | See parameter psolver for allowed values, and correct your parameter file. |
PA0017 | Vertical grid stretching is not allowed together with particle advection. | With the currently implemented spatial interpolation of flow quantities on the respective particle positions, a constant vertical grid spacing must be used. |
PA0018 | ros_count > 5 in Rosenbrock method | The Rosenbrock method is used if curvature and solution effects are included in the calculation of cloud droplet growth due to condensation (see curvature_solution effects). This algorithm may lead to unreasonable results, if the external conditions, especially the supersaturation, significantly changes between two PALM time steps. In that case, the algorithm will be carried out again with a smaller internal time step. The limits, which decide weather a result is reasonable or not, are only tested for a certain range of relative humidities and cloud droplet sizes. If this error appears, the result after 5 recalculations of the Rosenbrock algorithm is still regarded as unreasonable. Thus the limiting values may not be suitable for the current conditions and need to be adjusted in PALM's source code (see file lpm_doplet_condensation.f90 in the repository). |
PA0019 | no spectra levels given | output of spectra has been selected, but no height levels have been provided with parameter comp_spectra_level |
PA0020 | unknown multigrid cycle: cycle_mg = "..." | See parameter cycle_mg for allowed values, and appropriately correct your parameter file. |
PA0021 | unknown fft-algorithm: fft_method = "..." | See parameter fft_method for allowed values, and appropriately correct your parameter file. |
PA0022 | unknown advection scheme: momentum_advec = "..." | See parameter momentum_advec for allowed values, and appropriately correct your parameter file. |
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 timestep_scheme = runge-kutta-3. |
PA0024 | unknown advection scheme: scalar_advec = "..." | See parameter scalar_advec for allowed values, and appropriately correct your parameter file. |
PA0025 | use_upstream_for_tke set .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 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 use_upstream_for_tke in the parameter file (inipar-NAMELIST). This warning will not occur if |
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 | unknown timestep scheme: timestep_scheme = "..." | See parameter timestep_scheme for allowed values, and appropriately correct your parameter file. |
PA0028 | negative weighting factor: ... | The weighting factor of the cloud droplets is recalculated during the calculation of the droplet growth due to collision and coalescence. This error appears, if the newly calculated value for the weighting factor is negative and the hall_fast or wang_fast collision kernel has been used (see collision_kernel). A possible reason may be illegal values of the collision kernel. |
PA0029 | momentum advection scheme "..." does not work with timestep_scheme "..." | For timestep_scheme = 'runge-kutta-3' only momentum_advec = 'ws-scheme' or 'pw-scheme' gives a numerically stable solution. |
PA0030 | initializing_actions = "..." unkown or not allowed | See parameter initializing_actions for allowed values in initial runs (of a job chain). For a restart run, please set initializing_actions = 'read_restart_data' . |
PA0031 | initializing_actions = "set_constant_profiles" and "set_1d-model_profiles" are not allowed simultaneously | Set either initializing_actions = 'set_constant_profiles' in your parameter file, if the 3d-model shall be initialized with constant profiles, or set initializing_actions = 'set_1d-model_profiles' if the 3d-model shall be initialized with profiles of the (stationary) solution of the 1d-model. |
PA0032 | initializing_actions = "set_constant_profiles" and "by_user" are not allowed simultaneously | Set either initializing_actions = 'set_constant_profiles' in your parameter file, if the 3d-model shall be initialized with constant profiles, or set 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 user-interface. |
PA0033 | initializing_actions = "by_user" and "set_1d-model_profiles" are not allowed simultaneously | Set either 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 user-interface, or set initializing_actions = 'set_1d-model_profiles' , if the 3d-model shall be initialized with profiles of the (stationary) solution of the 1d-model. |
PA0034 | cloud_physics = ... is not allowed with humidity = ... | Fabian |
PA0035 | precipitation = ... is not allowed with cloud_physics = ... | Fabian |
PA0036 | humidity = .TRUE. and sloping_surface = .TRUE. are not allowed simultaneously | If 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 alpha_surface /= 0.0 the simultaneous use of humidity = .TRUE. is not allowed. |
PA0037 | negative weighting factor: ... | The weighting factor of the cloud droplets is recalculated during the calculation of the droplet growth due to collision and coalescence. This error appears if the newly calculated value for the weighting factor is negative and the 'hall' or 'wang' collision kernel is used (see collision_kernel). It may be caused by illegal values of the collision kernel. Please submit a trouble ticket if you have run into this error. |
PA0038 | humidity = .TRUE. and passive_scalar = .TRUE. is not allowed simultaneously' | In PALM, the same equation and internal variable is used for transport of humidity and scalar quantity. This quantity can either be the humidity or a passive scalar, but not both at the same time. |
PA0039 | negative weighting factor: ... | The weighting factor of the cloud droplets is recalculated during the calculation of the droplet growth due to collision and coalescence. This error appears if the newly calculated value for the weighting factor is negative and the 'palm' collision kernel is used (see collision_kernel). It may be caused by illegal values of the collision kernel. Please submit a trouble ticket if you have run into this error. |
PA0040 | LWC is not conserved during collision! LWC after condensation: ... LWC after collision: ... | Fabian |
PA0041 | plant_canopy = .TRUE. requires a non-zero drag coefficient, given value is drag_coefficient = 0.0 | In case of plant_canopy = .TRUE., a non-zero drag_coefficient must be set to account for the effect of the plant canopy on the flow. The canopy model in PALM adds an additional source/sink term to the momentum equations, the prognostic equation for temperature, and the subgrid scale turbulent kinetic energy equation. In case of humidity = .TRUE. or passive_scalar = .TRUE., an additional source/sink term is added to the prognostic equation of the respective scalar. If drag_coefficient = 0.0, the additional terms equal zero and there would be no effect on the flow. |
PA0042 | use_top_fluxes must be .TRUE. in ocean mode | In 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 | ABS( alpha_surface = ... ) must be< 90.0 | Upright surfaces are not allowed in case of sloping surfaces. |
PA0044 | dt = ... <= 0.0 | The parameter dt (time step for the 3d-model) must not be set to a value <= 0.0. |
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. |
PA0046 | baroclinity (ug) not allowed simultaneously with galilei transformation | The Galilei coordinate transformation (see galilei_transformation) is not allowed under baroclinic conditions (where the geostrophic wind varies with height). Modify either ug_surface or galilei_transformation, or set use_ug_for_galilei_tr = .FALSE. appropriately in the parameter file. |
PA0047 | baroclinity (vg) not allowed simultaneously with galilei transformation | The Galilei coordinate transformation (see galilei_transformation) is not allowed under baroclinic conditions (where the geostrophic wind varies with height). Modify either vg_surface, or galilei_transformation appropriately, or set use_ug_for_galilei_tr = .FALSE. in the parameter file. |
PA0048 | variable translation speed used for Galilei-transformation, which may cause instabilities in stably stratified regions | You have set both galilei_transformation = .TRUE. and 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 | unknown boundary condition: bc_lr = "..." | See parameter bc_lr for allowed values, and appropriately correct your parameter file. |
PA0050 | unknown boundary condition: bc_ns = "..." | See parameter bs_ns for allowed values, and appropriately correct your parameter file. |
PA0051 | non-cyclic lateral boundaries do not allow psolver = "..." | Using non-cyclic lateral boundary conditions requires the multigrid method for solving the Poisson equation for the perturbation pressure. You can choose this method by setting the parameter psolver = 'multigrid' . |
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 momentum_advec. |
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 scalar_advec. |
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 bc_lr = bc_ns = 'cyclic' , or set galilei_transformation = .FALSE. in the parameter file. |
PA0055 | turbulent_inflow = .T. requires initializing_actions = 'cyclic_fill' | Using a turbulent inflow requires that the 3d arrays have to be initialized by cyclically repeated data from a prerun. Set parameter initializing_actions appropriately. |
PA0056 | illegal value for reference_state: "..." | See parameter reference_state for allowed values, and appropriately correct your parameter file. |
PA0057 | boundary condition bc_e_b changed to "..." | You have set both bc_e_b = (u*)**+neumann, and prandtl_layer = .FALSE., which is in conflict, since this type of boundary condition requires a Prandtl layer. bc_e_b has been set to 'neumann' instead. |
PA0058 | unknown boundary condition: bc_e_b = "..." | See parameter bc_e_b for allowed values, and appropriately correct your parameter file. |
PA0059 | unknown boundary condition: bc_p_b = "..." | See parameter bc_p_b for allowed values, and appropriately correct your parameter file. |
PA0060 | error number free to use | |
PA0061 | unknown boundary condition: bc_p_t = "..." | See parameter bc_p_t for allowed values, and appropriately correct your parameter file. |
PA0062 | unknown boundary condition: bc_pt_b = "..." | See parameter bc_pt_b for allowed values, and appropriately correct your parameter file. |
PA0063 | unknown boundary condition: bc_pt_t = "..." | See parameter bc_pt_t for allowed values, and appropriately correct your parameter file. |
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 top_momentumflux_u and top_momentumflux_v at the same time. |
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 bc_pt_b = 'dirichlet' ), and a surface sensible heatflux (with 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 | constant_heatflux = .TRUE. is not allowed with pt_surface_initial_change (/=0) = ... | If you give the sensible heatflux as surface boundary condition (using parameter surface_heatflux), you must not specify anything about the surface temperature at the same time (e.g. with parameter pt_surface_initial_change). |
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 bc_pt_t = 'dirichlet' ), and a sensible heatflux at the top (with 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 | unknown boundary condition: bc_sa_t = "..." | See parameter bc_sa_t for allowed values, and appropriately correct your parameter file. |
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 bc_sa_t = 'neumann' ), but you did not provide a salinity flux at the top. Please provide parameter top_salinityflux in the parameter file. |
PA0070 | boundary condition: bc_sa_t = "..." is not allowed with constant_top_salinityflux = .TRUE.' | You have tried to set both, a Dirichlet boundary condition for salinity at the top (with bc_sa_t = 'dirichlet' ), and a salinity flux at the top (with 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 | unknown boundary condition: bc_..._b ="..." | See the respective parameter description in the documentation, and appropriately correct your parameter file. |
PA0072 | unknown boundary condition: bc_..._t ="..." | See the respective parameter description in the documentation, and appropriately correct your parameter file. |
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 bc_q_b / bc_s_b = 'dirichlet' ), and a surface latent heatflux / scalar flux (with surface_waterflux / 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 | 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 surface_waterflux / surface_scalarflux), you must not specify anything about the surface humidity / scalar at the same time (e.g. with parameter q_surface_initial_change / s_surface_initial_change). |
PA0075 | boundary condition: bc_uv_b = "..." is not allowed with prandtl_layer = .TRUE. | You have tried to set both, a Neumann surface boundary condition for horizontal velocity (with bc_uv_b = 'neumann' ), and a Prandtl layer between the surface and the first vertical grid point (with prandtl_layer = .TRUE.), which are contradicting conditions. Either set prandtl_layer = .FALSE. or bc_uv_b = 'dirichlet' in the parameter file. |
PA0076 | unknown boundary condition: bc_uv_b = "..." | See parameter bc_uv_b for allowed values, and appropriately correct your parameter file. |
PA0077 | unknown boundary condition: bc_uv_t = "..." | See parameter bc_uv_b for allowed values, and appropriately correct your parameter file. |
PA0078 | rayleigh_damping_factor = ... out of range [0.0,1.0] | Adjust the value of rayleigh_damping_factor in your parameter file to the allowed range. |
PA0079 | rayleigh_damping_height = ... out of range [0.0, ...] | Adjust the value of 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 | preprocessor switch for fftw is missing | You have set 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. |
PA0081 | error number free to use | |
PA0082 | number of statistic_regions = ... but only 10 regions are allowed | Adjust parameter statistic_regions in your parameter file to a value <= 9. |
PA0083 | normalizing_region = ... must be >= 0 and <= ... (value of statistic_regions) | The region number given by normalizing_region must be within the range [0, statistic_regions ]. Adjust normalizing_region appropriately in your parameter file. |
PA0084 | dt_sort_particles is reset to 0.0 because of cloud_droplets = .TRUE. | Using particles as cloud droplets (cloud_droplets = .TRUE.) requires sorting of the particle array after each timestep. This warning means, that the respective steering parameter (dt_sort_particles) for the resort-interval has been automatically reset to 0.0, in order to force a resort after each timestep. Not available from release 4.0 on. |
PA0085 | averaging_interval = ... must be <= dt_data_output = ... | The averaging_interval for output data must be smaller or equal to the output interval given by dt_data_output. Adjust settings of these variables appropriately in the parameter file. |
PA0086 | averaging_interval_pr = ... must be <= dt_dopr = ... | The averaging_interval_pr for profile output data must be smaller or equal to the output interval given by dt_dopr. Adjust settings of these variables appropriately in the parameter file. |
PA0087 | averaging_interval_sp = ... must be <= dt_dosp = ... | The averaging_interval_sp for spectra output data must be smaller or equal to the output interval given by dt_dosp. Adjust settings of these variables appropriately in the parameter file. |
PA0088 | dt_averaging_input = ... must be <= averaging_interval = ... | The sampling interval (set by dt_averaging_input) for averaging data must be less or equal to the averaging interval (set by averaging_interval). Adjust settings of these variables appropriately in the parameter file. |
PA0089 | dt_averaging_input_pr = ... must be <= averaging_interval_pr = ... | The sampling interval (set by dt_averaging_input_pr) for averaging profile data must be less or equal to the averaging interval (set by averaging_interval_pr). Adjust settings of these variables appropriately in the parameter file. |
PA0090 | precipitation_amount_interval = ... must not be larger than dt_do2d_xy = ... | Choose a value for precipitation_amount_interval smaller than or equal to dt_do2d_xy. Adjust the settings of precipitation_amount_interval appropriately in the parameter file. |
PA0091 | data_output_pr = ... is not implemented for ocean = .FALSE. | The listed entries in the parameter file under data_output_pr are only avialable for ocean= .T.. There could also be a typo in data_output_pr (an output variable was used that does not exist in PALM). |
PA0092 | data_output_pr = ... is not implemented for humidity = .FALSE. | The listed entries in the parameter file under data_output_pr are only available for humidity= .T.. There could also be a typo in data_output_pr (an output variable was used that does not exist in PALM). |
PA0093 | data_output_pr = ... is not implemented for passive_scalar = .FALSE. | The listed entries in the parameter file under data_output_pr are only available for passive_scalar= .T.. There could also be a typo in data_output_pr (an output variable was used that does not exist in PALM). |
PA0094 | data_output_pr = ... is not implemented for cloud_physics = .FALSE. | The listed entries in the parameter file under data_output_pr are only available for cloud_physics= .T.. There could also be a typo in data_output_pr (an output variable was used that does not exist in PALM). |
PA0095 | data_output_pr = ... is not implemented for cloud_physics = .FALSE. and humidity = .FALSE. | |The listed entries in the parameter file under data_output_pr are only available for cloud_physics= .T. and humidity=.T. There could also be a typo in data_output_pr (an output variable was used that does not exist in PALM). |
PA0096 | data_output_pr = ... is not implemented for cloud_physics = .FALSE. or cloud_droplets = .FALSE | The listed entries in the parameter file under data_output_pr are only available for cloud_droplets= .T. and humidity=.T. There could also be a typo in data_output_pr (an output variable was used that does not exist in PALM). |
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 here). |
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. |
PA0099 | netCDF: netCDF4 parallel output requested but no cpp-directive __netcdf4_parallel given switch back to netCDF4 non-parallel output | 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 (%copts) and load (%lopts) options of the configuration file appropriately. Job will be continued with netcdf_data_format = netcdf_data_format - 2. |
PA0100 | error number free to use | |
PA0101 | error number free to use | |
PA0102 | number of output quantities given by data_output and data_output_user exceeds the limit of 100 | The total number of output quantities listed in data_output and data_output_user exceeds the maximum of 100. To increase this limit, the standard PALM code has to be modified. In case you have little experience with the PALM code use a trouble ticket for a query to increase the maximum output number. |
PA0103 | output of "..." requires constant_diffusion = .FALSE. | Output of the subgrid TKE e listed in the parameter file under data_output or data_output_masks is only available for constant diffusion= .F.. |
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 data_output or data_output_masks is only available in case the particles_par namelist ist set in the parameter file |
PA0105 | output of "..." requires humidity = .TRUE. | Output of humidity (q and/or qv) listed in the parameter file under data_output or data_output_masks is only available for humidity= .T.. |
PA0106 | output of "..." requires cloud_physics = .TRUE. or cloud_droplets = .TRUE. | Output of liquid water content ql listed in the parameter file under data_output or data_output_masks is only available for cloud_physics= .T. or cloud_droplets= .T.. |
PA0107 | output of "..." requires cloud_droplets = .TRUE. | The quantities ql_c, ql_v, ql_vp are only calculated in case of cloud_droplets = .T.. |
PA0108 | output of "..." requires cloud_physics = .TRUE. | For the output of the water vapor content qv (specific humidity) set cloud_physics = .T. to switch on the condensation scheme. Also, humidity = .T. must be set. If you want to simulate the humidity without condensation/evaporation processes, use only humidity = .T. and choose output quantity q for output of the specific humidity. |
PA0109 | output of "..." requires ocean = .TRUE. | The quantities rho and sa are only calculated in case of ocean = .T.. |
PA0110 | output of "..." 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 passive_scalar = .T.. |
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. |
PA0112 | output of "..." requires precipitation = .TRUE. | The quantities pra* and prr* are only calculated in case of precipitation = .T.. |
PA0113 | temporal averaging of precipitation amount "..." is not possible | The quantity precipitation_amount pra* listed in data_output contains already the summed precipitation of the last precipitation_amount_interval. Therefore, remove the substring _av of pra*. |
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 here). |
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. |
PA0117 | error number free to use | |
PA0118 | error number free to use | |
PA0119 | error number free to use | |
PA0120 | error number free to use | |
PA0121 | km_constant = ... < 0.0 | The eddy-diffusivity km has to be positive definite. Change the value of km_constant accordingly. |
PA0122 | prandtl_number = ... < 0.0 | The Prandtl number Pr has to be positive definite. Change the value of prandtl_number accordingly. |
PA0123 | prandtl_layer is not allowed with fixed value of km | For laminar flows with a constant eddy diffusivity km_constant=.T., the Prandtl layer has to be switched of via prandtl_layer=.T.. |
PA0124 | pt_damping_width out of range |
In case of non-cyclic lateral boundary conditions, the parameter pt_damping_width should not be lesser than zero or greater than the model domain length in the respective direction. and in case of bc_ns /= 'cyclic': (nx+1), (ny+1) are the total number of grid points and dx, dy the grid lengths in the x-, y-direction, respectively. |
PA0125 | rif_min = ... must be less than rif_max = ... | The flux-Richardson number which is calculated interactively in PALM can be limited to prevent reaching unrealistic values under certain circumstances. Make sure that rif_min is smaller than rif_max. |
PA0126 | disturbance_level_b = ... must be >= ... (zu(3)) | Due to technical reasons the lower disturbance level given by disturbance_level_b has to be larger than zu(3). |
PA0127 | disturbance_level_b = ... must be <= ... (zu(nzt-2)) | Due to technical reasons the lower disturbance level given by disturbance_level_b has to be smaller than zu(nzt-2). |
PA0128 | disturbance_level_t = ... must be <= ... (zu(nzt-2)) | Due to technical reasons the upper disturbance level given by disturbance_level_t has to be smaller than zu(nzt-2). |
PA0129 | disturbance_level_t = ... must be >= disturbance_level_b = ... | Ensure that disturbance_level_t is larger than disturbance_level_b to obtain at least one layer where disturbances are added. |
PA0130 | disturbance_level_ind_t =... must be >= disturbance_level_b = ... | This error may occur when the lower and upper disturbance levels disturbance_level_b and 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 | inflow_disturbance_begin out of range | The parameter 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 | inflow_disturbance_end out of range | The parameter 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 | 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: nonclyclic boundary conditions as well as turbulent inflow. |
PA0134 | illegal value for recycling_width: ... | See parameter recycling_width for allowed values, and appropriately correct your parameter file. |
PA0135 | unknown random generator: random_generator = "..." | See parameter random_generator for allowed values, and appropriately correct your parameter file. |
PA0136 | damp_level_1d = ... must be > 0.0 and < ... (zu(nzt+1)) | Follow these instructions for damp_level_1d. |
PA0137 | mixing_length_1d = "..." is unknown | See parameter mixing_length_1d for allowed values, and appropriately correct your parameter file. |
PA0138 | dissipation_1d = "..." is unknown | See parameter dissipation_1d for allowed values, and appropriately correct your parameter file. |
PA0139 | termination_time_needed = ... must be > 30.0 on host ... | Choose a termination_time_needed that is larger than 30 seconds because a specific amount of time is needed to finish the job for example for copying files, compiling, data output, ... . |
PA0140 | termination_time_needed = ... should be >= 300.0 on host "..." | Choose a termination_time_needed that is larger than 300 seconds because a specific amount of time is needed to finish the job for example for copying files, compiling, data output, ... . |
PA0141 | coupling requires PALM to be called with "mrun -K parallel" | Coupling is only allowed in parallel and not in serial mode. |
PA0142 | absolute temperature < 0.0 at zu(...) = ... | Within the PALM code (in init_cloud_physics), 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 (nz), switch on the grid stretching at larger heights (see dz_stretch_level) or reduce the grid stretching factor (dz_stretch_factor). |
PA0143 | k=... j=... i=... ql_c=... part(...)%wf=... delta_r=... | |
PA0144 | #1 k=... j=... i=... e_s=... e_a=... t_int=... d_radius=... delta_r=... particle_radius=... | Theres |
PA0145 | collision_efficiency out of range: ... | Theres |
PA0146 | maximum_number_of_particles needs to be increased but this is not allowed with netcdf_data_format < 3 | netCDF output is switched on (data_output_format = 'netcdf' ) and a netCDF3 format is used (netcdf_data_format < 3). If output of particle data is switched on (see dt_write_particle_data), the size of the particle array, given on each processor by maximum_number_of_particles, is not allowed to increase during the run, when the netCDF3 data format is used, because netCDF3 allows only one unlimited dimension, which is the time dimension. Anyhow, PALM tries to increase the size of the particle array, if the number of particles in a subdomain becomes larger than the size of this array. This may happen because of a flow convergence or because new sets of particles are released (see dt_prel). This problem can be avoided by using the netCDF4 data format (netcdf_data_format > 2), which allows more than one unlimited dimension. Alternatively, maximum_number_of_particles can be given a sufficiently large value. |
PA0147 | maximum_number_of_tails needs to be increased but this is not allowed with netcdf_data_format < 3 | netCDF output is switched on (data_output_format = 'netcdf' ) and a netCDF3 format is used (netcdf_data_format < 3). If output of particle data is switched on (see dt_write_particle_data), the size of the particle array, given on each processor by maximum_number_of_tails, is not allowed to increase during the run, when the netCDF3 data format is used, because netCDF3 allows only one unlimited dimension, which is the time dimension. Anyhow, PALM tries to increase the size of the particle array, if the number of particles in a subdomain becomes larger than the size of this array. This may happen because of a flow convergence or because new sets of particles are released (see dt_prel). This problem can be avoided by using the netCDF4 data format (netcdf_data_format > 2), which allows more than one unlimited dimension. Alternatively, maximum_number_of_particles can be given a sufficiently large value. |
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 | particle out of range: i=... j=... k=... nxl=... nxr=... nys=... nyn=... nzb=... nzt=... | |
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 (dp_external = .TRUE.) and conserve_volume_flow is not allowed. Please correct your parameter file appropriately. |
PA0151 | dp_level_b = ... is out of range | dp_level_b is outside of the vertical bounds of the model domain. Please check the prescribed value for dp_level_b in your parameter file. |
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. dp_external is .TRUE., dpdxy must be set to a non-zero value in your parameter file. |
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. dpdxy is set to a non-zero value, dp_external = .TRUE. must be set in your parameter file. |
PA0154 | unknown conserve_volume_flow_mode: ... | See parameter conserve_volume_flow_mode for allowed values, and appropriately correct your parameter file. |
PA0155 | noncyclic boundary conditions require conserve_volume_flow_mode = "inflow_profile" | Micha |
PA0156 | noncyclic boundary conditions require conserve_volume_flow_mode = "inflow_profile" | Micha |
PA0157 | nonzero bulk velocity requires conserve_volume_flow = .T. and conserve_volume_flow_mode = "bulk_velocity" | |
PA0158 | no vertical boundary condition for variable "..." | |
PA0159 | no term for component "..." | |
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. |
PA0161 | sorry, calculation of spectra in non parallel mode is still not realized | Calculation of spectra in non-parallel mode is not implemented. |
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. |
PA0163 | run will be terminated because it is running out of job cpu limit remaining time: ... s termination time needed: ... s | In case that 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 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 Initialization and restart runs for further information. |
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 restart_time and/or dt_restart and the new restart time is calculated. Have a look at Initialization and restart runs for further information. |
PA0165 | re-open of unit 14 is not verified. Please check results! | The file with unit number 14 contains the binaries BINOUT. It was opened at least a second time by user specific settings. This is not verified, so check the results carefully. |
PA0166 | re-opening of file-id ... is not allowed | |
PA0167 | opening file-id ... not allowed for PE ... | |
PA0168 | opening file-id ... is not allowed since it is used otherwise | |
PA0169 | error number free to use | |
PA0170 | error number free to use | |
PA0171 | netCDF: netCDF4 format requested but no cpp-directive __netcdf4 given switch back to 64-bit offset 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 (%copts) and load (%lopts) options of the configuration file appropriately. |
PA0172 | no OPEN-statement for file-id ... | |
PA0173 | wrong component: ... | |
PA0174 | wrong argument expected: ... given: | Internal code error. Please inform the PALM developers. |
PA0175 | no time measurement defined on this host | |
PA0176 | negative time interval occured PE ... L=PAUSE "..." new=... last=... | |
PA0177 | negative time interval occured PE ... L=STOP "..." new=... last=... isum=... | |
PA0178 | negative time interval occured PE ... L=STOP "..." sum=... mtime=... | |
PA0179 | unknown modus of time measurement: ... | |
PA0180 | unknown cross-section: ... | |
PA0181 | no output provided for: ... | |
PA0182 | if humidity/passive_scalar = FALSE output of ... is not provided | |
PA0183 | if cloud_physics = FALSE output of ... is not provided | Theres |
PA0184 | if cloud_physics = FALSE output of ... is not provided | Theres |
PA0185 | data_output_profiles: normalizing cross ... is not possible since one of the normalizing factors is zero! cross_normx_factor(...,...) = ... cross_normy_factor(...,...) = ... | |
PA0186 | no spectra data available | |
PA0187 | fft method "..." currently does not work on NEC | Siggi |
PA0188 | no system-specific fft-call available | Siggi |
PA0189 | fft method "..." not available | Siggi |
PA0190 | flow_statistics is called two times within one timestep | |
PA0191 | unknown action(s): ... | |
PA0192 | timestep has exceeded the lower limit dt_1d = ... s simulation stopped! | |
PA0193 | unknown initializing problem | |
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 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 modules.f90 according to your needs. |
PA0195 | dvrp_username is undefined | |
PA0196 | dvrp_output="..." not allowed | |
PA0197 | dvrp_file="..." not allowed | |
PA0198 | mode_dvrp="..." not allowed | |
PA0199 | split of communicator not realized with MPI1 coupling atmosphere-ocean' | |
PA0200 | missing dz | |
PA0201 | dz=... <= 0.0 | |
PA0202 | grid anisotropy exceeds threshold given by only local horizontal reduction of near_wall mixing length l_wall starting from height level k = ... . | |
PA0203 | inconsistent building parameters: bxl=... bxr=... bys=... byn=... nx=... ny=... | |
PA0204 | no street canyon width given | |
PA0205 | inconsistent canyon parameters: cxl=... cxr=... cwx=... ch=... nx=... ny=... | |
PA0206 | inconsistent canyon parameters:... cys=... cyn=... cwy=... ch=... nx=... ny=... | |
PA0207 | inconsistent canyon parameters: street canyon can only be oriented either in x- or in y-direction | |
PA0208 | file TOPOGRAPHY_DATA does not exist | |
PA0209 | errors in file TOPOGRAPHY_DATA | Possible reasons for this error include: 1. File contains a header. Solution: The header of the ESRI Ascii Grid format (usually 6 lines) must be removed. 2. File does not contain enough data. a) The number of columns (ncols) is less than nx+1. b) The number of rows (nrows) is less than ny+1. Solution: Make sure that ncols matches nx+1 and that nrows matches ny+1. |
PA0210 | nzb_local values are outside the model domain MINVAL( nzb_local ) = ... MAXVAL( nzb_local ) = ... | |
PA0211 | nzb_local does not fulfill cyclic boundary condition in x-direction | |
PA0212 | nzb_local does not fulfill cyclic boundary condition in y-direction | |
PA0213 | max_number_of_particle_groups =... number_of_particle_groups reset to ... | |
PA0214 | version mismatch concerning data from prior run version on file = ... version in program = ... | |
PA0215 | particle group !# ... has a density ratio /= 0 but radius = 0 | |
PA0216 | number of initial particles (...) exceeds maximum_number_of_particles (...) on PE ... | More particles are initialized than allowed by maximum_number_of_particles. Adjust pdx, pdy, and pdz to reduce the number of particles. Not available from release 4.0 on. |
PA0217 | unknown boundary condition bc_par_b = "..." | |
PA0218 | unknown boundary condition bc_par_t = "..." | |
PA0219 | unknown boundary condition bc_par_lr = "..." | |
PA0219 | unknown boundary condition bc_par_ns = "..." | |
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 npex and npey, the product npey*npex has to match exactly the total number of processors which is assigned by the mrun-option -X. |
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 npex or npey is set in the &d3par-Namelist, the remaining, so far not assigned, number of processors has to be set, too. |
PA0223 | error number free to use | |
PA0224 | no matching grid for transpositions found | |
PA0225 | x-direction: gridpoint number (...) is not an integral divisor of the number of processors (...) | The division of the number of grid points along the x-direction given by nx+1 by the number of processors along the x-direction has a rest and is therefore not an integral divisor 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 npex) or by changing nx. It might also be the case that you did not think about that nx+1 is the total number of gridpoints along the x-direction instead of nx. |
PA0226 | x-direction: nx does not match the requirements given by the number of PEs used please use nx = ... instead of nx =... | |
PA0227 | y-direction: gridpoint number (...) is not an integral divisor of the number of processors (...) | The division of the number of grid points along the y-direction given by ny+1 by the number of processors along the y-direction has a rest and is therefore not an integral divisor 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 npey) or by changing ny. It might also be the case that you did not think about that ny+1 is the total number of gridpoints along the y-direction instead of ny. |
PA0228 | y-direction: ny does not match the requirements given by the number of PEs used please use ny = ... instead of ny =... | |
PA0229 | error number free to use | |
PA0230 | transposition z --> x: nz=... is not an integral divisor of pdims(1)= ... | Due to restrictions in data transposition, the division of nz by the number of processors in x-direction has to be without rest. Please ensure this by changing nz or setting the number of gridpoints in x-direction (pdims(1)) manually by npex. |
PA0231 | transposition x --> y: nx+1=... is not an integral divisor of pdims(2)= ... | Due to restrictions in data transposition, the division of nx+1 by the number of processors in y-direction has to be without rest. Please ensure this by changing nx or setting the number of gridpoints in y-direction (pdims(2)) manually by npex. |
PA0232 | transposition y --> z: ny+1=... is not an integral divisor of pdims(1)=... | Due to restrictions in data transposition, the division of ny+1 by the number of processors in x-direction has to be without rest. Please ensure this by changing ny or setting the number of gridpoints in x-direction (pdims(1)) manually by npex. |
PA0233 | transposition x --> y: ny+1=... is not an integral divisor of pdims(1)=... | Due to restrictions in data transposition, the division of ny+1 by the number of processors in x-direction has to be without rest. Please ensure this by changing ny or setting the number of gridpoints in x-direction (pdims(1)) manually by npex. |
PA0234 | direct transposition z --> y (needed for spectra): nz=... is not an integral divisor of pdims(2)=... | |
PA0235 | mg_switch_to_pe0_level out of range and reset to default (=0) | |
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: nx = 60, ny = 60, nz = 60, npex = 4, 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 nx , ny or nz or adjust the number of processors by modifying the parameters npex or 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 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 | multigrid gather/scatter impossible in non parallel mode | Siggi |
PA0238 | more than 10 multigrid levels | Siggi |
PA0239 | The value for "topography_grid_convention" is not set. Its default value is only valid for "topography" = "single_building", "single_street_canyon" or "read_from_file" Choose "cell_edge" or "cell_center". | |
PA0240 | The value for "topography_grid_convention" is not recognized. Choose "cell_edge" or "cell_center". | |
PA0241 | netcdf_precision must contain a "_" netcdf_precision(...)="..." | |
PA0242 | illegal netcdf precision: netcdf_precision( ...)="..." | |
PA0243 | unknown variable in inipar assignment: netcdf_precision(...)="..." | |
PA0244 | no grid defined for variable ... | |
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. | |
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 47stead. | |
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. | |
PA0248 | netCDF file for volume data ... from previous run found. This file will be extended. | |
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. | |
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. | |
PA0251 | netCDF file for cross-sections ... from previuos run found but this file cannot be extended due to mismatch in cross section levels. New file is created instead. | |
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. | |
PA0253 | netCDF file for cross-sections ... from previous run found. This file will be extended. | |
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. | |
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. | |
PA0256 | netCDF file for vertical profiles from previous run found. This file will be extended. | |
PA0257 | netCDF file for vertical profiles from previous run found. This file will be extended. | |
PA0258 | netCDF file for 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. | |
PA0259 | netCDF file for time series from previous run found. This file will be extended. | |
PA0260 | netCDF file for spectra from previuos run found, but this file cannot be extended due to variable mismatch. New file is created instead. | |
PA0261 | netCDF file for spectra from previuos run found, but this file cannot be extended due to mismatch in number of vertical levels. New file is created instead. | |
PA0262 | netCDF file for spectra from previuos run found, but this file cannot be extended due to mismatch in heights of vertical levels. New file is created instead. | |
PA0263 | netCDF file for spectra from previuos 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. | |
PA0264 | netCDF file for spectra from previous run found. This file will be extended. | |
PA0265 | netCDF file for particles from previuos 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. | |
PA0266 | netCDF file for particles from previous run found. This file will be extended. | |
PA0267 | netCDF file for particle time series from previuos run found, but this file cannot be extended due to variable mismatch. New file is created instead. | |
PA0268 | netCDF file for particle time series from previuos 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. | |
PA0269 | netCDF file for particle time series from previous run found. This file will be extended. | |
PA0270 | mode "..." not supported | |
PA0271 | errors in $inipar or $inipar-namelist found (CRAY-machines only) | One possible explanation: An old, meanwhile modified variable has been used in $inipar (e.g. ws_vertical_gradient (old) instead of subs_vertical_gradient (new)) |
PA0272 | no $inipar-namelist found | Your parameter file must contain an &inipar-namelist. Parameters given in this namelist are required for model steering. Please take a look at this example parameter file and appropriately correct your parameter file. |
PA0273 | no value or wrong value given for nx: nx=... | See parameter nx for allowed values, and check the &inipar-namelist in your parameter file. |
PA0274 | no value or wrong value given for ny: ny=... | See parameter ny for allowed values, and check the &inipar-namelist in your parameter file. |
PA0275 | no value or wrong value given for nz: nz=... | See parameter nz for allowed values, and check the &inipar-namelist in your parameter file. |
PA0276 | local file ENVPAR not found, some variables for steering may not be properly set | |
PA0277 | errors in local file ENVPAR some variables for steering may not be properly set | |
PA0278 | no envpar-NAMELIST found in local file ENVPAR some variables for steering may not be properly set | |
PA0279 | wrong component: ... | |
PA0280 | Number of OpenMP threads = ... | |
PA0281 | running optimized multinode version switch_per_lpar = ... tasks_per_lpar = ... tasks_per_logical_node = ... | |
PA0282 | parallel environment (MPI) required | |
PA0283 | no sufficient convergence within 1000 cycles | Siggi |
PA0284 | data from subdomain of previous run mapped more than 1000 times | |
PA0285 | number of PEs or virtual PE-grid changed in restart run PE ... will read from files ... | |
PA0286 | version mismatch concerning data from prior run version on file = "..." version in program = "..." | |
PA0287 | problem with index bound nxl on restart file "..." nxl = ... but it should be = ... from the index bound information array | |
PA0288 | problem with index bound nxr on restart file "..." nxr = ... but it should be = ... from the index bound information array | |
PA0289 | problem with index bound nys on restart file "..." nys = ... but it should be = ... from the index bound information array | |
PA0290 | problem with index bound nyn on restart file "..." nyn = ... but it should be = ... from the index bound information array | |
PA0201 | mismatch between actual data and data from prior run on PE ... nzb on file = ... nzb = ... | |
PA0292 | mismatch between actual data and data from prior run on PE ... nzt on file = ... nzt = ... | |
PA0293 | read_3d_binary: spectrum_x on restart file ignored because total numbers of grid points (nx) do not match | |
PA0294 | read_3d_binary: spectrum_y on restart file ignored because total numbers of grid points (ny) do not match | |
PA0295 | unknown field named "..." found in data from prior run on PE ... | |
PA0296 | version mismatch concerning control variables version on file = "..." version on program = "..." | |
PA0297 | numprocs not found in data from prior run on PE ... | |
PA0298 | hor_index_bounds not found in data from prior run on PE ... | |
PA0299 | nz not found in data from prior run on PE ... | |
PA0300 | max_pr_user not found in data from prior run on PE ... | |
PA0301 | statistic_regions not found in data from prior run on PE ... | |
PA0302 | unknown variable named "..." found in data from prior run on PE ... | |
PA0303 | nz not found in restart data file | |
PA0304 | mismatch concerning number of gridpoints along z nz on file = "..." nz from run = "..." | |
PA0305 | max_pr_user not found in restart data file | |
PA0306 | number of user profiles on restart data file differs from the current run max_pr_user on file = "..." max_pr_user from run = "..." | |
PA0307 | statistic_regions not found in restart data file | |
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! | |
PA0309 | inflow profiles not temporally averaged. Averaging will be done now using ... samples. | |
PA0310 | remote model "..." terminated with terminate_coupled_remote = ... local model "..." has terminate_coupled = ... | The remote model in a coupled run has been terminated. The reason for the termination is provided by terminate_coupled. Termination reasons: 1 model was terminated (unknown reason) 2 time step has reached minimum limit (see PA0312) 3 run will be terminated because it is running out of job cpu limit remaining time (see PA0163) 4 run will be terminated due to user settings of dt_restart (see PA0164) 5 run will be terminated due to user settings of restart_time (see PA0164) 6 unscheduled termination was forced by the user (see PA0398) |
PA0311 | number of gridpoints along x or/and y contain illegal factors only factors 8,6,5,4,3,2 are allowed | In case that fft_method='temperton-algorithm', the number of horizontal grid points (nx+1, 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 fft_method. |
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 dt_max. 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 dt_max in the NAMELIST file. Moreover, this error message may indicate for unrealistic settings of e.g. boundary conditions or other NAMELIST parameters. For very small vertical grid spacing dz this error might also occur if roughness_length >= 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. |
PA0313 | illegal value for parameter particle_color: ... | Farah |
PA0314 | illegal value for parameter particle_dvrpsize: ... | Farah |
PA0315 | color_interval(2) <= color_interval(1) | |
PA0316 | dvrpsize_interval(2) <= dvrpsize_interval(1) | |
PA0317 | ocean = .F. does not allow coupling_char = ... set by mrun-option "-y" | The mrun option "-y" must not be used for atmosphere runs. The option is only required for ocean precursor runs, which are followed by atmosphere-ocean coupled restart runs. |
PA0318 | inflow_damping_height must be explicitly specified because the inversion height calculated by the prerun is zero | |
PA0319 | section_xy must be <= nz + 1 = ... | |
PA0320 | section_xz must be <= ny + 1 = ... | |
PA0321 | section_yz must be <= nx + 1 = ... | |
PA0322 | output of q*w*(0) requires humidity=.TRUE. | Farah |
PA0323 | output of averaged quantity "..." requires to set a non-zero averaging interval | Farah |
PA0324 | Applying large scale vertical motion is not allowed for ocean runs | The large scale subsidence is only reasonable and implemented for atmospheric runs. The setting of subs_vertical_gradient and subs_vertical_gradient_level is not possible. |
PA0325 | illegal value: masks must be >= 0 and <= "..."(=max_masks) | Björn |
PA0326 | illegal value: mask_scale_x, mask_scale_y and mask_scale_z must be > 0.0 | |
PA0327 | no output available for: "..." | |
PA0328 | netCDF file formats 3 (netCDF 4) and 4 (netCDF 4 Classic model) are currently not supported (not yet tested). | |
PA0329 | number of output quantitities given by data_output_mask and data_output_mask_user exceeds the limit of 100 | |
PA0330 | illegal value for data_output: "..." | |
PA0331 | "..." in mask "..." along dimension "..." exceeds "..." = "..." | Björn |
PA0332 | mask_loop("...","...",1)="..." and/or mask_loop("...","...",2)="..." exceed "..."*"..."/="..." | Björn |
PA0333 | mask_loop("...","...",1)="..." and/or mask_loop("...","...",2)="..." exceed zw(nz)/mask_scale("...")="..." | |
PA0334 | mask_loop("...","...",2)="..." exceeds dz_stretch_level="...". Vertical mask locations will not match the desired heights within the stretching region. Recommendation: use mask instead of mask_loop. | Björn |
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. | |
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. | |
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. | |
PA0338 | netCDF file for "..." data for mask "..." from previous run found. This file will be extended. | |
PA0339 | coupling mode "...: nx+1 in ocean is not divisible without remainder with nx+1 in atmosphere | For the coupling between 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 in the x-direction then the atmosphere. In this case, the information must be interpolated for the data exchange between atmosphere and ocean. Therefor it must be ensured that each interpolation interval has the same number of gridpoints. This is ensured if the following equation is fulfilled: with
as the number of grid points in the x-direction for the ocean and atmosphere model, respectively. |
PA0340 | coupling mode "...: ny+1 in ocean is not divisible without remainder with ny+1 in atmosphere | For the coupling between 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 in the y-direction then the atmosphere. In this case, the information must be interpolated for the data exchange between atmosphere and ocean. Therefor it must be ensured that each interpolation interval has the same number of gridpoints. This is ensured if the following equation is fulfilled: with
as the number of grid points in the y-direction for the ocean and atmosphere model, respectively. |
PA0343 | initializing_actions = 'initialize_vortex' ist not allowed with conserve_volume_flow = .T. | |
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. |
PA0345 | uv_heights(1) must be 0.0 | |
PA0346 | u_profile(1) and v_profile(1) must be 0.0 | |
PA0347 | maxtry > 40 in Rosenbrock method | Error may appear if curvature and solution effects are included in the calculation of droplet growth by condensation (see curvature_solution effects. It means that the Rosenbrock method, used for integrating the stiff droplet growth equation, was unable to find an internal timestep which gives a sufficiently small truncation error within 40 tries. So far, this problem has not appeared. It might happen if some of the cloud physics parameters, which determine the growth by condensation, are given unrealistic values or if the droplet radius is extremely small. |
PA0348 | zero stepsize in Rosenbrock method | Error may appear if curvature and solution effects are included in the calculation of droplet growth by condensation (see curvature_solution effects. It means that within the Rosenbrock method, used for integrating the stiff droplet growth equation, the internal timestep has become zero, so that the integration cannot be performed. So far, this problem has not appeared. It might happen if some of the cloud physics parameters, which determine the growth by condensation, are given unrealistic values or if the droplet radius is extremely small. |
PA0349 | use_sgs_for_particles = .TRUE. not allowed with curvature_solution_effects = .TRUE. | When Lagrangian particles are used as cloud droplets, they are only allowed to be transported with the resolved-scale flow. The application of the stochastic subgrid-scale transport model is limited to passively advected particles. Since cloud droplets have inertia, a transport with the SGS model would give wrong results. |
PA0350 | unknown collision kernel: collision_kernel = "..." | see package parameter collision_kernel for allowed values |
PA0351 | heatflux must not be set for pure neutral flow | Inipar parameter neutral = .TRUE. has been set, but non-zero values for parameters surface_heatflux and / or 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 | error number free to use | |
PA0353 | error number free to use | |
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. | 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 | error number free to use | |
PA0356 | error number free to use | |
PA0357 | unknown cloud microphysics scheme cloud_scheme = "..." | Unknown cloud microphysics scheme. Allowed cloud microphysics schemes are "kessler" or "seifert_beheng". |
PA0358 | data_output_pr = '...' is not implemented for cloud_scheme /= seifert_beheng | Output of profiles of rain drop number concentration (nr), rain water content (qr) or precipitation rate (prr) is only allowed for cloud_scheme = "seifert_beheng". |
PA0359 | output of "..." requires cloud_scheme = seifert_beheng | Output of 3d-data or cross-sections of rain drop number concentration (nr), rain water content (qr) or precipitation rate (prr) is only allowed for cloud_scheme = "seifert_beheng". |
PA0360 | plant_canopy = .TRUE. requires cloud_scheme /= seifert_beheng | It is not allowed to use plant_canopy with the cloud_scheme = "seifert_beheng". |
PA0361 | data_output_pr = prr is not implemented for precipitation = .FALSE. | Output of precipitation rate (prr) 3d-data or cross-sections requires precipitation = .TRUE. |
PA0362 | cloud_scheme = seifert_beheng requires loop_optimization = "cache" or "vector" | Currently, the cloud microphysics scheme according to Seifert and Beheng (2006) is only available for loop_optimization = "cache" or "vector" |
PA0363 | error number free to use | |
PA0364 | zu(nzt+1) = ... m is higher than the maximum height in NUDING_DATA which is ...m. Interpolation on PALM grid is not possible. | NUDGING_DATA has a maximum vertical height that is smaller than the vertical extent of the grid used in PALM. Hence, interpolation of the NUDING_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. |
PA0365 | file NUDGING_DATA does not exist | Make sure that the file basename_nudge containing the nudging profiles as described in NUDGING_DATA is provided in the INPUT folder of the respective run on the host where the job is running. |
PA0366 | errors in file NUDGING_DATA | PALM has problems reading the file basename_nudge. Possible reasons could be that the format described in NUDGING_DATA is not followed closely. |
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 | 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 LSF_DATA is provided in the INPUT folder of the respective run on the host where the job is running. |
PA0369 | errors in file LSF_DATA | PALM has problems reading the file basename_lsf. Possible reasons could be that the format described in LSF_DATA is not followed closely. |
PA0370 | 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 LSF_DATA and aborts. Possible reasons could be that no time dependent surface variables are provided in the large scale forcing file. |
PA0371 | No time dependent surface variables in LSF_DATA for end of run found - lsf_surf is set to FALSE | This messages appears in the case that the first time step of the surface values read in from LSF_DATA is larger than the end time of the simulation. In this case the surface heat and water fluxes prescribed in LSF_DATA cannot be used. |
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 LSF_DATA and aborts. Possible reasons could be that no time dependent profile data is provided in the large scale forcing file. |
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 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 LSF_DATA cannot be used. |
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 large_scale_forcing = .T., too. The surface values and profiles needed in LSF_DATA should correspond to the data provided in NUDGING_DATA. |
PA0375 | Non-cyclic lateral boundaries do not allow for the usage of large scale forcing from external file. | Large scale forcing (and also nudging) are not implemented/tested for non-cyclic boundary conditions so far. |
PA0376 | The usage of large scale forcing from external file LSF_DATA requires humidity = .T.. | If you want to use large scale forcing (and also nudging) from an external file, you need to run PALM with humidity. |
PA0377 | The usage of large scale forcing from external file LSF_DATA is not implemented for non-flat topography | Please use topography = 'flat'. |
PA0378 | The usage of large scale forcing from external file LSF_DATA is not implemented for ocean runs | Please use ocean = .F.. |
PA0379 | unknown location ... | |
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 large_scale_subsidence = .T. but without large_scale_forcing a profile for the subsidence velocity w_subs has to be prescribed. |
PA0381 | Enable usage of large scale subsidence by setting large_scale_subsidence = .T.. | In the p3d-file, subs_vertical_gradient_level is set but large_scale_subsidence = .F.. In case large scale subsidence shall be used enable it via large_scale_subsidence = .T.. |
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 large_scale_forcing = .T.. |
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 netcdf_data_format to five or six for getting parallel output, netcdf_data_format is set internally to three or four for masked data. |
PA0384 | Output of xy cross-sections is not given at t='...' because the maximum number of output time levels is exceeded. | 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:
The parameters end_time, skip_time_do2d_xy and 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. |
PA0385 | Output of xz cross-sections is not given at t='...' because the maximum number of output time levels is exceeded. | 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:
The parameters end_time, skip_time_do2d_xz and 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. |
PA0386 | Output of yz cross-sections is not given at t='...' because the maximum number of output time levels is exceeded. | 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:
The parameters end_time, skip_time_do2d_yz and 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. |
PA0387 | Output of 3d data is not given at t='...' because the maximum number of output time levels is exceeded. | 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:
The parameters end_time, skip_time_do3d and 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. |
PA0388 | 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.' | 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: The parameters end_time, skip_time_do3d and 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. |
PA0389 | 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.' | 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: The parameters end_time, skip_time_do2d_xy and 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 modifing on of the parameters above, a new output file is created. |
PA0390 | 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.' | 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: The parameters end_time, skip_time_do2d_xz and 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. |
PA0391 | 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.' | 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: The parameters end_time, skip_time_do2d_yz and 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 | Particle tails are currently not available due to the new particle structure. | It is currently not allowed to use use_particle_tails = .TRUE., since the new particle structure (from release 4.0) does not allow particle tails. |
PA0393 | data_output_pr = ... is not implemented for large_scale_forcing = .FALSE. | The listed entries in the parameter file under data_output_pr are only avialable for large_scale_forcing = .T.. There could also be a typo in data_output_pr (an output variable was used that does not exist in PALM). |
PA0394 | data_output_pr = ... is not implemented for nudging = .FALSE. | The listed entries in the parameter file under data_output_pr are only avialable for nudging = .T.. There could also be a typo in data_output_pr (an output variable was used that does not exist in PALM). |
PA0395 | zu(nzt+1) = ... m is higher than the maximum height in LSF_DATA which is ...m. Interpolation on PALM grid is not possible. | LSF_DATA has a maximum vertical height that is smaller than the vertical extent of the grid used in PALM. Hence, interpolation of the LSF_DATA onto the PALM grid is not possible. Reduce either the vertical extent of the PALM modeling domain or enlarge the LSF_DATA file correspondingly. |
PA0396 | The usage of use_subsidence_tendencies requires large_scale_subsidence = .T.. | If use_subsidence_tendencies is used, subsidence tendencies for temperature and humidity are read in from the external file LSF_DATA. However, these tendencies can only be applied to the prognostic variables if large_scale_subsidence = .T.. |
PA0397 | The usage of use_subsidence_tendencies requires large_scale_forcing = .T.. | If use_subsidence_tendencies is used, subsidence tendencies for temperature and humidity are read in from the external file LSF_DATA. This requires large_scale_forcing = .T.. |
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. |
UI0001 | unknown location "..." | The location has to be either 'time_int' or 'nudging'. |
UI0002 | location "..." is not allowed to be called with parameters "i" and "j" | |
UI0003 | no output possible for: ... | |
UI0004 | unknown mode "..." | |
UI0005 | topography "..." not available yet | |
UI0006 | unknown topography "..." | |
UI0007 | canopy_mode "..." not available yet | |
UI0008 | unknown canopy_mode "..." | |
UI0009 | the number of user-defined profiles given in data_output_pr (...) does not match the one found in the restart file (...) | |
UI0010 | Spectra of ... can not be calculated | |
UI0011 | Spectra of ... are not defined | |
UI0012 | unknown variable named "..." found in data from prior run on PE | |
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 | 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 data_output) or a variable name that has been defined in the user interface is already used by PALM. |
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. Please check if your string settings in the user-interface follow the above rules. |