- Timestamp:
- Apr 8, 2016 11:33:18 AM (9 years ago)
- Location:
- palm/trunk/SOURCE
- Files:
-
- 22 edited
Legend:
- Unmodified
- Added
- Removed
-
palm/trunk/SOURCE/Makefile
r1838 r1849 20 20 # Current revisions: 21 21 # ------------------ 22 # 22 # Adapted for modularization of microphysics 23 23 # 24 24 # Former revisions: … … 370 370 check_parameters.o: modules.o mod_kinds.o land_surface_model_mod.o \ 371 371 netcdf_interface.o plant_canopy_model_mod.o pmc_interface.o radiation_model_mod.o \ 372 spectra_mod.o subsidence.o 372 spectra_mod.o subsidence.o microphysics.o 373 373 close_file.o: modules.o mod_kinds.o netcdf_interface.o 374 374 compute_vpt.o: modules.o mod_kinds.o … … 391 391 data_output_3d.o: modules.o cpulog.o mod_kinds.o mod_particle_attributes.o\ 392 392 netcdf_interface.o land_surface_model_mod.o 393 diffusion_e.o: modules.o mod_kinds.o 393 diffusion_e.o: modules.o mod_kinds.o microphysics.o 394 394 diffusion_s.o: modules.o mod_kinds.o 395 395 diffusion_u.o: modules.o mod_kinds.o wall_fluxes.o … … 408 408 global_min_max.o: modules.o mod_kinds.o 409 409 header.o: modules.o cpulog.o mod_kinds.o netcdf_interface.o land_surface_model_mod.o\ 410 plant_canopy_model_mod.opmc_handle_communicator.o pmc_interface.o \411 radiation_model_mod.o spectra_mod.o subsidence.o 410 microphysics.o plant_canopy_model_mod.o: pmc_handle_communicator.o pmc_interface.o \ 411 radiation_model_mod.o spectra_mod.o subsidence.o 412 412 inflow_turbulence.o: modules.o cpulog.o mod_kinds.o 413 413 init_1d_model.o: modules.o mod_kinds.o … … 415 415 lpm_init.o ls_forcing.o netcdf_interface.o plant_canopy_model_mod.o \ 416 416 radiation_model_mod.o random_function.o random_generator_parallel.o \ 417 surface_layer_fluxes.o417 surface_layer_fluxes.o microphysics.o 418 418 init_advec.o: modules.o mod_kinds.o 419 419 init_cloud_physics.o: modules.o mod_kinds.o … … 472 472 parin.o: modules.o cpulog.o land_surface_model_mod.o mod_kinds.o netcdf_interface.o \ 473 473 plant_canopy_model_mod.o pmc_interface.o progress_bar.o spectra_mod.o \ 474 radiation_model_mod.o 474 radiation_model_mod.o microphysics.o 475 475 plant_canopy_model_mod.o: modules.o mod_kinds.o 476 476 pmc_interface.o: modules.o mod_kinds.o pmc_client.o pmc_general.o\ … … 496 496 subsidence.o user_actions.o 497 497 progress_bar.o: modules.o mod_kinds.o 498 radiation_model_mod.o : modules.o mod_particle_attributes.o 498 radiation_model_mod.o : modules.o mod_particle_attributes.o microphysics.o 499 499 random_function.o: mod_kinds.o 500 500 random_gauss.o: mod_kinds.o random_function.o random_generator_parallel.o … … 504 504 spectra_mod.o 505 505 read_var_list.o: modules.o mod_kinds.o netcdf_interface.o plant_canopy_model_mod.o \ 506 spectra_mod.o 506 spectra_mod.o microphysics.o 507 507 run_control.o: modules.o cpulog.o mod_kinds.o 508 508 set_slicer_attributes_dvrp.o: modules.o mod_kinds.o … … 522 522 ls_forcing.o mod_kinds.o nudging.o pmc_interface.o production_e.o \ 523 523 prognostic_equations.o progress_bar.o radiation_model_mod.o \ 524 spectra_mod.o user_actions.o surface_layer_fluxes.o 524 spectra_mod.o user_actions.o surface_layer_fluxes.o microphysics.o 525 525 time_to_string.o: mod_kinds.o 526 timestep.o: modules.o cpulog.o mod_kinds.o 526 timestep.o: modules.o cpulog.o mod_kinds.o microphysics.o 527 527 timestep_scheme_steering.o: modules.o mod_kinds.o 528 528 transpose.o: modules.o cpulog.o mod_kinds.o … … 562 562 spectra_mod.o 563 563 write_var_list.o: modules.o mod_kinds.o netcdf_interface.o plant_canopy_model_mod.o\ 564 spectra_mod.o 564 spectra_mod.o microphysics.o -
palm/trunk/SOURCE/data_output_2d.f90
r1823 r1849 19 19 ! Current revisions: 20 20 ! ----------------- 21 ! 22 ! 21 ! precipitation_amount, precipitation_rate, prr moved to arrays_3d 22 ! 23 23 ! Former revisions: 24 24 ! ----------------- … … 134 134 135 135 USE arrays_3d, & 136 ONLY: dzw, e, nr, ol, p, pt, q, qc, ql, ql_c, ql_v, ql_vp, qr, qsws, & 137 rho, sa, shf, tend, ts, u, us, v, vpt, w, z0, z0h, z0q, zu, zw 136 ONLY: dzw, e, nr, ol, p, pt, precipitation_amount, precipitation_rate,& 137 prr,q, qc, ql, ql_c, ql_v, ql_vp, qr, qsws, rho, sa, shf, tend, & 138 ts, u, us, v, vpt, w, z0, z0h, z0q, zu, zw 138 139 139 140 USE averaging 140 141 141 142 USE cloud_parameters, & 142 ONLY: hyrho, l_d_cp, precipitation_amount, precipitation_rate, prr, & 143 pt_d_t 143 ONLY: hyrho, l_d_cp, pt_d_t 144 144 145 145 USE control_parameters, & -
palm/trunk/SOURCE/data_output_3d.f90
r1823 r1849 19 19 ! Current revisions: 20 20 ! ------------------ 21 ! 21 ! prr moved to arrays_3d 22 22 ! 23 23 ! Former revisions: … … 116 116 117 117 USE arrays_3d, & 118 ONLY: e, nr, p, pt, q, qc, ql, ql_c, ql_v, qr, rho, sa, tend, u, v,&119 v pt, w118 ONLY: e, nr, p, pt, prr, q, qc, ql, ql_c, ql_v, qr, rho, sa, tend, u, & 119 v, vpt, w 120 120 121 121 USE averaging 122 122 123 123 USE cloud_parameters, & 124 ONLY: l_d_cp, p rr, pt_d_t124 ONLY: l_d_cp, pt_d_t 125 125 126 126 USE control_parameters, & -
palm/trunk/SOURCE/diffusion_e.f90
r1832 r1849 19 19 ! Current revisions: 20 20 ! ----------------- 21 ! 21 ! Adapted for modularization of microphysics 22 22 ! 23 23 ! Former revisions: … … 122 122 wall_adjustment, wall_adjustment_factor 123 123 124 USE cloud_parameters, &125 ONLY: collision_turbulence126 127 124 USE grid_variables, & 128 125 ONLY: ddx2, ddy2 … … 133 130 134 131 USE kinds 135 132 133 USE microphysics_mod, & 134 ONLY: collision_turbulence 135 136 136 USE particle_attributes, & 137 137 ONLY: use_sgs_for_particles, wang_kernel … … 307 307 ! 308 308 !-- Boundary condition for dissipation 309 IF ( use_sgs_for_particles .OR. wang_kernel .OR. 309 IF ( use_sgs_for_particles .OR. wang_kernel .OR. & 310 310 collision_turbulence ) THEN 311 311 DO i = nxl, nxr … … 332 332 ONLY: atmos_ocean_sign, g, use_single_reference_value, & 333 333 wall_adjustment, wall_adjustment_factor 334 335 USE cloud_parameters, &336 ONLY: collision_turbulence337 334 338 335 USE grid_variables, & … … 344 341 345 342 USE kinds 346 343 344 USE microphysics_mod, & 345 ONLY: collision_turbulence 346 347 347 USE particle_attributes, & 348 348 ONLY: use_sgs_for_particles, wang_kernel … … 536 536 wall_adjustment, wall_adjustment_factor 537 537 538 USE cloud_parameters, &539 ONLY: collision_turbulence540 541 538 USE grid_variables, & 542 539 ONLY: ddx2, ddy2 … … 546 543 547 544 USE kinds 548 545 546 USE microphysics_mod, & 547 ONLY: collision_turbulence 548 549 549 USE particle_attributes, & 550 550 ONLY: use_sgs_for_particles, wang_kernel … … 621 621 ! 622 622 !-- Store dissipation if needed for calculating the sgs particle velocities 623 IF ( use_sgs_for_particles .OR. wang_kernel .OR. collision_turbulence ) THEN 623 IF ( use_sgs_for_particles .OR. wang_kernel .OR. & 624 collision_turbulence ) THEN 624 625 DO k = nzb_s_inner(j,i)+1, nzt 625 626 diss(k,j,i) = dissipation(k) -
palm/trunk/SOURCE/flow_statistics.f90
r1823 r1849 19 19 ! Current revisions: 20 20 ! ----------------- 21 ! 21 ! prr moved to arrays_3d 22 22 ! 23 23 ! Former revisions: … … 186 186 187 187 USE arrays_3d, & 188 ONLY: ddzu, ddzw, e, hyp, km, kh, nr, ol, p, prho, p t, q, qc, ql, qr,&189 q s, qsws, qswst, rho, sa, saswsb, saswst, shf, td_lsa_lpt,&188 ONLY: ddzu, ddzw, e, hyp, km, kh, nr, ol, p, prho, prr, pt, q, qc, ql,& 189 qr, qs, qsws, qswst, rho, sa, saswsb, saswst, shf, td_lsa_lpt, & 190 190 td_lsa_q, td_sub_lpt, td_sub_q, time_vert, ts, tswst, u, ug, us,& 191 191 usws, uswst, vsws, v, vg, vpt, vswst, w, w_subs, zw 192 192 193 193 USE cloud_parameters, & 194 ONLY: l_d_cp, p rr, pt_d_t194 ONLY: l_d_cp, pt_d_t 195 195 196 196 USE control_parameters, & -
palm/trunk/SOURCE/header.f90
r1834 r1849 19 19 ! Current revisions: 20 20 ! ----------------- 21 ! 22 ! 21 ! Adapted for modularization of microphysics 22 ! 23 23 ! Former revisions: 24 24 ! ----------------- … … 259 259 260 260 USE cloud_parameters, & 261 ONLY: cloud_water_sedimentation, collision_turbulence, cp, & 262 c_sedimentation, limiter_sedimentation, l_v, nc_const, & 263 r_d, ventilation_effect 264 261 ONLY: cp, l_v, r_d 262 265 263 USE cpulog, & 266 264 ONLY: log_point_s … … 280 278 USE land_surface_model_mod, & 281 279 ONLY: land_surface, lsm_header 282 280 281 USE microphysics_mod, & 282 ONLY: cloud_water_sedimentation, collision_turbulence, & 283 c_sedimentation, limiter_sedimentation, nc_const, & 284 ventilation_effect 285 283 286 USE model_1d, & 284 287 ONLY: damp_level_ind_1d, dt_pr_1d, dt_run_control_1d, end_time_1d -
palm/trunk/SOURCE/init_3d_model.f90
r1846 r1849 19 19 ! Current revisions: 20 20 ! ------------------ 21 ! 22 ! 21 ! Adapted for modularization of microphysics. 22 ! precipitation_amount, precipitation_rate, prr moved to arrays_3d. 23 ! Initialization of nc_1d, nr_1d, pt_1d, qc_1d, qr_1d, q_1d moved to 24 ! microphysics_init. 25 ! 23 26 ! Former revisions: 24 27 ! ----------------- … … 265 268 266 269 USE arrays_3d 267 268 USE cloud_parameters, & 269 ONLY: collision_turbulence, nc_const, precipitation_amount, & 270 precipitation_rate, prr 271 270 272 271 USE constants, & 273 272 ONLY: pi … … 289 288 290 289 USE ls_forcing_mod 291 290 291 USE microphysics_mod, & 292 ONLY: collision_turbulence, microphysics_init 293 292 294 USE model_1d, & 293 295 ONLY: e1d, kh1d, km1d, l1d, rif1d, u1d, us1d, usws1d, v1d, vsws1d … … 483 485 484 486 ! 485 !-- 1D-arrays486 ALLOCATE ( nc_1d(nzb:nzt+1), pt_1d(nzb:nzt+1), &487 q_1d(nzb:nzt+1), qc_1d(nzb:nzt+1) )488 !489 487 !-- 3D-cloud water content 490 488 #if defined( __nopointer ) … … 498 496 499 497 IF ( microphysics_seifert ) THEN 500 !501 !-- 1D-arrays502 ALLOCATE ( nr_1d(nzb:nzt+1), qr_1d(nzb:nzt+1) )503 504 498 ! 505 499 !-- 2D-rain water content and rain drop concentration arrays … … 743 737 ENDDO 744 738 ENDDO 745 !746 !-- Initialze nc_1d with default value747 nc_1d(:) = nc_const748 739 749 740 ENDIF … … 882 873 ENDDO 883 874 IF ( cloud_physics .AND. microphysics_seifert ) THEN 884 !885 !-- Initialze nc_1d with default value886 nc_1d(:) = nc_const887 875 888 876 DO i = nxlg, nxrg … … 1199 1187 1200 1188 precipitation_amount = 0.0_wp 1201 1202 IF ( microphysics_seifert ) THEN1203 nc_1d = nc_const1204 ENDIF1205 1189 ENDIF 1206 1190 ! … … 1655 1639 !-- lpm_init) is not defined. 1656 1640 CALL init_cloud_physics 1641 ! 1642 !-- Initialize bulk cloud microphysics 1643 CALL microphysics_init 1657 1644 ENDIF 1658 1645 -
palm/trunk/SOURCE/init_cloud_physics.f90
r1823 r1849 19 19 ! Current revisions: 20 20 ! ----------------- 21 ! 21 ! bfactor removed 22 22 ! 23 23 ! Former revisions: … … 85 85 86 86 USE cloud_parameters, & 87 ONLY: bfactor, cp, c_sedimentation, dpirho_l, dt_precipitation, & 88 hyrho, k_st, l_d_cp, l_d_r, l_d_rv, l_v, mass_of_solute, & 89 molecular_weight_of_solute, molecular_weight_of_water, pirho_l, & 90 pt_d_t, rho_l, r_d, r_v, sed_qc_const, schmidt, schmidt_p_1d3, & 91 sigma_gc, t_d_pt, vanthoff, w_precipitation 92 93 USE constants, & 94 ONLY: pi 95 87 ONLY: cp, hyrho, l_d_cp, l_d_r, l_d_rv, l_v, pt_d_t, rho_l, r_d, r_v, & 88 t_d_pt 89 96 90 USE control_parameters, & 97 ONLY: g, message_string, microphysics_seifert, pt_surface, & 98 rho_surface, surface_pressure 91 ONLY: g, message_string, pt_surface, rho_surface, surface_pressure 99 92 100 93 USE indices, & … … 118 111 l_d_rv = l_v / r_v 119 112 120 schmidt_p_1d3 = schmidt**( 1.0_wp / 3.0_wp )121 122 pirho_l = pi * rho_l / 6.0_wp123 dpirho_l = 1.0_wp / pirho_l124 !125 !-- constant for the sedimentation of cloud water (2-moment cloud physics)126 sed_qc_const = k_st * ( 3.0_wp / ( 4.0_wp * pi * rho_l ) &127 )**( 2.0_wp / 3.0_wp ) * &128 EXP( 5.0_wp * LOG( sigma_gc )**2 )129 !130 !-- Calculate timestep according to precipitation131 IF ( microphysics_seifert ) THEN132 dt_precipitation = c_sedimentation * MINVAL( dzu(nzb+2:nzt) ) / &133 w_precipitation134 ENDIF135 !136 !-- Calculate factor used in equation for droplet growth by condensation137 bfactor = 3.0_wp * vanthoff * mass_of_solute * molecular_weight_of_water &138 / ( 4.0_wp * pi * rho_l * molecular_weight_of_solute )139 113 ! 140 114 !-- Calculate: -
palm/trunk/SOURCE/land_surface_model_mod.f90
r1827 r1849 19 19 ! Current revisions: 20 20 ! ----------------- 21 ! 21 ! prr moved to arrays_3d 22 22 ! 23 23 ! Former revisions: … … 137 137 138 138 USE arrays_3d, & 139 ONLY: hyp, ol, pt, pt_p, q, q_p, ql, qsws, shf, ts, us, vpt, z0, z0h, &140 z0 q139 ONLY: hyp, ol, pt, pt_p, prr, q, q_p, ql, qsws, shf, ts, us, vpt, z0, & 140 z0h, z0q 141 141 142 142 USE cloud_parameters, & 143 ONLY: cp, hyrho, l_d_cp, l_d_r, l_v, p rr, pt_d_t, rho_l, r_d, r_v143 ONLY: cp, hyrho, l_d_cp, l_d_r, l_v, pt_d_t, rho_l, r_d, r_v 144 144 145 145 USE control_parameters, & -
palm/trunk/SOURCE/lpm_droplet_condensation.f90
r1832 r1849 19 19 ! Current revisions: 20 20 ! ------------------ 21 ! 21 ! Interpolation of supersaturation has been removed because it is not in 22 ! accordance with the release/depletion of latent heat/water vapor in 23 ! interaction_droplets_ptq. 24 ! 25 ! Calculation of particle Reynolds number has been corrected. 26 ! 27 ! eps_ros added from modules 22 28 ! 23 29 ! Former revisions: … … 90 96 91 97 USE arrays_3d, & 92 ONLY: hyp, pt, q, ql_c, ql_v , zu98 ONLY: hyp, pt, q, ql_c, ql_v 93 99 94 100 USE cloud_parameters, & 95 ONLY: bfactor, eps_ros, l_d_rv, l_v, rho_l,r_v101 ONLY: l_d_rv, l_v, rho_l, r_v 96 102 97 103 USE constants, & … … 113 119 114 120 USE particle_attributes, & 115 ONLY: block_offset, curvature_solution_effects, grid_particles, & 116 hall_kernel, number_of_particles, particles, radius_classes, & 117 use_kernel_tables, wang_kernel 121 ONLY: curvature_solution_effects, hall_kernel, mass_of_solute, & 122 molecular_weight_of_solute, molecular_weight_of_water, & 123 number_of_particles, particles, radius_classes, & 124 use_kernel_tables, vanthoff, wang_kernel 118 125 119 126 … … 129 136 INTEGER(iwp) :: kp !< 130 137 INTEGER(iwp) :: n !< 131 INTEGER(iwp) :: nb !<132 138 INTEGER(iwp) :: ros_count !< 133 139 134 INTEGER(iwp), PARAMETER :: maxtry = 40 !< 135 136 INTEGER(iwp), DIMENSION(0:7) :: end_index !< 137 INTEGER(iwp), DIMENSION(0:7) :: start_index !< 138 139 LOGICAL :: repeat !< 140 141 LOGICAL, DIMENSION(number_of_particles) :: flag_1 !< 140 INTEGER(iwp), PARAMETER :: maxtry = 40 !< 141 142 LOGICAL :: repeat !< 142 143 143 144 REAL(wp) :: aa !< 144 REAL(wp) :: afactor !< 145 REAL(wp) :: afactor !< curvature effects 145 146 REAL(wp) :: arg !< 146 REAL(wp) :: bb !< 147 REAL(wp) :: cc !< 148 REAL(wp) :: dd !< 147 REAL(wp) :: bfactor !< solute effects 149 148 REAL(wp) :: ddenom !< 150 149 REAL(wp) :: delta_r !< 150 REAL(wp) :: diameter !< diameter of cloud droplets 151 REAL(wp) :: diff_coeff_v !< diffusivity for water vapor 151 152 REAL(wp) :: drdt !< 152 153 REAL(wp) :: drdt_ini !< … … 157 158 REAL(wp) :: d2rdtdr !< 158 159 REAL(wp) :: errmax !< 160 REAL(wp) :: e_a !< current vapor pressure 161 REAL(wp) :: e_s !< current saturation vapor pressure 159 162 REAL(wp) :: err_ros !< 160 163 REAL(wp) :: g1 !< … … 162 165 REAL(wp) :: g3 !< 163 166 REAL(wp) :: g4 !< 164 REAL(wp) :: gg !<165 REAL(wp) :: pt_int !<166 REAL(wp) :: pt_int_l !<167 REAL(wp) :: pt_int_u !<168 REAL(wp) :: q_int !<169 REAL(wp) :: q_int_l !<170 REAL(wp) :: q_int_u !<171 167 REAL(wp) :: r_ros !< 172 168 REAL(wp) :: r_ros_ini !< 173 169 REAL(wp) :: sigma !< 174 REAL(wp) :: x !< 175 REAL(wp) :: y !< 170 REAL(wp) :: thermal_conductivity_v !< thermal conductivity for water 171 REAL(wp) :: t_int !< temperature 172 REAL(wp) :: w_s !< terminal velocity of droplets 176 173 REAL(wp) :: re_p !< 177 174 175 ! 178 176 !-- Parameters for Rosenbrock method 179 177 REAL(wp), PARAMETER :: a21 = 2.0_wp !< … … 200 198 REAL(wp), PARAMETER :: pshrnk = -1.0_wp /3.0_wp !< 201 199 REAL(wp), PARAMETER :: shrnk = 0.5_wp !< 202 203 REAL(wp), DIMENSION(number_of_particles) :: afactor_v !< 204 REAL(wp), DIMENSION(number_of_particles) :: diff_coeff_v !< 205 REAL(wp), DIMENSION(number_of_particles) :: e_s !< 206 REAL(wp), DIMENSION(number_of_particles) :: e_a !< 200 REAL(wp), PARAMETER :: eps_ros = 1.0E-4_wp !< accuracy of Rosenbrock method 201 202 ! 203 !-- Parameters for terminal velocity 204 REAL(wp), PARAMETER :: a_rog = 9.65_wp !< parameter for fall velocity 205 REAL(wp), PARAMETER :: b_rog = 10.43_wp !< parameter for fall velocity 206 REAL(wp), PARAMETER :: c_rog = 0.6_wp !< parameter for fall velocity 207 REAL(wp), PARAMETER :: k_cap_rog = 4.0_wp !< parameter for fall velocity 208 REAL(wp), PARAMETER :: k_low_rog = 12.0_wp !< parameter for fall velocity 209 REAL(wp), PARAMETER :: d0_rog = 0.745_wp !< separation diameter 210 211 REAL(wp), DIMENSION(number_of_particles) :: ventilation_effect !< 207 212 REAL(wp), DIMENSION(number_of_particles) :: new_r !< 208 REAL(wp), DIMENSION(number_of_particles) :: p_int !< 209 REAL(wp), DIMENSION(number_of_particles) :: thermal_conductivity_v !< 210 REAL(wp), DIMENSION(number_of_particles) :: t_int !< 211 REAL(wp), DIMENSION(number_of_particles) :: xv !< 212 REAL(wp), DIMENSION(number_of_particles) :: yv !< 213 REAL(wp), DIMENSION(number_of_particles) :: zv !< 213 214 214 215 215 216 216 CALL cpu_log( log_point_s(42), 'lpm_droplet_condens', 'start' ) 217 217 218 start_index = grid_particles(kp,jp,ip)%start_index 219 end_index = grid_particles(kp,jp,ip)%end_index 220 221 xv = particles(1:number_of_particles)%x 222 yv = particles(1:number_of_particles)%y 223 zv = particles(1:number_of_particles)%z 224 225 DO nb = 0,7 226 227 i = ip + block_offset(nb)%i_off 228 j = jp + block_offset(nb)%j_off 229 k = kp + block_offset(nb)%k_off 230 231 DO n = start_index(nb), end_index(nb) 232 ! 233 !-- Interpolate temperature and humidity. 234 x = xv(n) - i * dx 235 y = yv(n) - j * dy 236 aa = x**2 + y**2 237 bb = ( dx - x )**2 + y**2 238 cc = x**2 + ( dy - y )**2 239 dd = ( dx - x )**2 + ( dy - y )**2 240 gg = aa + bb + cc + dd 241 242 pt_int_l = ( ( gg - aa ) * pt(k,j,i) + ( gg - bb ) * pt(k,j,i+1) & 243 + ( gg - cc ) * pt(k,j+1,i) + ( gg - dd ) * pt(k,j+1,i+1) & 244 ) / ( 3.0_wp * gg ) 245 246 pt_int_u = ( ( gg-aa ) * pt(k+1,j,i) + ( gg-bb ) * pt(k+1,j,i+1) & 247 + ( gg-cc ) * pt(k+1,j+1,i) + ( gg-dd ) * pt(k+1,j+1,i+1) & 248 ) / ( 3.0_wp * gg ) 249 250 pt_int = pt_int_l + ( particles(n)%z - zu(k) ) / dz * & 251 ( pt_int_u - pt_int_l ) 252 253 q_int_l = ( ( gg - aa ) * q(k,j,i) + ( gg - bb ) * q(k,j,i+1) & 254 + ( gg - cc ) * q(k,j+1,i) + ( gg - dd ) * q(k,j+1,i+1) & 255 ) / ( 3.0_wp * gg ) 256 257 q_int_u = ( ( gg-aa ) * q(k+1,j,i) + ( gg-bb ) * q(k+1,j,i+1) & 258 + ( gg-cc ) * q(k+1,j+1,i) + ( gg-dd ) * q(k+1,j+1,i+1) & 259 ) / ( 3.0_wp * gg ) 260 261 q_int = q_int_l + ( zv(n) - zu(k) ) / dz * & 262 ( q_int_u - q_int_l ) 263 264 ! 265 !-- Calculate real temperature and saturation vapor pressure 266 p_int(n) = hyp(k) + ( particles(n)%z - zu(k) ) / dz * & 267 ( hyp(k+1)-hyp(k) ) 268 t_int(n) = pt_int * ( p_int(n) / 100000.0_wp )**0.286_wp 269 270 e_s(n) = 611.0_wp * EXP( l_d_rv * ( 3.6609E-3_wp - 1.0_wp / & 271 t_int(n) ) ) 272 273 ! 274 !-- Current vapor pressure 275 e_a(n) = q_int * p_int(n) / ( 0.378_wp * q_int + 0.622_wp ) 276 277 ENDDO 278 ENDDO 218 ! 219 !-- Calculate temperature, saturation vapor pressure and current vapor pressure 220 t_int = pt(kp,jp,ip) * ( hyp(kp) / 100000.0_wp )**0.286_wp 221 e_s = 611.0_wp * EXP( l_d_rv * ( 3.6609E-3_wp - 1.0_wp / t_int ) ) 222 e_a = q(kp,jp,ip) * hyp(kp) / ( 0.378_wp * q(kp,jp,ip) + 0.622_wp ) 223 ! 224 !-- Thermal conductivity for water (from Rogers and Yau, Table 7.1), 225 !-- diffusivity for water vapor (after Hall und Pruppacher, 1976) 226 thermal_conductivity_v = 7.94048E-05_wp * t_int + 0.00227011_wp 227 diff_coeff_v = 0.211E-4_wp * ( t_int / 273.15_wp )**1.94_wp * & 228 ( 101325.0_wp / hyp(kp) ) 229 ! 230 !-- Calculate effects of heat conductivity and diffusion of water vapor on the 231 !-- condensation/evaporation process (typically known as 1.0 / (F_k + F_d) ) 232 ddenom = 1.0_wp / ( rho_l * r_v * t_int / ( e_s * diff_coeff_v ) + & 233 ( l_v / ( r_v * t_int ) - 1.0_wp ) * rho_l * & 234 l_v / ( thermal_conductivity_v * t_int ) & 235 ) 279 236 280 237 new_r = 0.0_wp 281 flag_1 = .false. 282 238 239 ! 240 !-- Determine ventilation effect on evaporation of large drops 283 241 DO n = 1, number_of_particles 284 ! 285 !-- Change in radius by condensation/evaporation 286 IF ( particles(n)%radius >= 4.0E-5_wp .AND. & 287 e_a(n)/e_s(n) < 1.0_wp ) THEN 288 ! 289 !-- Approximation for large radii, where curvature and solution effects 290 !-- can be neglected but ventilation effect has to be included in case of 291 !-- evaporation. 292 !-- First calculate the droplet's Reynolds number 293 re_p = 2.0_wp * particles(n)%radius * ABS( particles(n)%speed_z ) / & 294 molecular_viscosity 242 243 IF ( particles(n)%radius >= 4.0E-5_wp .AND. e_a / e_s < 1.0_wp ) THEN 244 ! 245 !-- Terminal velocity is computed for vertical direction (Rogers et al., 246 !-- 1993, J. Appl. Meteorol.) 247 diameter = particles(n)%radius * 2000.0_wp !diameter in mm 248 IF ( diameter <= d0_rog ) THEN 249 w_s = k_cap_rog * diameter * ( 1.0_wp - EXP( -k_low_rog * diameter ) ) 250 ELSE 251 w_s = a_rog - b_rog * EXP( -c_rog * diameter ) 252 ENDIF 253 ! 254 !-- First calculate droplet's Reynolds number 255 re_p = 2.0_wp * particles(n)%radius * w_s / molecular_viscosity 295 256 ! 296 257 !-- Ventilation coefficient (Rogers and Yau, 1989): 297 258 IF ( re_p > 2.5_wp ) THEN 298 afactor_v(n) = 0.78_wp + 0.28_wp * SQRT( re_p )259 ventilation_effect(n) = 0.78_wp + 0.28_wp * SQRT( re_p ) 299 260 ELSE 300 afactor_v(n) = 1.0_wp + 0.09_wp * re_p261 ventilation_effect(n) = 1.0_wp + 0.09_wp * re_p 301 262 ENDIF 302 flag_1(n) = .TRUE. 303 ELSEIF ( particles(n)%radius >= 1.0E-6_wp .OR. & 304 .NOT. curvature_solution_effects ) THEN 305 ! 306 !-- Approximation for larger radii in case that curvature and solution 307 !-- effects are neglected and ventilation effects does not play a role 308 afactor_v(n) = 1.0_wp 309 flag_1(n) = .TRUE. 263 ELSE 264 ! 265 !-- For small droplets or in supersaturated environments, the ventilation 266 !-- effect does not play a role 267 ventilation_effect(n) = 1.0_wp 310 268 ENDIF 311 269 ENDDO 312 270 313 DO n = 1, number_of_particles 314 ! 315 !-- Thermal conductivity for water (from Rogers and Yau, Table 7.1), 316 !-- diffusivity for water vapor (after Hall und Pruppacher, 1976) 317 thermal_conductivity_v(n) = 7.94048E-05_wp * t_int(n) + 0.00227011_wp 318 diff_coeff_v(n) = 0.211E-4_wp * & 319 ( t_int(n) / 273.15_wp )**1.94_wp * ( 101325.0_wp / p_int(n)) 320 321 IF(flag_1(n)) then 322 arg = particles(n)%radius**2 + 2.0_wp * dt_3d * afactor_v(n) * & 323 ( e_a(n) / e_s(n) - 1.0_wp ) / & 324 ( ( l_d_rv / t_int(n) - 1.0_wp ) * l_v * rho_l / t_int(n) / & 325 thermal_conductivity_v(n) + & 326 rho_l * r_v * t_int(n) / diff_coeff_v(n) / e_s(n) ) 327 271 ! 272 !-- Use analytic model for condensational growth 273 IF( .NOT. curvature_solution_effects ) then 274 DO n = 1, number_of_particles 275 arg = particles(n)%radius**2 + 2.0_wp * dt_3d * ddenom * & 276 ventilation_effect(n) * & 277 ( e_a / e_s - 1.0_wp ) 328 278 arg = MAX( arg, 1.0E-16_wp ) 329 279 new_r(n) = SQRT( arg ) 330 ENDIF 331 ENDDO 332 280 ENDDO 281 ENDIF 282 283 ! 284 !-- If selected, use numerical solution of the condensational growth 285 !-- equation (e.g., for studying the activation of aerosols). 286 !-- Curvature and solutions effects are included in growth equation. 287 !-- Change in Radius is calculated with a 4th-order Rosenbrock method 288 !-- for stiff o.d.e's with monitoring local truncation error to adjust 289 !-- stepsize (see Numerical recipes in FORTRAN, 2nd edition, p. 731). 333 290 DO n = 1, number_of_particles 334 IF ( curvature_solution_effects .AND. & 335 ( ( particles(n)%radius < 1.0E-6_wp ) .OR. & 336 ( new_r(n) < 1.0E-6_wp ) ) ) THEN 337 ! 338 !-- Curvature and solutions effects are included in growth equation. 339 !-- Change in Radius is calculated with 4th-order Rosenbrock method 340 !-- for stiff o.d.e's with monitoring local truncation error to adjust 341 !-- stepsize (see Numerical recipes in FORTRAN, 2nd edition, p. 731). 342 !-- For larger radii the simple analytic method (see ELSE) gives 343 !-- almost the same results. 291 IF ( curvature_solution_effects ) THEN 344 292 345 293 ros_count = 0 … … 356 304 repeat = .FALSE. 357 305 ! 358 !-- Surface tension (Straka, 2009): 359 sigma = 0.0761_wp - 0.000155_wp * ( t_int(n) - 273.15_wp ) 306 !-- Curvature effect (afactor) with surface tension parameterization 307 !-- by Straka (2009) 308 sigma = 0.0761_wp - 0.000155_wp * ( t_int - 273.15_wp ) 309 afactor = 2.0_wp * sigma / ( rho_l * r_v * t_int ) 310 ! 311 !-- Solute effect (bfactor), mass of solute to be replaced by variable 312 !-- aerosol radius 313 bfactor = 3.0_wp * vanthoff * mass_of_solute * & 314 molecular_weight_of_water / ( 4.0_wp * pi * rho_l * & 315 molecular_weight_of_solute & 316 ) 360 317 361 318 r_ros = particles(n)%radius 362 319 dt_ros_sum = 0.0_wp ! internal integrated time (s) 363 320 internal_timestep_count = 0 364 365 ddenom = 1.0_wp / ( rho_l * r_v * t_int(n) / ( e_s(n) * &366 diff_coeff_v(n) ) + ( l_v / &367 ( r_v * t_int(n) ) - 1.0_wp ) * &368 rho_l * l_v / ( thermal_conductivity_v(n) * &369 t_int(n) ) &370 )371 372 afactor = 2.0_wp * sigma / ( rho_l * r_v * t_int(n) )373 374 321 ! 375 322 !-- Take internal time step values from the end of last PALM time step … … 380 327 !-- because larger values may lead to secondary solutions which are 381 328 !-- physically unlikely 382 IF ( dt_ros_next > 1.0E-2_wp .AND. e_a (n)/e_s(n)< 1.0_wp ) THEN329 IF ( dt_ros_next > 1.0E-2_wp .AND. e_a / e_s < 1.0_wp ) THEN 383 330 dt_ros_next = 1.0E-3_wp 384 331 ENDIF … … 408 355 ! 409 356 !-- Derivative at starting value 410 drdt = ddenom / r_ros * ( e_a(n) / e_s(n) - 1.0_wp - afactor / & 411 r_ros + bfactor / r_ros**3 ) 357 drdt = ddenom * ventilation_effect(n) * ( e_a / e_s - 1.0_wp - & 358 afactor / r_ros + & 359 bfactor / r_ros**3 & 360 ) / r_ros 361 412 362 drdt_ini = drdt 413 363 dt_ros_sum_ini = dt_ros_sum … … 416 366 ! 417 367 !-- Calculate radial derivative of dr/dt 418 d2rdtdr = ddenom * ( ( 1.0_wp - e_a(n)/e_s(n) ) / r_ros**2 + & 419 2.0_wp * afactor / r_ros**3 - & 420 4.0_wp * bfactor / r_ros**5 ) 368 d2rdtdr = ddenom * ventilation_effect(n) * & 369 ( ( 1.0_wp - e_a / e_s ) / r_ros**2 + & 370 2.0_wp * afactor / r_ros**3 - & 371 4.0_wp * bfactor / r_ros**5 & 372 ) 421 373 ! 422 374 !-- Adjust stepsize unless required accuracy is reached … … 432 384 g1 = drdt_ini / aa 433 385 r_ros = r_ros_ini + a21 * g1 434 drdt = ddenom / r_ros * ( e_a(n) / e_s(n) - 1.0_wp - & 435 afactor / r_ros + & 436 bfactor / r_ros**3 ) 386 drdt = ddenom * ventilation_effect(n) * ( e_a / e_s - 1.0_wp - & 387 afactor / r_ros + & 388 bfactor / r_ros**3 & 389 ) / r_ros 437 390 438 391 g2 = ( drdt + c21 * g1 / dt_ros )& 439 392 / aa 440 393 r_ros = r_ros_ini + a31 * g1 + a32 * g2 441 drdt = ddenom / r_ros * ( e_a(n) / e_s(n) - 1.0_wp - & 442 afactor / r_ros + & 443 bfactor / r_ros**3 ) 394 drdt = ddenom * ventilation_effect(n) * ( e_a / e_s - 1.0_wp - & 395 afactor / r_ros + & 396 bfactor / r_ros**3 & 397 ) / r_ros 444 398 445 399 g3 = ( drdt + & … … 510 464 !-- Limiting values are tested for droplets down to 1.0E-7 511 465 IF ( new_r(n) - particles(n)%radius >= 3.0E-7_wp .AND. & 512 e_a (n)/e_s(n)< 0.97_wp ) THEN466 e_a / e_s < 0.97_wp ) THEN 513 467 ros_count = ros_count + 1 514 468 repeat = .TRUE. … … 546 500 new_r(n) < 0.0_wp ) THEN 547 501 WRITE( message_string, * ) '#1 k=',k,' j=',j,' i=',i, & 548 ' e_s=',e_s (n), ' e_a=',e_a(n),' t_int=',t_int(n), &502 ' e_s=',e_s, ' e_a=',e_a,' t_int=',t_int, & 549 503 ' &delta_r=',delta_r, & 550 504 ' particle_radius=',particles(n)%radius -
palm/trunk/SOURCE/microphysics.f90
r1846 r1849 19 19 ! Current revisions: 20 20 ! ------------------ 21 ! 22 ! 21 ! Adapted for modularization of microphysics. 22 ! 23 23 ! Former revisions: 24 24 ! ----------------- … … 98 98 ! Description: 99 99 ! ------------ 100 !> Calculate cloud microphysics according to the two moment bulk 101 !> scheme by Seifert and Beheng (2006). 100 !> Calculate bilk cloud microphysics. 102 101 !------------------------------------------------------------------------------! 103 102 MODULE microphysics_mod 104 103 104 USE kinds 105 106 IMPLICIT NONE 107 108 LOGICAL :: cloud_water_sedimentation = .FALSE. !< cloud water sedimentation 109 LOGICAL :: limiter_sedimentation = .TRUE. !< sedimentation limiter 110 LOGICAL :: collision_turbulence = .FALSE. !< turbulence effects 111 LOGICAL :: ventilation_effect = .TRUE. !< ventilation effect 112 113 REAL(wp) :: a_1 = 8.69E-4_wp !< coef. in turb. parametrization (cm-2 s3) 114 REAL(wp) :: a_2 = -7.38E-5_wp !< coef. in turb. parametrization (cm-2 s3) 115 REAL(wp) :: a_3 = -1.40E-2_wp !< coef. in turb. parametrization 116 REAL(wp) :: a_term = 9.65_wp !< coef. for terminal velocity (m s-1) 117 REAL(wp) :: a_vent = 0.78_wp !< coef. for ventilation effect 118 REAL(wp) :: b_1 = 11.45E-6_wp !< coef. in turb. parametrization (m) 119 REAL(wp) :: b_2 = 9.68E-6_wp !< coef. in turb. parametrization (m) 120 REAL(wp) :: b_3 = 0.62_wp !< coef. in turb. parametrization 121 REAL(wp) :: b_term = 9.8_wp !< coef. for terminal velocity (m s-1) 122 REAL(wp) :: b_vent = 0.308_wp !< coef. for ventilation effect 123 REAL(wp) :: beta_cc = 3.09E-4_wp !< coef. in turb. parametrization (cm-2 s3) 124 REAL(wp) :: c_1 = 4.82E-6_wp !< coef. in turb. parametrization (m) 125 REAL(wp) :: c_2 = 4.8E-6_wp !< coef. in turb. parametrization (m) 126 REAL(wp) :: c_3 = 0.76_wp !< coef. in turb. parametrization 127 REAL(wp) :: c_const = 0.93_wp !< const. in Taylor-microscale Reynolds number 128 REAL(wp) :: c_evap = 0.7_wp !< constant in evaporation 129 REAL(wp) :: c_term = 600.0_wp !< coef. for terminal velocity (m-1) 130 REAL(wp) :: diff_coeff_l = 0.23E-4_wp !< diffusivity of water vapor (m2 s-1) 131 REAL(wp) :: eps_sb = 1.0E-20_wp !< threshold in two-moments scheme 132 REAL(wp) :: k_cc = 9.44E09_wp !< const. cloud-cloud kernel (m3 kg-2 s-1) 133 REAL(wp) :: k_cr0 = 4.33_wp !< const. cloud-rain kernel (m3 kg-1 s-1) 134 REAL(wp) :: k_rr = 7.12_wp !< const. rain-rain kernel (m3 kg-1 s-1) 135 REAL(wp) :: k_br = 1000.0_wp !< const. in breakup parametrization (m-1) 136 REAL(wp) :: k_st = 1.2E8_wp !< const. in drizzle parametrization (m-1 s-1) 137 REAL(wp) :: kappa_rr = 60.7_wp !< const. in collision kernel (kg-1/3) 138 REAL(wp) :: kin_vis_air = 1.4086E-5_wp !< kin. viscosity of air (m2 s-1) 139 REAL(wp) :: prec_time_const = 0.001_wp !< coef. in Kessler scheme (s-1) 140 REAL(wp) :: ql_crit = 0.0005_wp !< coef. in Kessler scheme (kg kg-1) 141 REAL(wp) :: schmidt_p_1d3=0.8921121_wp !< Schmidt number**0.33333, 0.71**0.33333 142 REAL(wp) :: sigma_gc = 1.3_wp !< geometric standard deviation cloud droplets 143 REAL(wp) :: thermal_conductivity_l = 2.43E-2_wp !< therm. cond. air (J m-1 s-1 K-1) 144 REAL(wp) :: w_precipitation = 9.65_wp !< maximum terminal velocity (m s-1) 145 REAL(wp) :: x0 = 2.6E-10_wp !< separating drop mass (kg) 146 REAL(wp) :: xrmin = 2.6E-10_wp !< minimum rain drop size (kg) 147 REAL(wp) :: xrmax = 5.0E-6_wp !< maximum rain drop site (kg) 148 149 REAL(wp) :: c_sedimentation = 2.0_wp !< Courant number of sedimentation process 150 REAL(wp) :: dpirho_l !< 6.0 / ( pi * rho_l ) 151 REAL(wp) :: dt_micro !< microphysics time step 152 REAL(wp) :: nc_const = 70.0E6_wp !< cloud droplet concentration 153 REAL(wp) :: dt_precipitation = 100.0_wp !< timestep precipitation (s) 154 REAL(wp) :: sed_qc_const !< const. for sedimentation of cloud water 155 REAL(wp) :: pirho_l !< pi * rho_l / 6.0; 156 157 REAL(wp), DIMENSION(:), ALLOCATABLE :: nc_1d !< 158 REAL(wp), DIMENSION(:), ALLOCATABLE :: nr_1d !< 159 REAL(wp), DIMENSION(:), ALLOCATABLE :: pt_1d !< 160 REAL(wp), DIMENSION(:), ALLOCATABLE :: qc_1d !< 161 REAL(wp), DIMENSION(:), ALLOCATABLE :: qr_1d !< 162 REAL(wp), DIMENSION(:), ALLOCATABLE :: q_1d !< 163 164 SAVE 105 165 106 166 PRIVATE 107 PUBLIC microphysics_control 167 PUBLIC microphysics_control, microphysics_init 168 169 PUBLIC cloud_water_sedimentation, collision_turbulence, c_sedimentation, & 170 dt_precipitation, limiter_sedimentation, nc_const, sigma_gc, & 171 ventilation_effect 108 172 109 173 INTERFACE microphysics_control … … 157 221 END INTERFACE calc_precipitation_amount 158 222 159 160 223 CONTAINS 161 162 163 224 !------------------------------------------------------------------------------! 164 225 ! Description: 165 226 ! ------------ 166 !> Call for all grid points 227 !> Initialization of bulk microphysics 228 !------------------------------------------------------------------------------! 229 SUBROUTINE microphysics_init 230 231 USE arrays_3d, & 232 ONLY: dzu 233 234 USE constants, & 235 ONLY: pi 236 237 USE cloud_parameters, & 238 ONLY: rho_l 239 240 USE control_parameters, & 241 ONLY: microphysics_seifert 242 243 USE indices, & 244 ONLY: nzb, nzt 245 246 IMPLICIT NONE 247 248 ! 249 !-- constant for the sedimentation of cloud water (2-moment cloud physics) 250 sed_qc_const = k_st * ( 3.0_wp / ( 4.0_wp * pi * rho_l ) & 251 )**( 2.0_wp / 3.0_wp ) * & 252 EXP( 5.0_wp * LOG( sigma_gc )**2 ) 253 254 ! 255 !-- Calculate timestep according to precipitation 256 IF ( microphysics_seifert ) THEN 257 dt_precipitation = c_sedimentation * MINVAL( dzu(nzb+2:nzt) ) / & 258 w_precipitation 259 ENDIF 260 261 ! 262 !-- Pre-calculate frequently calculated fractions of pi and rho_l 263 pirho_l = pi * rho_l / 6.0_wp 264 dpirho_l = 1.0_wp / pirho_l 265 266 ! 267 !-- Allocate 1D microphysics arrays 268 ALLOCATE ( nc_1d(nzb:nzt+1), pt_1d(nzb:nzt+1), q_1d(nzb:nzt+1), & 269 qc_1d(nzb:nzt+1) ) 270 271 IF ( microphysics_seifert ) THEN 272 ALLOCATE ( nr_1d(nzb:nzt+1), qr_1d(nzb:nzt+1) ) 273 ENDIF 274 275 ! 276 !-- Initialze nc_1d with nc_const 277 nc_1d = nc_const 278 279 END SUBROUTINE microphysics_init 280 281 282 !------------------------------------------------------------------------------! 283 ! Description: 284 ! ------------ 285 !> Control of microphysics for all grid points 167 286 !------------------------------------------------------------------------------! 168 287 SUBROUTINE microphysics_control 169 288 170 289 USE arrays_3d, & 171 ONLY: hyp, pt_init, zu290 ONLY: hyp, pt_init, prr, zu 172 291 173 292 USE cloud_parameters, & 174 ONLY: c loud_water_sedimentation, cp, hyrho, prr, pt_d_t, r_d, t_d_pt293 ONLY: cp, hyrho, pt_d_t, r_d, t_d_pt 175 294 176 295 USE control_parameters, & 177 ONLY: call_microphysics_at_all_substeps, dt_3d, dt_micro,&178 g, intermediate_timestep_count, large_scale_forcing,&296 ONLY: call_microphysics_at_all_substeps, dt_3d, g, & 297 intermediate_timestep_count, large_scale_forcing, & 179 298 lsf_surf, microphysics_kessler, microphysics_seifert, & 180 299 pt_surface, rho_surface,surface_pressure … … 263 382 264 383 USE cloud_parameters, & 265 ONLY: eps_sb, xrmin, xrmax,hyrho384 ONLY: hyrho 266 385 267 386 USE cpulog, & … … 314 433 315 434 USE cloud_parameters, & 316 ONLY: a_1, a_2, a_3, b_1, b_2, b_3, beta_cc, c_1, c_2, c_3, & 317 c_const, collision_turbulence, dpirho_l, eps_sb, hyrho, & 318 k_cc, kin_vis_air, nc_const, x0 435 ONLY: hyrho 319 436 320 437 USE control_parameters, & 321 ONLY: dt_micro,rho_surface438 ONLY: rho_surface 322 439 323 440 USE cpulog, & … … 446 563 447 564 USE arrays_3d, & 448 ONLY: dzw, pt, q, qc565 ONLY: dzw, pt, prr, q, qc 449 566 450 567 USE cloud_parameters, & 451 ONLY: l_d_cp, pt_d_t, prec_time_const, prr, ql_crit 452 453 USE control_parameters, & 454 ONLY: dt_micro 568 ONLY: l_d_cp, pt_d_t 455 569 456 570 USE indices, & … … 506 620 507 621 USE cloud_parameters, & 508 ONLY: collision_turbulence, eps_sb, hyrho, k_cr0622 ONLY: hyrho 509 623 510 624 USE control_parameters, & 511 ONLY: dt_micro,rho_surface625 ONLY: rho_surface 512 626 513 627 USE cpulog, & … … 587 701 588 702 USE cloud_parameters, & 589 ONLY: dpirho_l, eps_sb, hyrho, k_br, k_rr703 ONLY: hyrho 590 704 591 705 USE control_parameters, & 592 ONLY: dt_micro,rho_surface706 ONLY: rho_surface 593 707 594 708 USE cpulog, & … … 659 773 660 774 USE cloud_parameters, & 661 ONLY: a_term, a_vent, b_term, b_vent, c_evap, c_term, & 662 diff_coeff_l, dpirho_l, eps_sb, hyrho, kin_vis_air, & 663 l_d_cp, l_d_r, l_v, r_v, schmidt_p_1d3, & 664 thermal_conductivity_l, t_d_pt, ventilation_effect 775 ONLY: hyrho, l_d_cp, l_d_r, l_v, r_v, t_d_pt 665 776 666 777 USE constants, & 667 778 ONLY: pi 668 669 USE control_parameters, &670 ONLY: dt_micro671 779 672 780 USE cpulog, & … … 817 925 818 926 USE arrays_3d, & 819 ONLY: ddzu, dzu, pt, q, qc927 ONLY: ddzu, dzu, pt, prr, q, qc 820 928 821 929 USE cloud_parameters, & 822 ONLY: eps_sb, hyrho, l_d_cp, nc_const, prr, pt_d_t, sed_qc_const930 ONLY: hyrho, l_d_cp, pt_d_t 823 931 824 932 USE control_parameters, & 825 ONLY: call_microphysics_at_all_substeps, dt_micro, & 826 intermediate_timestep_count 933 ONLY: call_microphysics_at_all_substeps, intermediate_timestep_count 827 934 828 935 USE cpulog, & … … 840 947 IMPLICIT NONE 841 948 842 INTEGER(iwp) :: i 843 INTEGER(iwp) :: j 844 INTEGER(iwp) :: k 949 INTEGER(iwp) :: i !< 950 INTEGER(iwp) :: j !< 951 INTEGER(iwp) :: k !< 845 952 846 953 REAL(wp), DIMENSION(nzb:nzt+1) :: sed_qc !< … … 900 1007 901 1008 USE arrays_3d, & 902 ONLY: ddzu, dzu, nr, pt, q, qr1009 ONLY: ddzu, dzu, nr, pt, prr, q, qr 903 1010 904 1011 USE cloud_parameters, & 905 ONLY: a_term, b_term, c_term, dpirho_l, eps_sb, hyrho, & 906 limiter_sedimentation, l_d_cp, prr, pt_d_t 1012 ONLY: hyrho, l_d_cp, pt_d_t 907 1013 908 1014 USE control_parameters, & 909 ONLY: call_microphysics_at_all_substeps, dt_micro, & 910 intermediate_timestep_count 1015 ONLY: call_microphysics_at_all_substeps, intermediate_timestep_count 911 1016 USE cpulog, & 912 1017 ONLY: cpu_log, log_point_s … … 1125 1230 SUBROUTINE calc_precipitation_amount 1126 1231 1232 USE arrays_3d, & 1233 ONLY: precipitation_amount, prr 1234 1127 1235 USE cloud_parameters, & 1128 ONLY: hyrho , precipitation_amount, prr1236 ONLY: hyrho 1129 1237 1130 1238 USE control_parameters, & … … 1166 1274 ! Description: 1167 1275 ! ------------ 1168 !> C all for grid pointi,j1276 !> Control of microphysics for grid points i,j 1169 1277 !------------------------------------------------------------------------------! 1170 1278 … … 1172 1280 1173 1281 USE arrays_3d, & 1174 ONLY: hyp, nc_1d, nr, nr_1d, pt, pt_init, pt_1d, q, q_1d, qc, & 1175 qc_1d, qr, qr_1d, zu 1282 ONLY: hyp, nr, pt, pt_init, prr, q, qc, qr, zu 1176 1283 1177 1284 USE cloud_parameters, & 1178 ONLY: cloud_water_sedimentation, cp, hyrho, nc_const, prr, pt_d_t, & 1179 r_d, t_d_pt 1285 ONLY: cp, hyrho, pt_d_t, r_d, t_d_pt 1180 1286 1181 1287 USE control_parameters, & 1182 ONLY: call_microphysics_at_all_substeps, dt_3d, dt_micro,&1183 g, intermediate_timestep_count, large_scale_forcing,&1288 ONLY: call_microphysics_at_all_substeps, dt_3d, g, & 1289 intermediate_timestep_count, large_scale_forcing, & 1184 1290 lsf_surf, microphysics_seifert, microphysics_kessler, & 1185 1291 pt_surface, rho_surface, surface_pressure … … 1286 1392 SUBROUTINE adjust_cloud_ij( i, j ) 1287 1393 1288 USE arrays_3d, &1289 ONLY: qr_1d, nr_1d1290 1291 1394 USE cloud_parameters, & 1292 ONLY: eps_sb, xrmin, xrmax,hyrho1395 ONLY: hyrho 1293 1396 1294 1397 USE indices, & … … 1334 1437 1335 1438 USE arrays_3d, & 1336 ONLY: diss, dzu , nc_1d, nr_1d, qc_1d, qr_1d1439 ONLY: diss, dzu 1337 1440 1338 1441 USE cloud_parameters, & 1339 ONLY: a_1, a_2, a_3, b_1, b_2, b_3, beta_cc, c_1, c_2, c_3, & 1340 c_const, collision_turbulence, dpirho_l, eps_sb, hyrho, & 1341 kin_vis_air, k_cc, x0 1442 ONLY: hyrho 1342 1443 1343 1444 USE control_parameters, & 1344 ONLY: dt_micro,rho_surface1445 ONLY: rho_surface 1345 1446 1346 1447 USE grid_variables, & … … 1454 1555 1455 1556 USE arrays_3d, & 1456 ONLY: dzw, p t_1d, q_1d, qc_1d1557 ONLY: dzw, prr 1457 1558 1458 1559 USE cloud_parameters, & 1459 ONLY: l_d_cp, pt_d_t, prec_time_const, prr, ql_crit 1460 1461 USE control_parameters, & 1462 ONLY: dt_micro 1560 ONLY: l_d_cp, pt_d_t 1463 1561 1464 1562 USE indices, & … … 1505 1603 1506 1604 USE arrays_3d, & 1507 ONLY: diss , qc_1d, qr_1d1605 ONLY: diss 1508 1606 1509 1607 USE cloud_parameters, & 1510 ONLY: collision_turbulence, eps_sb, hyrho, k_cr01608 ONLY: hyrho 1511 1609 1512 1610 USE control_parameters, & 1513 ONLY: dt_micro,rho_surface1611 ONLY: rho_surface 1514 1612 1515 1613 USE indices, & … … 1572 1670 SUBROUTINE selfcollection_breakup_ij( i, j ) 1573 1671 1574 USE arrays_3d, &1575 ONLY: nr_1d, qr_1d1576 1577 1672 USE cloud_parameters, & 1578 ONLY: dpirho_l, eps_sb, hyrho, k_br, k_rr1673 ONLY: hyrho 1579 1674 1580 1675 USE control_parameters, & 1581 ONLY: dt_micro,rho_surface1676 ONLY: rho_surface 1582 1677 1583 1678 USE indices, & … … 1632 1727 1633 1728 USE arrays_3d, & 1634 ONLY: hyp , nr_1d, pt_1d, q_1d, qc_1d, qr_1d1729 ONLY: hyp 1635 1730 1636 1731 USE cloud_parameters, & 1637 ONLY: a_term, a_vent, b_term, b_vent, c_evap, c_term, diff_coeff_l,& 1638 dpirho_l, eps_sb, hyrho, kin_vis_air, l_d_cp, l_d_r, & 1639 l_v, r_v, schmidt_p_1d3, thermal_conductivity_l, & 1640 t_d_pt, ventilation_effect 1732 ONLY: hyrho, l_d_cp, l_d_r, l_v, r_v, t_d_pt 1641 1733 1642 1734 USE constants, & 1643 1735 ONLY: pi 1644 1645 USE control_parameters, &1646 ONLY: dt_micro1647 1736 1648 1737 USE indices, & … … 1779 1868 1780 1869 USE arrays_3d, & 1781 ONLY: ddzu, dzu, nc_1d, pt_1d, q_1d, qc_1d1870 ONLY: ddzu, dzu, prr 1782 1871 1783 1872 USE cloud_parameters, & 1784 ONLY: eps_sb, hyrho, l_d_cp, prr, pt_d_t, sed_qc_const1873 ONLY: hyrho, l_d_cp, pt_d_t 1785 1874 1786 1875 USE control_parameters, & 1787 ONLY: call_microphysics_at_all_substeps, dt_micro, & 1788 intermediate_timestep_count 1876 ONLY: call_microphysics_at_all_substeps, intermediate_timestep_count 1789 1877 1790 1878 USE indices, & … … 1798 1886 IMPLICIT NONE 1799 1887 1800 INTEGER(iwp) :: i 1801 INTEGER(iwp) :: j 1802 INTEGER(iwp) :: k 1888 INTEGER(iwp) :: i !< 1889 INTEGER(iwp) :: j !< 1890 INTEGER(iwp) :: k !< 1803 1891 1804 1892 REAL(wp), DIMENSION(nzb:nzt+1) :: sed_qc !< … … 1848 1936 1849 1937 USE arrays_3d, & 1850 ONLY: ddzu, dzu, nr_1d, pt_1d, q_1d, qr_1d1938 ONLY: ddzu, dzu, prr 1851 1939 1852 1940 USE cloud_parameters, & 1853 ONLY: a_term, b_term, c_term, dpirho_l, eps_sb, hyrho, & 1854 limiter_sedimentation, l_d_cp, prr, pt_d_t 1941 ONLY: hyrho, l_d_cp, pt_d_t 1855 1942 1856 1943 USE control_parameters, & 1857 ONLY: call_microphysics_at_all_substeps, dt_micro, & 1858 intermediate_timestep_count 1944 ONLY: call_microphysics_at_all_substeps, intermediate_timestep_count 1859 1945 1860 1946 USE indices, & … … 2050 2136 SUBROUTINE calc_precipitation_amount_ij( i, j ) 2051 2137 2138 USE arrays_3d, & 2139 ONLY: precipitation_amount, prr 2140 2052 2141 USE cloud_parameters, & 2053 ONLY: hyrho , precipitation_amount, prr2142 ONLY: hyrho 2054 2143 2055 2144 USE control_parameters, & … … 2089 2178 !------------------------------------------------------------------------------! 2090 2179 FUNCTION gamm( xx ) 2091 2092 USE cloud_parameters, &2093 ONLY: cof, stp2094 2180 2095 2181 USE kinds … … 2106 2192 REAL(wp) :: y_gamm !< 2107 2193 2108 x_gamm = xx 2109 y_gamm = x_gamm 2194 2195 REAL(wp), PARAMETER :: stp = 2.5066282746310005_wp !< 2196 REAL(wp), PARAMETER :: cof(6) = (/ 76.18009172947146_wp, & 2197 -86.50532032941677_wp, & 2198 24.01409824083091_wp, & 2199 -1.231739572450155_wp, & 2200 0.1208650973866179E-2_wp, & 2201 -0.5395239384953E-5_wp /) !< 2202 2203 x_gamm = xx 2204 y_gamm = x_gamm 2110 2205 tmp = x_gamm + 5.5_wp 2111 tmp = ( x_gamm + 0.5_wp ) * LOG( tmp ) - tmp 2206 tmp = ( x_gamm + 0.5_wp ) * LOG( tmp ) - tmp 2112 2207 ser = 1.000000000190015_wp 2113 2208 -
palm/trunk/SOURCE/mod_particle_attributes.f90
r1832 r1849 19 19 ! Current revisions: 20 20 ! ------------------ 21 ! 21 ! bfactor, mass_of_solute, molecular_weight_of_solute, molecular_weight_of_water, 22 ! vanthoff added from modules 22 23 ! 23 24 ! Former revisions: … … 115 116 REAL(wp), DIMENSION(:), ALLOCATABLE :: log_z_z0 116 117 118 ! 119 !-- Lagrangian cloud model constants 120 REAL(wp) :: mass_of_solute = 1.0E-17_wp !< soluted NaCl (kg) 121 REAL(wp) :: molecular_weight_of_solute = 0.05844_wp !< mol. m. NaCl (kg mol-1) 122 REAL(wp) :: molecular_weight_of_water = 0.01801528_wp !< mol. m. H2O (kg mol-1) 123 REAL(wp) :: vanthoff = 2.0_wp !< van't Hoff factor for NaCl 124 117 125 TYPE particle_type 118 126 SEQUENCE -
palm/trunk/SOURCE/modules.f90
r1846 r1849 19 19 ! Current revisions: 20 20 ! ------------------ 21 ! 22 ! 21 ! bfactor, mass_of_solute, molecular_weight_of_solute, molecular_weight_of_water, 22 ! vanthoff moved to mod_particle_attributes. 23 ! dt_micro and several cloud_parameters moved to microphysics_mod. 24 ! 1d-microphysics profiles moved to microphysics_mod. 25 ! 23 26 ! Former revisions: 24 27 ! ----------------- … … 394 397 c_u_m, c_u_m_l, c_v_m, c_v_m_l, c_w_m, c_w_m_l, ddzu, ddzu_pres, & 395 398 dd2zu, dzu, ddzw, dzw, hyp, inflow_damping_factor, l_grid, & 396 nc_1d, nr_1d, ptdf_x, ptdf_y, p_surf, pt_surf, pt_1d, pt_init, & 397 qsws_surf, q_1d, q_init, q_surf, qc_1d, qr_1d, rdf, rdf_sc, & 398 ref_state, sa_init, shf_surf, timenudge, time_surf, time_vert, & 399 tmp_tnudge, ug, u_init, u_nzb_p1_for_vfc, vg, v_init, & 399 ptdf_x, ptdf_y, p_surf, pt_surf, pt_init, qsws_surf, q_init, q_surf, & 400 rdf, rdf_sc, ref_state, sa_init, shf_surf, timenudge, time_surf, & 401 time_vert, tmp_tnudge, ug, u_init, u_nzb_p1_for_vfc, vg, v_init, & 400 402 v_nzb_p1_for_vfc, w_subs, zu, zw 401 403 … … 407 409 mean_inflow_profiles, nrs, nrsws, nrswst, & 408 410 ol, & !< Obukhov length 409 p tnudge, pt_slope_ref,&411 precipitation_amount, precipitation_rate, ptnudge, pt_slope_ref, & 410 412 qnudge, qs, qsws, qswst, qswst_remote, qrs, qrsws, qrswst, & 411 413 saswsb, saswst, shf, tnudge, td_lsa_lpt, td_lsa_q, td_sub_lpt, & … … 421 423 diss_l_v, diss_l_w, flux_l_e, flux_l_nr, flux_l_pt, flux_l_q, & 422 424 flux_l_qr, flux_l_sa, flux_l_u, flux_l_v, flux_l_w, kh, km, & 423 l_wall, p _loc, tend, tric,&425 l_wall, prr, p_loc, tend, tric, & 424 426 u_m_l, u_m_n, u_m_r, u_m_s, v_m_l, v_m_n, v_m_r, v_m_s, w_m_l, & 425 427 w_m_n, w_m_r, w_m_s … … 490 492 USE kinds 491 493 492 LOGICAL :: cloud_water_sedimentation = .FALSE., & !< cloud water sedimentation in bulk cloud physics 493 limiter_sedimentation = .TRUE., & !< sedimentation limiter in bulk cloud physics 494 collision_turbulence = .FALSE., & !< turbulence effects in bulk cloud physics 495 ventilation_effect = .TRUE. !< ventilation effect in bulk cloud physics 496 497 498 REAL(wp) :: a_1 = 8.69E-4_wp, & !< coef. in turb. parametrization (cm-2 s3) 499 a_2 = -7.38E-5_wp, & !< coef. in turb. parametrization (cm-2 s3) 500 a_3 = -1.40E-2_wp, & !< coef. in turb. parametrization 501 a_term = 9.65_wp, & !< coef. for terminal velocity (m s-1) 502 a_vent = 0.78_wp, & !< coef. for ventilation effect 503 b_1 = 11.45E-6_wp, & !< coef. in turb. parametrization (m) 504 b_2 = 9.68E-6_wp, & !< coef. in turb. parametrization (m) 505 b_3 = 0.62_wp, & !< coef. in turb. parametrization 506 b_term = 9.8_wp, & !< coef. for terminal velocity (m s-1) 507 b_vent = 0.308_wp, & !< coef. for ventilation effect 508 beta_cc = 3.09E-4_wp, & !< coef. in turb. parametrization (cm-2 s3) 509 bfactor, & !< solution effect on diffusional growth 510 c_1 = 4.82E-6_wp, & !< coef. in turb. parametrization (m) 511 c_2 = 4.8E-6_wp, & !< coef. in turb. parametrization (m) 512 c_3 = 0.76_wp, & !< coef. in turb. parametrization 513 c_const = 0.93_wp, & !< const. in Taylor-microscale Reynolds number 514 c_evap = 0.7_wp, & !< constant in evaporation 515 c_sedimentation = 2.0_wp, & !< Courant number of sedimentation process 516 c_term = 600.0_wp, & !< coef. for terminal velocity (m-1) 517 cof(6) = (/ 76.18009172947146_wp, & !< coefficients in the 518 -86.50532032941677_wp, & !< numerical 519 24.01409824083091_wp, & !< calculation of the 520 -1.231739572450155_wp, & !< gamma function 521 0.1208650973866179E-2_wp, & 522 -0.5395239384953E-5_wp /), & 523 cp = 1005.0_wp, & !< heat capacity of dry air (J kg-1 K-1) 524 diff_coeff_l = 0.23E-4_wp, & !< diffusivity of water vapor (m2 s-1) 525 effective_coll_efficiency, & !< effective collision efficiency 526 eps_ros = 1.0E-4_wp, & !< accuracy of Rosenbrock method 527 eps_sb = 1.0E-20_wp, & !< threshold in two-moments scheme 528 k_cc = 9.44E09_wp, & !< const. cloud-cloud kernel (m3 kg-2 s-1) 529 k_cr0 = 4.33_wp, & !< const. cloud-rain kernel (m3 kg-1 s-1) 530 k_rr = 7.12_wp, & !< const. rain-rain kernel (m3 kg-1 s-1) 531 k_br = 1000._wp, & !< const. in breakup parametrization (m-1) 532 k_st = 1.2E8_wp, & !< const. in drizzle parametrization (m-1 s-1) 533 kappa_rr = 60.7_wp, & !< const. in collision kernel (kg-1/3) 534 kin_vis_air = 1.4086E-5_wp, & !< kin. viscosity of air (m2 s-1) 494 REAL(wp) :: cp = 1005.0_wp, & !< heat capacity of dry air (J kg-1 K-1) 535 495 l_v = 2.5E+06_wp, & !< latent heat of vaporization (J kg-1) 536 496 l_d_cp, l_d_r, l_d_rv, & !< l_v / cp, l_v / r_d, l_v / r_v 537 mass_of_solute = 1.0E-17_wp, & !< soluted NaCl (kg)538 molecular_weight_of_solute = 0.05844_wp, & !< mol. m. NaCl (kg mol-1)539 molecular_weight_of_water = 0.01801528_wp, & !< mol. m. H2O (kg mol-1)540 nc_const = 70.0E6_wp, & !< cloud droplet concentration541 prec_time_const = 0.001_wp, & !< coef. in Kessler scheme542 pirho_l, dpirho_l, & !< pi * rho_l / 6.0; 6.0 / ( pi * rho_l )543 497 rho_l = 1.0E3_wp, & !< density of water (kg m-3) 544 ql_crit = 0.0005_wp, & !< coef. in Kessler scheme545 498 r_d = 287.0_wp, & !< sp. gas const. dry air (J kg-1 K-1) 546 r_v = 461.51_wp, & !< sp. gas const. water vapor (J kg-1 K-1) 547 schmidt = 0.71_wp, & !< Schmidt number 548 schmidt_p_1d3, & !< schmidt**( 1.0 / 3.0 ) 549 sed_qc_const, & !< const. for sedimentation of cloud water 550 sigma_gc = 1.3_wp, & !< log-normal geometric standard deviation 551 stp = 2.5066282746310005_wp, & !< parameter in gamma function 552 thermal_conductivity_l = 2.43E-2_wp, & !< therm. cond. air (J m-1 s-1 K-1) 553 vanthoff = 2.0_wp, & !< van't Hoff factor for NaCl 554 x0 = 2.6E-10_wp, & !< separating drop mass (kg) 555 xrmin = 2.6E-10_wp, & !< minimum rain drop size (kg) 556 xrmax = 5.0E-6_wp, & !< maximum rain drop site (kg) 557 dt_precipitation = 100.0_wp, & !< timestep precipitation (s) 558 w_precipitation = 9.65_wp !< maximum terminal velocity (m s-1) 499 r_v = 461.51_wp !< sp. gas const. water vapor (J kg-1 K-1) 500 559 501 560 502 REAL(wp), DIMENSION(:), ALLOCATABLE :: hyrho, pt_d_t, t_d_pt 561 562 REAL(wp), DIMENSION(:,:), ALLOCATABLE :: precipitation_amount, &563 precipitation_rate564 !565 !-- 3D array of precipitation rate566 REAL(wp), DIMENSION(:,:,:), ALLOCATABLE :: prr567 503 568 504 SAVE … … 807 743 dt_do2d_xy = 9999999.9_wp, dt_do2d_xz = 9999999.9_wp, & 808 744 dt_do2d_yz = 9999999.9_wp, dt_do3d = 9999999.9_wp, dt_dvrp = 9999999.9_wp, & 809 dt_max = 20.0_wp, dt_micro = -1.0_wp,&745 dt_max = 20.0_wp, & 810 746 dt_restart = 9999999.9_wp, & 811 747 dt_run_control = 60.0_wp, dt_3d = -1.0_wp, dz = -1.0_wp, & -
palm/trunk/SOURCE/parin.f90
r1834 r1849 19 19 ! Current revisions: 20 20 ! ----------------- 21 ! 21 ! Adapted for modularization of microphysics 22 22 ! 23 23 ! Former revisions: … … 205 205 USE plant_canopy_model_mod, & 206 206 ONLY: pcm_parin 207 208 USE cloud_parameters, & 207 208 USE control_parameters 209 210 USE cpulog, & 211 ONLY: cpu_log_barrierwait 212 213 USE dvrp_variables, & 214 ONLY: local_dvrserver_running 215 216 USE grid_variables, & 217 ONLY: dx, dy 218 219 USE indices, & 220 ONLY: nx, ny, nz 221 222 USE kinds 223 224 USE land_surface_model_mod, & 225 ONLY: lsm_parin 226 227 USE microphysics_mod, & 209 228 ONLY: c_sedimentation, cloud_water_sedimentation, & 210 229 collision_turbulence, limiter_sedimentation, nc_const, & 211 230 ventilation_effect 212 231 213 USE control_parameters214 215 USE cpulog, &216 ONLY: cpu_log_barrierwait217 218 USE dvrp_variables, &219 ONLY: local_dvrserver_running220 221 USE grid_variables, &222 ONLY: dx, dy223 224 USE indices, &225 ONLY: nx, ny, nz226 227 USE kinds228 229 USE land_surface_model_mod, &230 ONLY: lsm_parin231 232 232 USE model_1d, & 233 233 ONLY: damp_level_1d, dt_pr_1d, dt_run_control_1d, end_time_1d -
palm/trunk/SOURCE/radiation_model_mod.f90
r1827 r1849 19 19 ! Current revisions: 20 20 ! ----------------- 21 ! 21 ! Adapted for modularization of microphysics 22 22 ! 23 23 ! Former revisions: … … 98 98 99 99 USE cloud_parameters, & 100 ONLY: cp, l_d_cp, nc_const, rho_l, sigma_gc100 ONLY: cp, l_d_cp, rho_l 101 101 102 102 USE constants, & … … 112 112 113 113 USE kinds 114 115 USE microphysics_mod, & 116 ONLY: nc_const, sigma_gc 114 117 115 118 #if defined ( __netcdf ) -
palm/trunk/SOURCE/read_3d_binary.f90
r1834 r1849 19 19 ! Current revisions: 20 20 ! ----------------- 21 ! 21 ! prr, precipitation_amount moved to arrays_3d 22 22 ! 23 23 ! Former revisions: … … 102 102 103 103 USE arrays_3d, & 104 ONLY: e, kh, km, ol, p, pt, q, ql, qc, nr, nrs, nrsws, nrswst, qr, & 104 ONLY: e, kh, km, ol, p, pt, q, ql, qc, nr, nrs, nrsws, nrswst, & 105 prr, precipitation_amount, qr, & 105 106 qrs, qrsws, qrswst, qs, qsws, qswst, sa, saswsb, saswst, & 106 107 rif_wall, shf, ts, tswst, u, u_m_l, u_m_n, u_m_r, u_m_s, us, & … … 109 110 110 111 USE averaging 111 112 USE cloud_parameters, &113 ONLY: prr, precipitation_amount114 112 115 113 USE control_parameters, & -
palm/trunk/SOURCE/read_var_list.f90
r1834 r1849 19 19 ! Current revisions: 20 20 ! ------------------ 21 ! 22 ! 21 ! Adapted for modularization of microphysics 22 ! 23 23 ! Former revisions: 24 24 ! ----------------- … … 171 171 q_init, ref_state, sa_init, u_init, ug, v_init, vg 172 172 173 USE cloud_parameters, & 173 USE control_parameters 174 175 USE grid_variables, & 176 ONLY: dx, dy 177 178 USE indices, & 179 ONLY: nz, nx, nx_on_file, ny, ny_on_file 180 181 USE microphysics_mod, & 174 182 ONLY: c_sedimentation, collision_turbulence, & 175 183 cloud_water_sedimentation, limiter_sedimentation, & 176 184 nc_const, ventilation_effect 177 178 USE control_parameters179 180 USE grid_variables, &181 ONLY: dx, dy182 183 USE indices, &184 ONLY: nz, nx, nx_on_file, ny, ny_on_file185 185 186 186 USE model_1d, & -
palm/trunk/SOURCE/sum_up_3d_data.f90
r1818 r1849 19 19 ! Current revisions: 20 20 ! ----------------- 21 ! 21 ! precipitation_rate moved to arrays_3d 22 22 ! 23 23 ! Former revisions: … … 94 94 95 95 USE arrays_3d, & 96 ONLY: dzw, e, nr, ol, p, pt, q, qc, ql, ql_c, ql_v, qr, qsws, rho, sa,&97 shf, ts, u, us, v, vpt, w, z0, z0h, z0q96 ONLY: dzw, e, nr, ol, p, pt, precipitation_rate, q, qc, ql, ql_c, & 97 ql_v, qr, qsws, rho, sa, shf, ts, u, us, v, vpt, w, z0, z0h, z0q 98 98 99 99 USE averaging, & … … 105 105 106 106 USE cloud_parameters, & 107 ONLY: l_d_cp, p recipitation_rate, pt_d_t107 ONLY: l_d_cp, pt_d_t 108 108 109 109 USE control_parameters, & -
palm/trunk/SOURCE/time_integration.f90
r1834 r1849 19 19 ! Current revisions: 20 20 ! ------------------ 21 ! 22 ! 21 ! Adapted for modularization of microphysics 22 ! 23 23 ! Former revisions: 24 24 ! ----------------- … … 243 243 ws_scheme_sca 244 244 245 USE cloud_parameters, &246 ONLY: collision_turbulence247 248 245 USE cpulog, & 249 246 ONLY: cpu_log, log_point, log_point_s … … 264 261 USE ls_forcing_mod, & 265 262 ONLY: ls_forcing_surf, ls_forcing_vert 263 264 USE microphysics_mod, & 265 ONLY: collision_turbulence 266 266 267 267 USE nudge_mod, & -
palm/trunk/SOURCE/timestep.f90
r1818 r1849 19 19 ! Current revisions: 20 20 ! ------------------ 21 ! 21 ! Adapted for modularization of microphysics 22 22 ! 23 23 ! Former revisions: … … 89 89 ONLY: dzu, dzw, kh, km, u, v, w 90 90 91 USE cloud_parameters, &92 ONLY: dt_precipitation93 94 91 USE control_parameters, & 95 92 ONLY: cfl_factor, coupling_mode, dt_3d, dt_fixed, dt_max, & … … 110 107 111 108 USE kinds 109 110 USE microphysics_mod, & 111 ONLY: dt_precipitation 112 112 113 113 USE pegrid -
palm/trunk/SOURCE/write_3d_binary.f90
r1834 r1849 19 19 ! Current revisions: 20 20 ! ----------------- 21 ! 21 ! prr, precipitation_amount moved to arrays_3d 22 22 ! 23 23 ! Former revisions: … … 95 95 96 96 USE arrays_3d, & 97 ONLY: e, kh, km, ol, p, pt, q, ql, qc, nr, nrs, nrsws, nrswst, qr, & 97 ONLY: e, kh, km, ol, p, pt, q, ql, qc, nr, nrs, nrsws, nrswst, & 98 prr, precipitation_amount, qr, & 98 99 qrs, qrsws, qrswst, qs, qsws, qswst, sa, saswsb, saswst, & 99 100 rif_wall, shf, ts, tswst, u, u_m_l, u_m_n, u_m_r, u_m_s, us, & … … 102 103 103 104 USE averaging 104 105 USE cloud_parameters, & 106 ONLY: prr, precipitation_amount 107 105 108 106 USE control_parameters, & 109 107 ONLY: iran, humidity, passive_scalar, cloud_physics, cloud_droplets, & -
palm/trunk/SOURCE/write_var_list.f90
r1834 r1849 19 19 ! Current revisions: 20 20 ! ----------------- 21 ! 22 ! 21 ! Adapted for modularization of microphysics 22 ! 23 23 ! Former revisions: 24 24 ! ----------------- … … 149 149 ONLY: inflow_damping_factor, mean_inflow_profiles, pt_init, & 150 150 q_init, ref_state, sa_init, u_init, ug, v_init, vg 151 152 USE cloud_parameters, & 153 ONLY: c_sedimentation, cloud_water_sedimentation, & 154 collision_turbulence, limiter_sedimentation, nc_const, & 155 ventilation_effect 156 151 157 152 USE control_parameters 158 153 … … 162 157 USE indices, & 163 158 ONLY: nz, nx, ny 164 159 160 USE microphysics_mod, & 161 ONLY: c_sedimentation, cloud_water_sedimentation, & 162 collision_turbulence, limiter_sedimentation, nc_const, & 163 ventilation_effect 164 165 165 USE model_1d, & 166 166 ONLY: damp_level_1d, dt_pr_1d, dt_run_control_1d, end_time_1d
Note: See TracChangeset
for help on using the changeset viewer.