Changeset 4114
- Timestamp:
- Mar 28, 2022, 6:23:04 PM (3 years ago)
- Location:
- LMDZ6/trunk/libf/phylmd
- Files:
-
- 7 edited
Legend:
- Unmodified
- Added
- Removed
-
LMDZ6/trunk/libf/phylmd/cloudth_mod.F90
r4089 r4114 1549 1549 USE ioipsl_getin_p_mod, ONLY : getin_p 1550 1550 USE phys_output_var_mod, ONLY : cloudth_sth,cloudth_senv,cloudth_sigmath,cloudth_sigmaenv 1551 USE lscp_tools_mod, ONLY: CALC_QSAT_ECMWF 1552 USE phys_local_var_mod, ONLY : qlth, qith, qsith 1551 USE lscp_tools_mod, ONLY: CALC_QSAT_ECMWF, FALLICE_VELOCITY 1552 USE phys_local_var_mod, ONLY : qlth, qith, qsith, with 1553 1553 1554 1554 IMPLICIT NONE … … 1596 1596 INTEGER itap,ind1,l,ig,iter,k 1597 1597 INTEGER iflag_topthermals, niter 1598 1598 LOGICAL falseklon(klon) 1599 1599 1600 1600 REAL zqsatth(klon), zqsatenv(klon), zqsatenvonly(klon) … … 1619 1619 REAL IntJ,IntI1,IntI2,IntI3,IntJ_CF,IntI1_CF,IntI3_CF,coeffqlenv,coeffqlth 1620 1620 REAL zdelta,qsatbef,zcor 1621 REAL Tbefth(klon), Tbefenv(klon), Tbefenvonly(klon) 1621 REAL Tbefth(klon), Tbefenv(klon), Tbefenvonly(klon), rhoth(klon) 1622 1622 REAL qlbef 1623 1623 REAL dqsatenv(klon), dqsatth(klon), dqsatenvonly(klon) … … 1689 1689 qlth(:,ind2)=0. 1690 1690 qith(:,ind2)=0. 1691 with(:,ind2)=0. 1691 1692 rneb(:,:)=0. 1692 1693 qcloud(:)=0. … … 1697 1698 cenv_vol(:,:)=0. 1698 1699 ctot_vol(:,:)=0. 1700 falseklon(:)=.false. 1699 1701 qsatmmussig1=0. 1700 1702 qsatmmussig2=0. … … 1795 1797 Tbefth(:)=ztla(:,ind2)*zpspsk(:,ind2) 1796 1798 Tbefenvonly(:)=temp(:,ind2) 1799 rhoth(:)=paprs(:,ind2)/Tbefth(:)/RD 1797 1800 1798 1801 zqenv(:)=(po(:)-fraca(:,ind2)*zqta(:,ind2))/(1.-fraca(:,ind2)) !qt = a*qtth + (1-a)*qtenv … … 1989 1992 ENDIF 1990 1993 1991 CALL ICE_MPC_BL_CLOUDS(ind1,ind2,klev,Ni,Ei,C_cap,d_top,iflag_topthermals,temp_mpc,pres_mpc,zqta(ind1,:),qsith(ind1,:),qlth(ind1,:),deltazlev_mpc, snowf_mpc,fraca_mpc,qith(ind1,:))1994 CALL ICE_MPC_BL_CLOUDS(ind1,ind2,klev,Ni,Ei,C_cap,d_top,iflag_topthermals,temp_mpc,pres_mpc,zqta(ind1,:),qsith(ind1,:),qlth(ind1,:),deltazlev_mpc,with(ind1,:),fraca_mpc,qith(ind1,:)) 1992 1995 1993 1996 ! qmax calculation … … 2229 2232 2230 2233 2231 ENDDO !loop on klon 2234 ENDDO !loop on klon 2235 2236 ! Calcule ice fall velocity in thermals 2237 2238 CALL FALLICE_VELOCITY(klon,qith(:,ind2),Tbefth(:),rhoth(:),paprs(:,ind2),falseklon(:),with(:,ind2)) 2232 2239 2233 2240 RETURN … … 2237 2244 2238 2245 !++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ 2239 SUBROUTINE ICE_MPC_BL_CLOUDS(ind1,ind2,klev,Ni,Ei,C_cap,d_top,iflag_topthermals,temp,pres,qth,qsith,qlth,deltazlev, snowf,fraca,qith)2246 SUBROUTINE ICE_MPC_BL_CLOUDS(ind1,ind2,klev,Ni,Ei,C_cap,d_top,iflag_topthermals,temp,pres,qth,qsith,qlth,deltazlev,with,fraca,qith) 2240 2247 2241 2248 ! parameterization of ice for boundary … … 2297 2304 !============================================================================= 2298 2305 2299 USE lscp_tools_mod, ONLY: CALC_QSAT_ECMWF2300 2306 USE ioipsl_getin_p_mod, ONLY : getin_p 2301 2307 USE phys_state_var_mod, ONLY : fm_therm, detr_therm, entr_therm … … 2318 2324 REAL, DIMENSION(klev), INTENT(IN) :: qlth ! condensed liquid water in thermals, approximated value [kg/kg] 2319 2325 REAL, DIMENSION(klev), INTENT(IN) :: deltazlev ! layer thickness [m] 2320 REAL, DIMENSION(klev +1), INTENT(IN) :: snowf ! snow flux at the upper inferface2326 REAL, DIMENSION(klev), INTENT(IN) :: with ! ice crystal fall velocity [m/s] 2321 2327 REAL, DIMENSION(klev+1), INTENT(IN) :: fraca ! fraction of the mesh covered by thermals 2322 2328 REAL, DIMENSION(klev), INTENT(INOUT) :: qith ! condensed ice water , thermals [kg/kg] … … 2396 2402 fp1=0. 2397 2403 IF (fraca(ind2p1) .GT. 0.) THEN 2398 fp2=- snowf(ind2p2)/fraca(ind2p1)! flux defined positive upward2399 fp1=- snowf(ind2p1)/fraca(ind2p1)2404 fp2=-qith(ind2p2)*rho(ind2p2)*with(ind2p2)*fraca(ind2p2)! flux defined positive upward 2405 fp1=-qith(ind2p1)*rho(ind2p1)*with(ind2p1)*fraca(ind2p1) 2400 2406 ENDIF 2401 2407 -
LMDZ6/trunk/libf/phylmd/conf_phys_m.F90
r4089 r4114 182 182 INTEGER,SAVE :: iflag_cloudth_vert_omp 183 183 INTEGER,SAVE :: iflag_rain_incloud_vol_omp 184 INTEGER,SAVE :: iflag_vice_omp 184 INTEGER,SAVE :: iflag_vice_omp, iflag_rei_omp 185 185 REAL,SAVE :: rad_froid_omp, rad_chau1_omp, rad_chau2_omp 186 186 REAL,SAVE :: t_glace_min_omp, t_glace_max_omp … … 255 255 LOGICAL, SAVE :: ok_new_lscp_omp 256 256 LOGICAL, SAVE :: ok_icefra_lscp_omp 257 LOGICAL, SAVE :: ok_radliq_snow_omp 258 257 259 258 260 INTEGER, INTENT(OUT):: read_climoz ! read ozone climatology, OpenMP shared … … 1501 1503 CALL getin('iflag_vice',iflag_vice_omp) 1502 1504 1505 !Config Key = iflag_rei 1506 !Config Desc = 1507 !Config Def = 0 1508 !Config Help = 1509 ! 1510 iflag_rei_omp = 0 1511 CALL getin('iflag_rei',iflag_rei_omp) 1512 1513 1503 1514 ! 1504 1515 !Config Key = iflag_ice_thermo … … 2366 2377 2367 2378 2368 2379 ok_radliq_snow_omp = .FALSE. 2380 CALL getin('ok_radliq_snow', ok_radliq_snow_omp) 2381 ! 2382 !Config Key = ok_radliq_snow_omp 2383 !Config Desc = take into account snowfall for radiation 2384 !Config Def = .FALSE. 2385 !Config Help = ... 2369 2386 2370 2387 ecrit_LES_omp = 1./8. … … 2488 2505 iflag_rain_incloud_vol=iflag_rain_incloud_vol_omp 2489 2506 iflag_vice=iflag_vice_omp 2507 iflag_rei=iflag_rei_omp 2490 2508 iflag_ice_thermo = iflag_ice_thermo_omp 2491 2509 ok_ice_sursat = ok_ice_sursat_omp … … 2690 2708 ok_new_lscp = ok_new_lscp_omp 2691 2709 ok_icefra_lscp=ok_icefra_lscp_omp 2710 ok_radliq_snow=ok_radliq_snow_omp 2692 2711 read_fco2_ocean_cor = read_fco2_ocean_cor_omp 2693 2712 var_fco2_ocean_cor = var_fco2_ocean_cor_omp … … 2915 2934 WRITE(lunout,*) ' iflag_rain_incloud_vol = ',iflag_rain_incloud_vol 2916 2935 WRITE(lunout,*) ' iflag_vice = ',iflag_vice 2936 WRITE(lunout,*) ' iflag_rei = ',iflag_rei 2917 2937 WRITE(lunout,*) ' iflag_ice_thermo = ',iflag_ice_thermo 2918 2938 WRITE(lunout,*) ' ok_ice_sursat = ',ok_ice_sursat … … 3028 3048 WRITE(lunout,*) ' ok_new_lscp = ', ok_new_lscp 3029 3049 WRITE(lunout,*) ' ok_icefra_lscp = ', ok_icefra_lscp 3050 WRITE(lunout,*) ' ok_radliq_snow = ', ok_radliq_snow 3030 3051 WRITE(lunout,*) ' read_climoz = ', read_climoz 3031 3052 WRITE(lunout,*) ' carbon_cycle_tr = ', carbon_cycle_tr -
LMDZ6/trunk/libf/phylmd/lscp_mod.F90
r4099 r4114 208 208 !$OMP THREADPRIVATE(rain_int_min) 209 209 210 LOGICAL, SAVE :: ok_radliq_precip=.false. ! Inclusion of all precipitation in radliq (cloud water seen by radiation)211 !$OMP THREADPRIVATE(ok_radliq_precip)212 213 214 210 215 211 … … 232 228 REAL qcloud(klon), icefrac_mpc(klon,klev), qincloud_mpc(klon) 233 229 REAL zrfl(klon), zrfln(klon), zqev, zqevt 234 REAL zifl(klon), zifln(klon), z qev0,zqevi, zqevti230 REAL zifl(klon), zifln(klon), ziflprev(klon),zqev0,zqevi, zqevti 235 231 REAL zoliq(klon), zcond(klon), zq(klon), zqn(klon) 236 232 REAL zoliql(klon), zoliqi(klon) 237 233 REAL zt(klon) 238 REAL zdz(klon),zrho(klon ),iwc(klon)234 REAL zdz(klon),zrho(klon,klev),iwc(klon) 239 235 REAL zchau,zfroi,zfice(klon),zneb(klon),znebprecip(klon) 240 236 REAL zmelt,zrain,zsnow,zprecip … … 335 331 CALL getin_p('seuil_neb',seuil_neb) 336 332 CALL getin_p('rain_int_min',rain_int_min) 337 CALL getin_p('ok_radliq_precip',ok_radliq_precip)338 333 WRITE(lunout,*) 'lscp, ninter:', ninter 339 334 WRITE(lunout,*) 'lscp, iflag_evap_prec:', iflag_evap_prec 340 335 WRITE(lunout,*) 'lscp, seuil_neb:', seuil_neb 341 336 WRITE(lunout,*) 'lscp, rain_int_min:', rain_int_min 342 WRITE(lunout,*) 'lscp, ok_radliq_precip:', ok_radliq_precip343 337 344 338 ! check for precipitation sub-time steps … … 390 384 rain(:) = 0.0 391 385 snow(:) = 0.0 392 zoliq(:)=0. 386 zoliq(:)=0.0 387 zfice(:)=0.0 388 dzfice(:)=0.0 389 zqprecl(:)=0.0 390 zqpreci(:)=0.0 393 391 zrfl(:) = 0.0 394 392 zifl(:) = 0.0 393 ziflprev(:)=0.0 395 394 zneb(:) = seuil_neb 396 395 zrflclr(:) = 0.0 … … 944 943 945 944 ! ---------------------------------------------------------------- 946 ! P3> Precipitation formation and calculation of condensed 947 ! water seen by the radiation scheme 945 ! P3> Precipitation formation 948 946 ! ---------------------------------------------------------------- 949 947 … … 1001 999 zoliqi(i)= zoliq(i)*zfice(i) 1002 1000 zoliql(i)= zoliq(i)*(1.-zfice(i)) 1003 zrho(i ) = pplay(i,k) / zt(i) / RD1004 zdz(i) = (paprs(i,k)-paprs(i,k+1)) / (zrho(i )*RG)1001 zrho(i,k) = pplay(i,k) / zt(i) / RD 1002 zdz(i) = (paprs(i,k)-paprs(i,k+1)) / (zrho(i,k)*RG) 1005 1003 iwc(i) = 0. 1006 1004 zneb(i) = MAX(rneb(i,k),seuil_neb) … … 1012 1010 1013 1011 ! ------------------------------------------------------------------------------- 1014 ! Iterations to calculate a "mean" cloud water content during the precipitation 1015 ! Comment: it is not the remaining water after precipitation but a mean 1016 ! remaining water in the cloud during the time step that is seen by the radiation 1012 ! Autoconversion 1017 1013 ! ------------------------------------------------------------------------------- 1018 1014 … … 1021 1017 DO i=1,klon 1022 1018 IF (rneb(i,k).GT.0.0) THEN 1023 iwc(i) = zrho(i ) * zoliqi(i) / zneb(i) ! in-cloud ice condensate content1019 iwc(i) = zrho(i,k) * zoliqi(i) / zneb(i) ! in-cloud ice condensate content 1024 1020 ENDIF 1025 1021 ENDDO 1026 1022 1027 CALL FALLICE_VELOCITY(klon,iwc(:),zt(:),zrho(: ),pplay(:,k),ptconv(:,k),velo(:,k))1023 CALL FALLICE_VELOCITY(klon,iwc(:),zt(:),zrho(:,k),pplay(:,k),ptconv(:,k),velo(:,k)) 1028 1024 1029 1025 DO i = 1, klon … … 1088 1084 1089 1085 1090 ! Include the contribution to non-evaporated precipitation to radliq1091 IF ((ok_radliq_precip) .AND. (k .LT. klev)) THEN1092 ! for rain drops, we assume a fallspeed of 5m/s1093 vr=5.01094 radliql(:,k)=radliql(:,k)+zrfl(:)/vr/zrho(:)1095 ! for ice crystals, we take the fallspeed from level above1096 radliqi(:,k)=radliqi(:,k)+zifl(:)/zrho(:)/velo(:,k+1)1097 radliq(:,k)=radliql(:,k)+radliqi(:,k)1098 ENDIF1099 1100 ! caculate the percentage of ice in "radliq" so cloud+precip seen by the radiation scheme1101 DO i=1,klon1102 IF (radliq(i,k) .GT. 0.) THEN1103 radicefrac(i,k)=MIN(MAX(radliqi(i,k)/radliq(i,k),0.),1.)1104 ENDIF1105 ENDDO1106 1107 1086 1108 1087 ! Precipitation flux calculation 1109 1088 1110 1089 DO i = 1, klon 1090 1091 1092 ziflprev(i)=zifl(i) 1111 1093 1112 1094 IF (rneb(i,k) .GT. 0.0) THEN … … 1144 1126 ! iced water budget 1145 1127 zqpreci(i) = max (zqpreci(i) - Deltaqprecl - Deltaq, 0.) 1146 1147 1128 1148 1129 IF (iflag_evap_prec.EQ.4) THEN … … 1163 1144 ENDIF ! rneb>0 1164 1145 1146 1165 1147 ENDDO 1148 1149 1150 1166 1151 1167 1152 ! LTP: limit of surface cloud fraction covered by precipitation when the local intensity of the flux is below rain_int_min … … 1189 1174 ENDIF 1190 1175 1191 ! --------------------------------1192 1176 ! End of precipitation formation 1193 1177 ! -------------------------------- … … 1205 1189 ENDDO 1206 1190 1191 ! Calculation of the concentration of condensates seen by the radiation scheme 1192 ! for liquid phase, we take radliql 1193 ! for ice phase, we take radliqi if we neglect snowfall, otherwise (ok_radliq_snow=true) 1194 ! we recaulate radliqi to account for contributions from the precipitation flux 1195 1196 1197 IF ((ok_radliq_snow) .AND. (k .LT. klev)) THEN 1198 ! for the solid phase (crystals + snowflakes) 1199 ! we recalculate radliqi by summing 1200 ! the ice content calculated in the mesh 1201 ! + the contribution of the non-evaporated snowfall 1202 ! from the overlying layer 1203 DO i=1,klon 1204 IF (ziflprev(i) .NE. 0.0) THEN 1205 radliqi(i,k)=zoliq(i)*zfice(i)+zqpreci(i)+ziflprev(i)/zrho(i,k+1)/velo(i,k+1) 1206 ELSE 1207 radliqi(i,k)=zoliq(i)*zfice(i)+zqpreci(i) 1208 ENDIF 1209 radliq(i,k)=radliql(i,k)+radliqi(i,k) 1210 ENDDO 1211 ENDIF 1212 1213 ! caculate the percentage of ice in "radliq" so cloud+precip seen by the radiation scheme 1214 DO i=1,klon 1215 IF (radliq(i,k) .GT. 0.) THEN 1216 radicefrac(i,k)=MIN(MAX(radliqi(i,k)/radliq(i,k),0.),1.) 1217 ENDIF 1218 ENDDO 1219 1220 1207 1221 1208 1222 ! ---------------------------------------------------------------- -
LMDZ6/trunk/libf/phylmd/newmicro.F90
r3999 r4114 3 3 SUBROUTINE newmicro(flag_aerosol, ok_cdnc, bl95_b0, bl95_b1, paprs, pplay, t, pqlwp, picefra, pclc, & 4 4 pcltau, pclemi, pch, pcl, pcm, pct, pctlwp, xflwp, xfiwp, xflwc, xfiwc, & 5 mass_solu_aero, mass_solu_aero_pi, pcldtaupi, re, fl, reliq, reice, &5 mass_solu_aero, mass_solu_aero_pi, pcldtaupi, latitude_deg,re, fl, reliq, reice, & 6 6 reliq_pi, reice_pi) 7 7 … … 31 31 32 32 ! t-------input-R-temperature 33 ! pqlwp---input-R-eau liquide nuageuse dans l'atmosphere dans la partie 34 ! nuageuse (kg/kg) 33 ! pqlwp---input-R-eau liquide nuageuse dans l'atmosphere dans la maille (kg/kg) 35 34 ! picefra--input-R-fraction de glace dans les nuages 36 35 ! pclc----input-R-couverture nuageuse pour le rayonnement (0 a 1) … … 41 40 ! bl95_b0-input-R-a PARAMETER, may be varied for tests (s-sea, l-land) 42 41 ! bl95_b1-input-R-a PARAMETER, may be varied for tests ( -"- ) 42 ! latitude_deg-input latitude in degrees 43 43 44 44 ! re------output-R-Cloud droplet effective radius multiplied by fl [um] … … 89 89 REAL pclemi(klon, klev) 90 90 REAL pcldtaupi(klon, klev) 91 REAL latitude_deg(klon) 91 92 92 93 REAL pct(klon) … … 128 129 REAL, PARAMETER :: t_glace_max_old = 273.13 129 130 130 REAL rel, tc, rei 131 REAL rel, tc, rei, iwc, dei, deimin, deimax 131 132 REAL k_ice0, k_ice, df 132 133 PARAMETER (k_ice0=0.005) ! units=m2/g … … 339 340 rhodz(i, k) 340 341 zfiwp_var = 1000.*zfice(i, k)*pqlwp(i, k)/pclc(i, k)*rhodz(i, k) 341 tc = t(i, k) - 273.15 342 rei = d_rei_dt*tc + rei_max 343 IF (tc<=-81.4) rei = rei_min 342 ! Calculation of ice cloud effective radius in micron 343 IF (iflag_rei .EQ. 1) THEN 344 ! when we account for precipitation in the radiation scheme, 345 ! It is recommended to use the rei formula from Sun and Rikkus 1999 with a revision 346 ! from Sun 2001 (as in the IFS model) 347 iwc=zfice(i, k)*pqlwp(i, k)/pclc(i,k)*zrho(i,k)*1000. !in cloud ice water content in g/m3 348 dei=(1.2351+0.0105*(t(i,k)-273.15))*(45.8966*(iwc**0.2214) + & 349 & 0.7957*(iwc**0.2535)*(t(i,k)-83.15)) 350 !deimax=155.0 351 !deimin=20.+40*cos(abs(latitude_deg(i))/180.*RPI) 352 !Etienne: deimax and deimin controled by rei_max and rei_min in physiq.def 353 deimax=rei_max*2.0 354 deimin=2.0*rei_min+40*cos(abs(latitude_deg(i))/180.*RPI) 355 dei=min(dei,deimax) 356 dei=max(dei,deimin) 357 rei=3.*sqrt(3.)/8.*dei 358 ELSE 359 ! Default 360 ! for ice clouds: as a function of the ambiant temperature 361 ! [formula used by Iacobellis and Somerville (2000), with an 362 ! asymptotical value of 3.5 microns at T<-81.4 C added to be 363 ! consistent with observations of Heymsfield et al. 1986]: 364 ! 2011/05/24 : rei_min = 3.5 becomes a free PARAMETER as well as 365 ! rei_max=61.29 366 tc = t(i, k) - 273.15 367 rei = d_rei_dt*tc + rei_max 368 IF (tc<=-81.4) rei = rei_min 369 ENDIF 344 370 345 371 ! -- cloud optical thickness : … … 419 445 rel = rad_chaud(i, k) 420 446 421 ! for ice clouds: as a function of the ambiant temperature 422 ! [formula used by Iacobellis and Somerville (2000), with an 423 ! asymptotical value of 3.5 microns at T<-81.4 C added to be 424 ! consistent with observations of Heymsfield et al. 1986]: 425 ! 2011/05/24 : rei_min = 3.5 becomes a free PARAMETER as well as 426 ! rei_max=61.29 427 428 tc = t(i, k) - 273.15 429 rei = d_rei_dt*tc + rei_max 430 IF (tc<=-81.4) rei = rei_min 431 447 ! Calculation of ice cloud effective radius in micron 448 449 450 IF (iflag_rei .GT. 0) THEN 451 452 ! when we account for precipitation in the radiation scheme, 453 ! we use the rei formula from Sun and Rikkus 1999 with a revision 454 ! from Sun 2001 (as in the IFS model) 455 iwc=zfice(i, k)*pqlwp(i, k)/pclc(i,k)*zrho(i,k)*1000. !in cloud ice water content in g/m3 456 dei=(1.2351+0.0105*(t(i,k)-273.15))*(45.8966*(iwc**0.2214) + & 457 &0.7957*(iwc**0.2535)*(t(i,k)-83.15)) 458 459 deimax=155.0 460 deimin=20.+40*cos(abs(latitude_deg(i))/180.*RPI) 461 dei=min(dei,deimax) 462 dei=max(dei,deimin) 463 rei=3.*sqrt(3.)/8.*dei 464 465 ELSE 466 ! Default 467 ! for ice clouds: as a function of the ambiant temperature 468 ! [formula used by Iacobellis and Somerville (2000), with an 469 ! asymptotical value of 3.5 microns at T<-81.4 C added to be 470 ! consistent with observations of Heymsfield et al. 1986]: 471 ! 2011/05/24 : rei_min = 3.5 becomes a free PARAMETER as well as 472 ! rei_max=61.29 473 tc = t(i, k) - 273.15 474 rei = d_rei_dt*tc + rei_max 475 IF (tc<=-81.4) rei = rei_min 476 ENDIF 432 477 ! -- cloud optical thickness : 433 478 ! [for liquid clouds, traditional formula, -
LMDZ6/trunk/libf/phylmd/nuage.h
r3999 r4114 12 12 INTEGER iflag_rain_incloud_vol 13 13 14 INTEGER iflag_mpc_bl, iflag_gammasat, iflag_vice 15 LOGICAL ok_icefra_lscp 14 INTEGER iflag_mpc_bl, iflag_gammasat, iflag_vice, iflag_rei 15 LOGICAL ok_icefra_lscp, ok_radliq_snow 16 16 17 17 common /nuagecom/ rad_froid,rad_chau1, rad_chau2,t_glace_max, & … … 21 21 & iflag_t_glace,iflag_cloudth_vert,iflag_cld_cv, & 22 22 & iflag_rain_incloud_vol, & 23 & ok_icefra_lscp, & 24 & iflag_mpc_bl, iflag_gammasat, iflag_vice 23 & ok_icefra_lscp,ok_radliq_snow, & 24 & iflag_mpc_bl, iflag_gammasat, iflag_vice, & 25 & iflag_rei 25 26 !$OMP THREADPRIVATE(/nuagecom/) -
LMDZ6/trunk/libf/phylmd/phys_local_var_mod.F90
r4072 r4114 438 438 REAL,ALLOCATABLE,SAVE,DIMENSION(:,:) :: cldemi, cldfra, cldtau, fiwc, fl, re, flwc 439 439 !$OMP THREADPRIVATE(cldemi, cldfra, cldtau, fiwc, fl, re, flwc) 440 REAL,ALLOCATABLE,SAVE,DIMENSION(:,:) :: qlth, qith, qsith 440 REAL,ALLOCATABLE,SAVE,DIMENSION(:,:) :: qlth, qith, qsith, with 441 441 !$OMP THREADPRIVATE(qlth, qith, qsith) 442 442 REAL,ALLOCATABLE,SAVE,DIMENSION(:,:) :: ref_liq, ref_ice, theta, zphi … … 778 778 ALLOCATE(rain_lsc(klon)) 779 779 ALLOCATE(rain_num(klon)) 780 ALLOCATE(qlth(klon,klev), qith(klon,klev), qsith(klon,klev) )780 ALLOCATE(qlth(klon,klev), qith(klon,klev), qsith(klon,klev), with(klon,klev)) 781 781 ! 782 782 ALLOCATE(sens_x(klon), sens_w(klon)) … … 1089 1089 DEALLOCATE(rain_lsc) 1090 1090 DEALLOCATE(rain_num) 1091 DEALLOCATE(qlth, qith, qsith )1091 DEALLOCATE(qlth, qith, qsith, with) 1092 1092 ! 1093 1093 DEALLOCATE(sens_x, sens_w) -
LMDZ6/trunk/libf/phylmd/physiq_mod.F90
r4098 r4114 4125 4125 flwp, fiwp, flwc, fiwc, & 4126 4126 mass_solu_aero, mass_solu_aero_pi, & 4127 cldtaupi, re, fl, ref_liq, ref_ice, &4127 cldtaupi, latitude_deg, re, fl, ref_liq, ref_ice, & 4128 4128 ref_liq_pi, ref_ice_pi) 4129 4129 ELSE
Note: See TracChangeset
for help on using the changeset viewer.