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

Last change on this file since 2011 was 2011, checked in by kanani, 8 years ago

changes related to steering and formating of urban surface model

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