Ignore:
Timestamp:
Sep 24, 2018 3:42:55 PM (6 years ago)
Author:
knoop
Message:

Modularization of all bulk cloud physics code components

File:
1 edited

Legend:

Unmodified
Added
Removed
  • palm/trunk/SOURCE/parin.f90

    r3248 r3274  
    2525! -----------------
    2626! $Id$
     27! Modularization of all bulk cloud physics code components
     28!
     29! 3248 2018-09-14 09:42:06Z sward
    2730! Minor formating changes
    2831!
     
    420423
    421424    USE arrays_3d,                                                             &
    422         ONLY:  pt_init, q_init, ref_state, s_init, sa_init,                    &     
     425        ONLY:  pt_init, q_init, ref_state, s_init, sa_init,                    &
    423426               ug, u_init, v_init, vg
     427
     428    USE bulk_cloud_model_mod,                                                  &
     429        ONLY:  bcm_parin
    424430
    425431    USE chemistry_model_mod,                                                   &
    426432        ONLY:  chem_parin
    427        
     433
    428434    USE chem_modules
    429435
     
    455461    USE land_surface_model_mod,                                                &
    456462        ONLY: lsm_parin
    457 
    458     USE microphysics_mod,                                                      &
    459         ONLY:  c_sedimentation, cloud_water_sedimentation,                     &
    460                collision_turbulence, curvature_solution_effects_bulk,          &
    461                dry_aerosol_radius, limiter_sedimentation, na_init, nc_const,   &
    462                sigma_bulk, ventilation_effect
    463463
    464464    USE model_1d_mod,                                                          &
     
    525525    INTEGER(iwp) ::  ioerr          !< error flag for open/read/write
    526526
    527     NAMELIST /inipar/  aerosol_bulk, alpha_surface, approximation, bc_e_b,     &
     527    NAMELIST /inipar/  alpha_surface, approximation, bc_e_b,     &
    528528                       bc_lr, bc_ns, bc_p_b, bc_p_t, bc_pt_b, bc_pt_t, bc_q_b, &
    529529             bc_q_t,bc_s_b, bc_s_t, bc_sa_t, bc_uv_b, bc_uv_t,                 &
     
    531531             building_length_y, building_wall_left, building_wall_south,       &
    532532             calc_soil_moisture_during_spinup,                                 &
    533              call_psolver_at_all_substeps, call_microphysics_at_all_substeps, &
     533             call_psolver_at_all_substeps, &
    534534             canyon_height,                                                    &
    535535             canyon_width_x, canyon_width_y, canyon_wall_left,                 &
    536              canyon_wall_south, c_sedimentation, cfl_factor, cloud_droplets,   &
    537              cloud_physics, cloud_scheme, cloud_top_radiation,                 &
    538              cloud_water_sedimentation,                                        &
    539              collective_wait, collision_turbulence, complex_terrain,           &
     536             canyon_wall_south, cfl_factor, cloud_droplets,   &
     537             cloud_top_radiation,                 &
     538             collective_wait, complex_terrain,           &
    540539             conserve_volume_flow,                                             &
    541540             conserve_volume_flow_mode, constant_flux_layer,                   &
    542              coupling_start_time, curvature_solution_effects_bulk,             &
     541             coupling_start_time,             &
    543542             cycle_mg, damp_level_1d,                                          &
    544543             data_output_during_spinup,                                        &
    545544             day_of_year_init,                                                 &
    546545             dissipation_1d,                                                   &
    547              dp_external, dp_level_b, dp_smooth, dpdxy, dry_aerosol_radius,    &
     546             dp_external, dp_level_b, dp_smooth, dpdxy,    &
    548547             dt, dt_pr_1d, dt_run_control_1d, dt_spinup, dx, dy, dz, dz_max,   &
    549548             dz_stretch_factor, dz_stretch_level, dz_stretch_level_start,      &
     
    555554             initializing_actions, km_constant,                                &
    556555             large_scale_forcing, large_scale_subsidence, latitude,            &
    557              limiter_sedimentation, longitude,                                 &
     556             longitude,                                 &
    558557             loop_optimization, lsf_exception, masking_method, mg_cycles,      &
    559558             mg_switch_to_pe0_level, mixing_length_1d, momentum_advec,         &
    560              most_method, na_init, nc_const, nesting_offline,                  &
     559             most_method, nesting_offline,                  &
    561560             netcdf_precision, neutral, ngsrb,                                 &
    562561             nsor, nsor_ini, nudging, nx, ny, nz, ocean, omega, omega_sor,     &
    563562             outflow_source_plane, passive_scalar,                             &
    564              prandtl_number, precipitation, psolver, pt_damping_factor,        &
     563             prandtl_number, psolver, pt_damping_factor,        &
    565564             pt_damping_width, pt_reference, pt_surface,                       &
    566565             pt_surface_initial_change, pt_vertical_gradient,                  &
     
    574573             roughness_length, sa_surface,                                     &
    575574             sa_vertical_gradient, sa_vertical_gradient_level, scalar_advec,   &
    576              scalar_rayleigh_damping, sigma_bulk,                              &
     575             scalar_rayleigh_damping,                              &
    577576             spinup_time, spinup_pt_amplitude, spinup_pt_mean,                 &
    578577             statistic_regions, subs_vertical_gradient,                        &
     
    592591             use_top_fluxes, use_ug_for_galilei_tr, use_upstream_for_tke,      &
    593592             uv_heights, u_bulk, u_profile, vg_surface, vg_vertical_gradient,  &
    594              vg_vertical_gradient_level, v_bulk, v_profile, ventilation_effect,&
     593             vg_vertical_gradient_level, v_bulk, v_profile,&
    595594             wall_adjustment, wall_heatflux, wall_humidityflux,                &
    596595             wall_salinityflux, wall_scalarflux, y_shift, zeta_max, zeta_min,  &
    597596             z0h_factor
    598597
    599     NAMELIST /initialization_parameters/  aerosol_bulk, alpha_surface,         &
     598    NAMELIST /initialization_parameters/  alpha_surface,         &
    600599             approximation, bc_e_b,                                            &
    601600             bc_lr, bc_ns, bc_p_b, bc_p_t, bc_pt_b, bc_pt_t, bc_q_b,           &
     
    604603             building_length_y, building_wall_left, building_wall_south,       &
    605604             calc_soil_moisture_during_spinup,                                 &
    606              call_psolver_at_all_substeps, call_microphysics_at_all_substeps, &
     605             call_psolver_at_all_substeps, &
    607606             canyon_height,                                                    &
    608607             canyon_width_x, canyon_width_y, canyon_wall_left,                 &
    609              canyon_wall_south, c_sedimentation, cfl_factor, cloud_droplets,   &
    610              cloud_physics, cloud_scheme, cloud_top_radiation,                 &
    611              cloud_water_sedimentation,                                        &
    612              collective_wait, collision_turbulence, complex_terrain,           &
     608             canyon_wall_south, cfl_factor, cloud_droplets,   &
     609             cloud_top_radiation,                 &
     610             collective_wait, complex_terrain,           &
    613611             conserve_volume_flow,                                             &
    614612             conserve_volume_flow_mode, constant_flux_layer,                   &
    615              coupling_start_time, curvature_solution_effects_bulk,             &
     613             coupling_start_time,             &
    616614             cycle_mg, damp_level_1d,                                          &
    617615             data_output_during_spinup,                                        &
    618616             day_of_year_init,                                                 &
    619617             dissipation_1d,                                                   &
    620              dp_external, dp_level_b, dp_smooth, dpdxy, dry_aerosol_radius,    &
     618             dp_external, dp_level_b, dp_smooth, dpdxy,    &
    621619             dt, dt_pr_1d, dt_run_control_1d, dt_spinup, dx, dy, dz, dz_max,   &
    622620             dz_stretch_factor, dz_stretch_level, dz_stretch_level_start,      &
     
    628626             initializing_actions, km_constant,                                &
    629627             large_scale_forcing, large_scale_subsidence, latitude,            &
    630              limiter_sedimentation, longitude,                                 &
     628             longitude,                                 &
    631629             loop_optimization, lsf_exception, masking_method, mg_cycles,      &
    632630             mg_switch_to_pe0_level, mixing_length_1d, momentum_advec,         &
    633              most_method, na_init, nc_const, nesting_offline,                  &
     631             most_method, nesting_offline,                  &
    634632             netcdf_precision, neutral, ngsrb,                                 &
    635633             nsor, nsor_ini, nudging, nx, ny, nz, ocean, omega, omega_sor,     &
    636634             outflow_source_plane, passive_scalar,                             &
    637              prandtl_number, precipitation, psolver, pt_damping_factor,        &
     635             prandtl_number, psolver, pt_damping_factor,        &
    638636             pt_damping_width, pt_reference, pt_surface,                       &
    639637             pt_surface_initial_change, pt_vertical_gradient,                  &
     
    647645             roughness_length, sa_surface,                                     &
    648646             sa_vertical_gradient, sa_vertical_gradient_level, scalar_advec,   &
    649              scalar_rayleigh_damping, sigma_bulk,                              &
     647             scalar_rayleigh_damping,                              &
    650648             spinup_time, spinup_pt_amplitude, spinup_pt_mean,                 &
    651649             statistic_regions, subs_vertical_gradient,                        &
     
    665663             use_free_convection_scaling,                                      &
    666664             uv_heights, u_bulk, u_profile, vg_surface, vg_vertical_gradient,  &
    667              vg_vertical_gradient_level, v_bulk, v_profile, ventilation_effect,&
     665             vg_vertical_gradient_level, v_bulk, v_profile,&
    668666             wall_adjustment, wall_heatflux, wall_humidityflux,                &
    669667             wall_salinityflux, wall_scalarflux, y_shift, zeta_max, zeta_min,  &
     
    684682             mask_y_loop, mask_z_loop, netcdf_data_format, netcdf_deflate,     &
    685683             normalizing_region, npex, npey, nz_do3d,                          &
    686              precipitation_amount_interval, profile_columns, profile_rows,     &
     684             profile_columns, profile_rows,     &
    687685             restart_time, section_xy, section_xz, section_yz,                 &
    688686             skip_time_data_output, skip_time_data_output_av, skip_time_dopr,  &
     
    705703             mask_y_loop, mask_z_loop, netcdf_data_format, netcdf_deflate,     &
    706704             normalizing_region, npex, npey, nz_do3d,                          &
    707              precipitation_amount_interval, profile_columns, profile_rows,     &
     705             profile_columns, profile_rows,     &
    708706             restart_time, section_xy, section_xz, section_yz,                 &
    709707             skip_time_data_output, skip_time_data_output_av, skip_time_dopr,  &
     
    864862
    865863!
     864!--       Check if gust module is used and read &gust_par if required
     865          CALL bcm_parin
     866
     867!
    866868!--       Check if urban surface model is used and read &urban_surface_par if required
    867869          CALL usm_parin
Note: See TracChangeset for help on using the changeset viewer.