source: palm/trunk/SOURCE/parin.f90 @ 2118

Last change on this file since 2118 was 2118, checked in by raasch, 7 years ago

all OpenACC directives and related parts removed from the code

  • Property svn:keywords set to Id
File size: 26.7 KB
RevLine 
[1682]1!> @file parin.f90
[2000]2!------------------------------------------------------------------------------!
[1036]3! This file is part of PALM.
4!
[2000]5! PALM is free software: you can redistribute it and/or modify it under the
6! terms of the GNU General Public License as published by the Free Software
7! Foundation, either version 3 of the License, or (at your option) any later
8! version.
[1036]9!
10! PALM is distributed in the hope that it will be useful, but WITHOUT ANY
11! WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR
12! A PARTICULAR PURPOSE.  See the GNU General Public License for more details.
13!
14! You should have received a copy of the GNU General Public License along with
15! PALM. If not, see <http://www.gnu.org/licenses/>.
16!
[2101]17! Copyright 1997-2017 Leibniz Universitaet Hannover
[2000]18!------------------------------------------------------------------------------!
[1036]19!
[257]20! Current revisions:
[1484]21! -----------------
[2118]22! -background_communication from inipar
[1956]23!
24! Former revisions:
25! -----------------
26! $Id: parin.f90 2118 2017-01-17 16:38:49Z raasch $
[1958]27!
[2051]28! 2050 2016-11-08 15:00:55Z gronemeier
29! Implement turbulent outflow condition
30!
[2038]31! 2037 2016-10-26 11:15:40Z knoop
32! Anelastic approximation implemented
33!
[2036]34! 2035 2016-10-24 15:06:17Z suehring
35! Remove check for npex and npey in nesting case
36!
[2012]37! 2011 2016-09-19 17:29:57Z kanani
38! Added flag lsf_exception to allow explicit enabling of large scale forcing
39! together with buildings on flat terrain.
40!
[2008]41! 2007 2016-08-24 15:47:17Z kanani
42! Added call to urban surface model for reading of &urban_surface_par
43!
[2005]44! 2004 2016-08-24 10:25:59Z suehring
45! Humidity and passive scalar treated separately in nesting mode
46!
[2001]47! 2000 2016-08-20 18:09:15Z knoop
48! Forced header and separation lines into 80 columns
49!
[1993]50! 1992 2016-08-12 15:14:59Z suehring
51! +top_scalarflux
52!
[1961]53! 1960 2016-07-12 16:34:24Z suehring
54! Allocation of s_init
55!
[1958]56! 1957 2016-07-07 10:43:48Z suehring
57! flight module added
58!
[1956]59! 1955 2016-07-01 12:38:59Z hellstea
[1955]60! The parameter intializating_actions is set to 'set_constant_profiles for
61! all nest domains in order to make sure that diagnostic variables are properly
62! initialized for nest domains. Prognostic variables are later initialized by
63! interpolation from the parent domain.
[1957]64!
[1933]65! 1917 2016-05-27 14:28:12Z witha
66! Initial version of purely vertical nesting introduced.
67!
[1917]68! 1914 2016-05-26 14:44:07Z witha
69! Added call to wind turbine model for reading of &wind_turbine_par
70!
[1851]71! 1849 2016-04-08 11:33:18Z hoffmann
72! Adapted for modularization of microphysics
[1852]73!
[1834]74! 1833 2016-04-07 14:23:03Z raasch
75! call of spectra_parin
76!
[1832]77! 1831 2016-04-07 13:15:51Z hoffmann
78! turbulence renamed collision_turbulence, drizzle renamed
79! cloud_water_sedimentation
80! curvature_solution_effects removed
81!
[1827]82! 1826 2016-04-07 12:01:39Z maronga
83! Added call to radiation model for reading of &radiation_par.
84! Added call to plant canopy model for reading of &canopy_par.
85!
[1818]86! 1817 2016-04-06 15:44:20Z maronga
[1826]87! Added call to land surface model for reading of &lsm_par
[1818]88!
[1805]89! 1804 2016-04-05 16:30:18Z maronga
90! Removed code for parameter file check (__check)
91!
[1784]92! 1783 2016-03-06 18:36:17Z raasch
93! +netcdf_deflate in d3par, netcdf module and variable names changed
94!
[1765]95! 1764 2016-02-28 12:45:19Z raasch
[1764]96! cpp-statements for nesting removed, explicit settings of boundary conditions
97! in nest domains,
98! bugfix: npex/npey message moved from inipar to d3par
99! bugfix: check of lateral boundary conditions from check_parameters to here,
100! because they will be already used in init_pegrid and init_grid
[1321]101!
[1763]102! 1762 2016-02-25 12:31:13Z hellstea
103! Introduction of nested domain feature
104!
[1692]105! 1691 2015-10-26 16:17:44Z maronga
106! Added parameter most_method. Renamed prandtl_layer to constant_flux_layer.
107!
[1683]108! 1682 2015-10-07 23:56:08Z knoop
109! Code annotations made doxygen readable
110!
[1561]111! 1560 2015-03-06 10:48:54Z keck
112! +recycling_yshift
113!
[1497]114! 1496 2014-12-02 17:25:50Z maronga
115! Renamed: "radiation -> "cloud_top_radiation"
116!
[1485]117! 1484 2014-10-21 10:53:05Z kanani
118! Changes due to new module structure of the plant canopy model:
119!   canopy-model related parameters moved to new package canopy_par in
120!   subroutine package_parin
121!
[1430]122! 1429 2014-07-15 12:53:45Z knoop
123! +ensemble_member_nr to prepare the random_generator for ensemble runs
124!
[1403]125! 1402 2014-05-09 14:25:13Z raasch
126! location messages modified, batch_job included in envpar-NAMELIST
127!
[1385]128! 1384 2014-05-02 14:31:06Z raasch
129! location messages added
130!
[1366]131! 1365 2014-04-22 15:03:56Z boeske
132! Usage of large scale forcing enabled:
133! +use_subsidence_tendencies
134!
[1362]135! 1361 2014-04-16 15:17:48Z hoffmann
136! +call_microphysics_at_all_substeps
137!
[1360]138! 1359 2014-04-11 17:15:14Z hoffmann
139! REAL constants provided with KIND-attribute
140!
[1354]141! 1353 2014-04-08 15:21:23Z heinze
142! REAL constants provided with KIND-attribute
143!
[1329]144! 1327 2014-03-21 11:00:16Z raasch
145! -data_output_format, do3d_compress, do3d_comp_prec
146!
[1321]147! 1320 2014-03-20 08:40:49Z raasch
[1320]148! ONLY-attribute added to USE-statements,
149! kind-parameters added to all INTEGER and REAL declaration statements,
150! kinds are defined in new module kinds,
151! old module precision_kind is removed,
152! revision history before 2012 removed,
153! comment fields (!:) to be used for variable explanations added to
154! all variable declaration statements
[1054]155!
[1319]156! 1318 2014-03-17 13:35:16Z raasch
157! +cpu_log_barrierwait in d3par
158!
[1302]159! 1301 2014-03-06 13:29:46Z heinze
160! +large_scale_subsidence
161!
[1242]162! 1241 2013-10-30 11:36:58Z heinze
163! +nudging
164! +large_scale_forcing
165!
[1217]166! 1216 2013-08-26 09:31:42Z raasch
167! +transpose_compute_overlap in inipar
168!
[1196]169! 1195 2013-07-01 12:27:57Z heinze
170! Bugfix: allocate ref_state
171!
[1182]172! 1179 2013-06-14 05:57:58Z raasch
173! +reference_state in inipar
174!
[1160]175! 1159 2013-05-21 11:58:22Z fricke
176! +use_cmax
177!
[1132]178! 1128 2013-04-12 06:19:32Z raasch
179! +background_communication in inipar
180!
[1116]181! 1115 2013-03-26 18:16:16Z hoffmann
182! unused variables removed
183!
[1093]184! 1092 2013-02-02 11:24:22Z raasch
185! unused variables removed
186!
[1066]187! 1065 2012-11-22 17:42:36Z hoffmann
188! +nc, c_sedimentation, limiter_sedimentation, turbulence
189! -mu_constant, mu_constant_value
190!
[1054]191! 1053 2012-11-13 17:11:03Z hoffmann
[1053]192! necessary expansions according to the two new prognostic equations (nr, qr)
193! of the two-moment cloud physics scheme and steering parameters:
194! +*_init, *_surface, *_surface_initial_change, *_vertical_gradient,
195! +*_vertical_gradient_level, surface_waterflux_*,
196! +cloud_scheme, drizzle, mu_constant, mu_constant_value, ventilation_effect
[601]197!
[1037]198! 1036 2012-10-22 13:43:42Z raasch
199! code put under GPL (PALM 3.9)
200!
[1017]201! 1015 2012-09-27 09:23:24Z raasch
202! -adjust_mixing_length
203!
[1004]204! 1003 2012-09-14 14:35:53Z raasch
205! -grid_matching
206!
[1002]207! 1001 2012-09-13 14:08:46Z raasch
208! -cut_spline_overshoot, long_filter_factor, overshoot_limit_*, ups_limit_*
209!
[997]210! 996 2012-09-07 10:41:47Z raasch
211! -use_prior_plot1d_parameters
212!
[979]213! 978 2012-08-09 08:28:32Z fricke
214! -km_damp_max, outflow_damping_width
215! +pt_damping_factor, pt_damping_width
216! +z0h_factor
217!
[965]218! 964 2012-07-26 09:14:24Z raasch
219! -cross_normalized_x, cross_normalized_y, cross_xtext, z_max_do1d,
220! z_max_do1d_normalized
221!
[941]222! 940 2012-07-09 14:31:00Z raasch
223! +neutral in inipar
224!
[928]225! 927 2012-06-06 19:15:04Z raasch
226! +masking_method in inipar
227!
[826]228! 824 2012-02-17 09:09:57Z raasch
229! +curvature_solution_effects in inipar
230!
[810]231! 809 2012-01-30 13:32:58Z maronga
232! Bugfix: replaced .AND. and .NOT. with && and ! in the preprocessor directives
233!
[808]234! 807 2012-01-25 11:53:51Z maronga
235! New cpp directive "__check" implemented which is used by check_namelist_files
236!
[1]237! Revision 1.1  1997/07/24 11:22:50  raasch
238! Initial revision
239!
240!
241! Description:
242! ------------
[1682]243!> This subroutine reads variables controling the run from the NAMELIST files
[1]244!------------------------------------------------------------------------------!
[1682]245 SUBROUTINE parin
246 
[1]247
[1320]248    USE arrays_3d,                                                             &
[1960]249        ONLY:  pt_init, q_init, ref_state, s_init, sa_init, ug, u_init, v_init,&
[1320]250               vg
251
[1826]252    USE plant_canopy_model_mod,                                                &
253         ONLY: pcm_parin 
[1320]254
[1762]255    USE control_parameters
[1320]256
257    USE cpulog,                                                                &
258        ONLY:  cpu_log_barrierwait
259
260    USE dvrp_variables,                                                        &
261        ONLY:  local_dvrserver_running
262
[1957]263    USE flight_mod,                                                            &
264        ONLY:  flight_parin
265
[1320]266    USE grid_variables,                                                        &
267        ONLY:  dx, dy
268
269    USE indices,                                                               &
270        ONLY:  nx, ny, nz
271
[1764]272    USE kinds
273
[1817]274    USE land_surface_model_mod,                                                &
275        ONLY: lsm_parin
[1849]276
277    USE microphysics_mod,                                                      &
278        ONLY:  c_sedimentation, cloud_water_sedimentation,                     &
279               collision_turbulence, limiter_sedimentation, nc_const,          &
280               ventilation_effect
281
[1320]282    USE model_1d,                                                              &
283        ONLY:  damp_level_1d, dt_pr_1d, dt_run_control_1d, end_time_1d
284
[1]285    USE pegrid
286
[1783]287    USE netcdf_interface,                                                      &
288        ONLY:  netcdf_data_format, netcdf_deflate, netcdf_precision
289
[1764]290    USE pmc_interface,                                                         &
[1933]291        ONLY:  nested_run, nesting_mode
[1764]292
[1320]293    USE profil_parameter,                                                      &
294        ONLY:  cross_profiles, cross_ts_uymax, cross_ts_uymin,                 &
295               profile_columns, profile_rows
296
[1402]297    USE progress_bar,                                                          &
298        ONLY :  batch_job
299
[1833]300    USE radiation_model_mod,                                                   &
301        ONLY: radiation_parin 
302
303    USE spectra_mod,                                                           &
304        ONLY :  spectra_parin
305
[1320]306    USE statistics,                                                            &
307        ONLY:  hom, hom_sum, pr_palm, region, statistic_regions
308
[2007]309    USE urban_surface_mod,                                                     &
310        ONLY: usm_parin
311
[1914]312    USE wind_turbine_model_mod,                                                &
313        ONLY:  wtm_parin
[1691]314
[1914]315
[1]316    IMPLICIT NONE
317
[1682]318    INTEGER(iwp) ::  i   !<
[1]319
320
[2118]321    NAMELIST /inipar/  alpha_surface, approximation, bc_e_b, bc_lr,            &
[1429]322                       bc_ns, bc_p_b, bc_p_t, bc_pt_b, bc_pt_t, bc_q_b,        &
323             bc_q_t,bc_s_b, bc_s_t, bc_sa_t, bc_uv_b, bc_uv_t,                 &
324             bottom_salinityflux, building_height, building_length_x,          &
325             building_length_y, building_wall_left, building_wall_south,       &
326             call_psolver_at_all_substeps, call_microphysics_at_all_substeps,  &
[1484]327             canyon_height,                                                    &
[1429]328             canyon_width_x, canyon_width_y, canyon_wall_left,                 &
329             canyon_wall_south, c_sedimentation, cfl_factor, cloud_droplets,   &
[1496]330             cloud_physics, cloud_scheme, cloud_top_radiation,                 &
[1831]331             cloud_water_sedimentation,                                        &
332             collective_wait, collision_turbulence, conserve_volume_flow,      &
[1691]333             conserve_volume_flow_mode, constant_flux_layer,                   &
334             coupling_start_time,                                              &
[1831]335             cycle_mg, damp_level_1d,                                          &
[1429]336             dissipation_1d,                                                   &
[1484]337             dp_external, dp_level_b, dp_smooth, dpdxy,                        &
[1831]338             dt, dt_pr_1d, dt_run_control_1d, dx, dy, dz, dz_max,              &
[1429]339             dz_stretch_factor, dz_stretch_level, end_time_1d,                 &
[2037]340             ensemble_member_nr, e_init, e_min, fft_method,                    &
341             flux_input_mode, flux_output_mode,                                &
342             galilei_transformation, humidity,                                 &
[1429]343             inflow_damping_height, inflow_damping_width,                      &
344             inflow_disturbance_begin, inflow_disturbance_end,                 &
[1484]345             initializing_actions, km_constant,                                &
[1429]346             large_scale_forcing, large_scale_subsidence,                      &
[1496]347             limiter_sedimentation,                                            &
[2011]348             loop_optimization, lsf_exception, masking_method, mg_cycles,      &
[1429]349             mg_switch_to_pe0_level, mixing_length_1d, momentum_advec,         &
[1691]350             most_method, nc_const, netcdf_precision, neutral, ngsrb,          &
[1429]351             nsor, nsor_ini, nudging, nx, ny, nz, ocean, omega, omega_sor,     &
[2050]352             outflow_source_plane, passive_scalar, phi,                        &
[1429]353             prandtl_number, precipitation, psolver, pt_damping_factor,        &
354             pt_damping_width, pt_reference, pt_surface,                       &
355             pt_surface_initial_change, pt_vertical_gradient,                  &
356             pt_vertical_gradient_level, q_surface, q_surface_initial_change,  &
357             q_vertical_gradient, q_vertical_gradient_level,                   &
[1496]358             random_generator, random_heatflux,                                &
[1560]359             rayleigh_damping_factor, rayleigh_damping_height,                 &
360             recycling_width, recycling_yshift,                                &
[1429]361             reference_state, residual_limit,                                  &
[1691]362             roughness_length, sa_surface,                                     &
[1429]363             sa_vertical_gradient, sa_vertical_gradient_level, scalar_advec,   &
[1484]364             scalar_rayleigh_damping,                                          &
[1429]365             statistic_regions, subs_vertical_gradient,                        &
[785]366             subs_vertical_gradient_level, surface_heatflux, surface_pressure, &
[1429]367             surface_scalarflux, surface_waterflux,                            &
368             s_surface, s_surface_initial_change, s_vertical_gradient,         &
369             s_vertical_gradient_level, timestep_scheme,                       &
370             topography, topography_grid_convention, top_heatflux,             &
371             top_momentumflux_u, top_momentumflux_v, top_salinityflux,         &
[1992]372             top_scalarflux, transpose_compute_overlap, turbulent_inflow,      &
[2050]373             turbulent_outflow,                                                &
[1429]374             use_subsidence_tendencies, ug_surface, ug_vertical_gradient,      &
375             ug_vertical_gradient_level, use_surface_fluxes, use_cmax,         &
376             use_top_fluxes, use_ug_for_galilei_tr, use_upstream_for_tke,      &
377             uv_heights, u_bulk, u_profile, vg_surface, vg_vertical_gradient,  &
378             vg_vertical_gradient_level, v_bulk, v_profile, ventilation_effect,&
379             wall_adjustment, wall_heatflux, wall_humidityflux,                &
[1691]380             wall_scalarflux, zeta_max, zeta_min, z0h_factor
[1053]381     
[1429]382    NAMELIST /d3par/  averaging_interval, averaging_interval_pr,               &
383             cpu_log_barrierwait, create_disturbances,                         &
384             cross_profiles, cross_ts_uymax, cross_ts_uymin,                   &
[1327]385             data_output, data_output_masks,                                   &
[600]386             data_output_pr, data_output_2d_on_each_pe, disturbance_amplitude, &
[1429]387             disturbance_energy_limit, disturbance_level_b,                    &
[1327]388             disturbance_level_t, do2d_at_begin, do3d_at_begin,                &
[1429]389             dt, dt_averaging_input, dt_averaging_input_pr,                    &
390             dt_coupling, dt_data_output, dt_data_output_av, dt_disturb,       &
391             dt_domask, dt_dopr, dt_dopr_listing, dt_dots, dt_do2d_xy,         &
392             dt_do2d_xz, dt_do2d_yz, dt_do3d, dt_max, dt_restart,              &
393             dt_run_control,end_time, force_print_header, mask_scale_x,        &
394             mask_scale_y, mask_scale_z, mask_x, mask_y, mask_z, mask_x_loop,  &
[1783]395             mask_y_loop, mask_z_loop, netcdf_data_format, netcdf_deflate,     &
396             normalizing_region, npex, npey, nz_do3d,                          &
397             precipitation_amount_interval, profile_columns, profile_rows,     &
398             restart_time, section_xy, section_xz, section_yz,                 &
399             skip_time_data_output, skip_time_data_output_av, skip_time_dopr,  &
400             skip_time_do2d_xy, skip_time_do2d_xz, skip_time_do2d_yz,          &
401             skip_time_do3d, skip_time_domask, synchronous_exchange,           &
402             termination_time_needed, z_max_do2d
[1]403
404
[1429]405    NAMELIST /envpar/  batch_job, host, local_dvrserver_running,               &
406                       maximum_cpu_time_allowed, maximum_parallel_io_streams,  &
407                       revision, return_addres, return_username,               &
[1402]408                       run_identifier, tasks_per_node, write_binary
[1]409
410!
[759]411!-- First read values of environment variables (this NAMELIST file is
412!-- generated by mrun)
[1402]413    CALL location_message( 'reading environment parameters from ENVPAR', .FALSE. )
[759]414    OPEN ( 90, FILE='ENVPAR', STATUS='OLD', FORM='FORMATTED', ERR=30 )
415    READ ( 90, envpar, ERR=31, END=32 )
416    CLOSE ( 90 )
[1402]417    CALL location_message( 'finished', .TRUE. )
[1]418
419!
[759]420!-- Calculate the number of groups into which parallel I/O is split.
421!-- The default for files which are opened by all PEs (or where each
422!-- PE opens his own independent file) is, that all PEs are doing input/output
423!-- in parallel at the same time. This might cause performance or even more
424!-- severe problems depending on the configuration of the underlying file
425!-- system.
426!-- First, set the default:
[1429]427    IF ( maximum_parallel_io_streams == -1  .OR.                               &
[759]428         maximum_parallel_io_streams > numprocs )  THEN
429       maximum_parallel_io_streams = numprocs
430    ENDIF
431!
432!-- Now calculate the number of io_blocks and the io_group to which the
433!-- respective PE belongs. I/O of the groups is done in serial, but in parallel
434!-- for all PEs belonging to the same group.
435!-- These settings are repeated in init_pegrid for the communicator comm2d,
436!-- which is not available here
437    io_blocks = numprocs / maximum_parallel_io_streams
438    io_group  = MOD( myid+1, io_blocks )
[1]439
[1402]440    CALL location_message( 'reading NAMELIST parameters from PARIN', .FALSE. )
[759]441!
442!-- Data is read in parallel by groups of PEs
443    DO  i = 0, io_blocks-1
444       IF ( i == io_group )  THEN
[559]445
[1]446!
[759]447!--       Open the NAMELIST-file which is send with this job
448          CALL check_open( 11 )
[559]449
[1]450!
[759]451!--       Read the control parameters for initialization.
[996]452!--       The namelist "inipar" must be provided in the NAMELIST-file.
453          READ ( 11, inipar, ERR=10, END=11 )
[807]454
[996]455          GOTO 12
[807]456
[1429]457 10       message_string = 'errors in \$inipar &or no \$inipar-namelist ' //   &
[759]458                           'found (CRAY-machines only)'
459          CALL message( 'parin', 'PA0271', 1, 2, 0, 6, 0 )
[146]460
[759]461 11       message_string = 'no \$inipar-namelist found'
462          CALL message( 'parin', 'PA0272', 1, 2, 0, 6, 0 )
463
[146]464!
[759]465!--       If required, read control parameters from restart file (produced by
466!--       a prior run). All PEs are reading from file created by PE0 (see
467!--       check_open)
468 12       IF ( TRIM( initializing_actions ) == 'read_restart_data' )  THEN
469             CALL read_var_list
470!
471!--          The restart file will be reopened when reading the subdomain data
472             CALL close_file( 13 )
[87]473
[1]474!
[759]475!--          Increment the run count
476             runnr = runnr + 1
477          ENDIF
478
[87]479!
[1933]480!--       In case of nested runs, explicitly set nesting boundary conditions.
481!--       This will overwrite the user settings. bc_lr and bc_ns always need
482!--       to be cyclic for vertical nesting.
483          IF ( nesting_mode == 'vertical' )  THEN
484             IF (bc_lr /= 'cyclic' .OR. bc_ns /= 'cyclic' )  THEN
485                WRITE ( message_string, *)  'bc_lr and bc_ns were set to ,',   &
486                                      'cyclic for vertical nesting'
487                CALL message( 'parin', 'PA0428', 0, 0, 0, 6, 0 )
488                bc_lr   = 'cyclic'
489                bc_ns   = 'cyclic'
490             ENDIF
491             IF ( nest_domain )  THEN
492                bc_uv_t = 'nested'
493                bc_pt_t = 'nested'
494                bc_q_t  = 'nested'
[2004]495                bc_s_t  = 'nested'
[1933]496                bc_p_t  = 'neumann'
497             ENDIF
498          ELSE
499         
500!
501!--       For other nesting modes only set boundary conditions for
502!--       nested domains.
503             IF ( nest_domain )  THEN
504                bc_lr   = 'nested'
505                bc_ns   = 'nested'
506                bc_uv_t = 'nested'
507                bc_pt_t = 'nested'
508                bc_q_t  = 'nested'
[2004]509                bc_s_t  = 'nested'
[1933]510                bc_p_t  = 'neumann'
511             ENDIF
[1764]512          ENDIF
[1955]513
514!         
515!--       In case of nested runs, make sure that initializing_actions =
516!--       'set_constant_profiles' even though the constant-profiles
517!--       initializations for the prognostic variables will be overwritten
518!--       by pmci_child_initialize and pmci_parent_initialize. This is,
519!--       however, important e.g. to make sure that diagnostic variables
520!--       are set properly.
521          IF ( nest_domain )  THEN
522             initializing_actions = 'set_constant_profiles'
523          ENDIF
524
[1957]525           
[1764]526!
527!--       Check validity of lateral boundary conditions. This has to be done
528!--       here because they are already used in init_pegrid and init_grid and
529!--       therefore cannot be check in check_parameters
530          IF ( bc_lr /= 'cyclic'  .AND.  bc_lr /= 'dirichlet/radiation'  .AND. &
531               bc_lr /= 'radiation/dirichlet'  .AND.  bc_lr /= 'nested' )  THEN
532             message_string = 'unknown boundary condition: bc_lr = "' // &
533                              TRIM( bc_lr ) // '"'
534             CALL message( 'check_parameters', 'PA0049', 1, 2, 0, 6, 0 )
535          ENDIF
536          IF ( bc_ns /= 'cyclic'  .AND.  bc_ns /= 'dirichlet/radiation'  .AND. &
537               bc_ns /= 'radiation/dirichlet'  .AND.  bc_ns /= 'nested' )  THEN
538             message_string = 'unknown boundary condition: bc_ns = "' // &
539                              TRIM( bc_ns ) // '"'
540             CALL message( 'check_parameters', 'PA0050', 1, 2, 0, 6, 0 )
541          ENDIF
542
543!
544!--       Set internal variables used for speed optimization in if clauses
545          IF ( bc_lr /= 'cyclic' )               bc_lr_cyc    = .FALSE.
546          IF ( bc_lr == 'dirichlet/radiation' )  bc_lr_dirrad = .TRUE.
547          IF ( bc_lr == 'radiation/dirichlet' )  bc_lr_raddir = .TRUE.
548          IF ( bc_ns /= 'cyclic' )               bc_ns_cyc    = .FALSE.
549          IF ( bc_ns == 'dirichlet/radiation' )  bc_ns_dirrad = .TRUE.
550          IF ( bc_ns == 'radiation/dirichlet' )  bc_ns_raddir = .TRUE.
551
552!
[759]553!--       Definition of names of areas used for computing statistics. They must
554!--       be defined at this place, because they are allowed to be redefined by
555!--       the user in user_parin.
556          region = 'total domain'
[87]557
558!
[759]559!--       Read runtime parameters given by the user for this run (namelist
560!--       "d3par"). The namelist "d3par" can be omitted. In that case, default
561!--       values are used for the parameters.
562          READ ( 11, d3par, END=20 )
[87]563
564!
[1826]565!--       Check if land surface model is used and read &lsm_par if required
[1817]566          CALL lsm_parin
[1833]567
[1817]568!
[2007]569!--       Check if urban surface model is used and read &urban_surface_par if required
570          CALL usm_parin
571
572!
[1833]573!--       Check if spectra shall be calculated and read spectra_par if required
574          CALL spectra_parin
575
576!
[1826]577!--       Check if radiation model is used and read &radiation_par if required
578          CALL radiation_parin
579 
580 
581!--       Check if plant canopy model is used and read &canopy_par if required
582          CALL pcm_parin
583 
584!
[759]585!--       Read control parameters for optionally used model software packages
586 20       CALL package_parin
[87]587
588!
[1914]589!--       Check if wind turbine model is used and read &wind_turbine_par if
590!--       required
591          CALL wtm_parin
[1957]592!
593!--       Check if virtual flights should be carried out and read &flight_part
594!--       if required
595          CALL flight_parin
[1914]596
597!
[759]598!--       Read user-defined variables
599          CALL user_parin
[87]600
[147]601!
[759]602!--       Check in case of initial run, if the grid point numbers are well
603!--       defined and allocate some arrays which are already needed in
604!--       init_pegrid or check_parameters. During restart jobs, these arrays
605!--       will be allocated in read_var_list. All other arrays are allocated
606!--       in init_3d_model.
607          IF ( TRIM( initializing_actions ) /= 'read_restart_data' )  THEN
[667]608
[759]609             IF ( nx <= 0 )  THEN
[1429]610                WRITE( message_string, * ) 'no value or wrong value given',    &
[759]611                                           ' for nx: nx=', nx
612                CALL message( 'parin', 'PA0273', 1, 2, 0, 6, 0 )
613             ENDIF
614             IF ( ny <= 0 )  THEN
[1429]615                WRITE( message_string, * ) 'no value or wrong value given',    &
[759]616                                           ' for ny: ny=', ny
617                CALL message( 'parin', 'PA0274', 1, 2, 0, 6, 0 )
618             ENDIF
619             IF ( nz <= 0 )  THEN
[1429]620                WRITE( message_string, * ) 'no value or wrong value given',    &
[759]621                                           ' for nz: nz=', nz
622                CALL message( 'parin', 'PA0275', 1, 2, 0, 6, 0 )
623             ENDIF
624!
625!--          ATTENTION: in case of changes to the following statement please
626!--                  also check the allocate statement in routine read_var_list
[1960]627             ALLOCATE( pt_init(0:nz+1), q_init(0:nz+1), s_init(0:nz+1),        &
[1429]628                       ref_state(0:nz+1), sa_init(0:nz+1), ug(0:nz+1),         &
629                       u_init(0:nz+1), v_init(0:nz+1), vg(0:nz+1),             &
630                       hom(0:nz+1,2,pr_palm+max_pr_user,0:statistic_regions),  &
[759]631                       hom_sum(0:nz+1,pr_palm+max_pr_user,0:statistic_regions) )
[1]632
[1353]633             hom = 0.0_wp
[1]634
[759]635          ENDIF
636
[1]637!
[759]638!--       NAMELIST-file is not needed anymore
639          CALL close_file( 11 )
[1]640
[759]641       ENDIF
[1804]642#if defined( __parallel )
[759]643       CALL MPI_BARRIER( MPI_COMM_WORLD, ierr )
644#endif
645    ENDDO
646
[1402]647    CALL location_message( 'finished', .TRUE. )
[1384]648
[1]649    RETURN
650
[1429]651 30 message_string = 'local file ENVPAR not found' //                          &
[257]652                     '&some variables for steering may not be properly set'
653    CALL message( 'parin', 'PA0276', 0, 1, 0, 6, 0 )
[1]654    RETURN
655
[1429]656 31 message_string = 'errors in local file ENVPAR' //                          &
[257]657                     '&some variables for steering may not be properly set'
658    CALL message( 'parin', 'PA0277', 0, 1, 0, 6, 0 )
[1]659    RETURN
660
[1429]661 32 message_string = 'no envpar-NAMELIST found in local file ENVPAR'  //       &
[257]662                     '&some variables for steering may not be properly set'
663    CALL message( 'parin', 'PA0278', 0, 1, 0, 6, 0 )
[1]664
665 END SUBROUTINE parin
Note: See TracBrowser for help on using the repository browser.