Changeset 4412


Ignore:
Timestamp:
Feb 1, 2023, 5:35:29 PM (16 months ago)
Author:
evignon
Message:

travail de l'atelier nuages du 30/01/23: on renomme cldliq (ou radliq) en radocond
car le nom est tres trompeur + on ajoute des commentaires dans lscp_mod

Location:
LMDZ6/trunk
Files:
9 edited

Legend:

Unmodified
Added
Removed
  • LMDZ6/trunk/DefLists/field_def_lmdz.xml

    r4248 r4412  
    583583        <field id="concdust"    long_name="Concentration of Dust "    unit="kg/m3" />
    584584        <field id="ec550aer"    long_name="Extinction at 550nm"    unit="m^-1" />
    585         <field id="lwcon"    long_name="Cloud liquid water content"    unit="kg/kg" />
    586         <field id="iwcon"    long_name="Cloud ice water content"    unit="kg/kg" />
     585        <field id="lwcon"    long_name="Cloud liquid water content seen by radiation"    unit="kg/kg" />
     586        <field id="iwcon"    long_name="Cloud ice water content seen by radiation"    unit="kg/kg" />
    587587        <field id="temp"    long_name="Air temperature"    unit="K" />
    588588        <field id="theta"    long_name="Potential air temperature"    unit="K" />
  • LMDZ6/trunk/libf/phylmd/lscp_ini_mod.F90

    r4380 r4412  
    3535  !$OMP THREADPRIVATE(iflag_mpc_bl)
    3636 
    37   LOGICAL, SAVE :: ok_radliq_snow=.false.       ! take into account the mass of ice precip in the cloud ice content seen by radiation
    38   !$OMP THREADPRIVATE(ok_radliq_snow)
     37  LOGICAL, SAVE :: ok_radocond_snow=.false.       ! take into account the mass of ice precip in the cloud ice content seen by radiation
     38  !$OMP THREADPRIVATE(ok_radocond_snow)
    3939
    4040
     
    5656    CALL getin_p('rain_int_min',rain_int_min)
    5757    CALL getin_p('iflag_mpc_bl',iflag_mpc_bl)
    58     CALL getin_p('ok_radliq_snow',ok_radliq_snow)         
     58    CALL getin_p('ok_radocond_snow',ok_radocond_snow)         
    5959    WRITE(lunout,*) 'lscp, ninter:', ninter
    6060    WRITE(lunout,*) 'lscp, iflag_evap_prec:', iflag_evap_prec
     
    6262    WRITE(lunout,*) 'lscp, rain_int_min:', rain_int_min
    6363    WRITE(lunout,*) 'lscp, iflag_mpc_bl:', iflag_mpc_bl
    64     WRITE(lunout,*) 'lscp, ok_radliq_snow:', ok_radliq_snow
     64    WRITE(lunout,*) 'lscp, ok_radocond_snow:', ok_radocond_snow
    6565   
    6666    ! check for precipitation sub-time steps
  • LMDZ6/trunk/libf/phylmd/lscp_mod.F90

    r4397 r4412  
    99     paprs,pplay,t,q,ptconv,ratqs,                      &
    1010     d_t, d_q, d_ql, d_qi, rneb, rneblsvol, rneb_seri,  &
    11      radliq, radicefrac, rain, snow,                    &
     11     radocond, radicefrac, rain, snow,                    &
    1212     frac_impa, frac_nucl, beta,                        &
    1313     prfl, psfl, rhcl, zqta, fraca,                     &
     
    4141! References:
    4242!
     43! - Bony, S., & Emanuel, K. A. 2001, JAS, doi: 10.1175/1520-0469(2001)058<3158:APOTCA>2.0.CO;2
    4344! - Hourdin et al. 2013, Clim Dyn, doi:10.1007/s00382-012-1343-y
    4445! - Jam et al. 2013, Boundary-Layer Meteorol, doi:10.1007/s10546-012-9789-3
     46! - Jouhaud, et al. 2018. JAMES, doi:10.1029/2018MS001379
    4547! - Madeleine et al. 2020, JAMES, doi:10.1029/2020MS002046
     48! - Touzze-Peifert Ludo, PhD thesis, p117-124
    4649! -------------------------------------------------------------------------------
    4750! Code structure:
     
    5053! P1>     Evaporation of the precipitation (falling from the k+1 level)
    5154! P2>     Cloud formation (at the k level)
    52 ! P2.A.0> Cloud properties calculation from a rectangular pdf
    53 ! P2.A.1> With the new PDFs, calculation of cloud properties using the inital
     55! P2.A.1> With the PDFs, calculation of cloud properties using the inital
    5456!         values of T and Q
    5557! P2.A.2> Coupling between condensed water and temperature
    5658! P2.A.3> Calculation of final quantities associated with cloud formation
    57 ! P2.B>   'All or nothing' cloud
    58 ! P2.C>   Release of Latent heat after cloud formation
     59! P2.B>   Release of Latent heat after cloud formation
    5960! P3>     Autoconversion to precipitation (k-level)
    6061! P4>     Wet scavenging
     
    6566! water used in the physics and the dynamics
    6667!
    67 ! During the autoconversion to precipitation (P3 step), radliq (cloud water used
     68! During the autoconversion to precipitation (P3 step), radocond (cloud water used
    6869! by the radiation scheme) is calculated as an average of the water that remains
    6970! in the cloud during the precipitation and not the water remaining at the end
     
    7576! Radiation:
    7677! xflwc(newmicro)+xfiwc(newmicro) =
    77 !   cldliq(physiq)=radliq(fisrt)=lwcon(nc)+iwcon(nc)
     78!   radocond=lwcon(nc)+iwcon(nc)
    7879!
    7980! Notetheless, be aware of:
    8081!
    81 ! radliq(fisrt) .NE. ocond(nc)
     82! radocond .NE. ocond(nc)
    8283! i.e.:
    8384! lwcon(nc)+iwcon(nc) .NE. ocond(nc)
     85! but oliq+(ocond-oliq) .EQ. ocond
    8486! (which is not trivial)
    8587!++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++
     
    9193
    9294USE lscp_ini_mod, ONLY : seuil_neb, ninter, iflag_evap_prec, t_coup, DDT0, ztfondue, rain_int_min
    93 USE lscp_ini_mod, ONLY : iflag_mpc_bl, ok_radliq_snow, a_tr_sca
     95USE lscp_ini_mod, ONLY : iflag_mpc_bl, ok_radocond_snow, a_tr_sca
    9496
    9597
     
    115117  REAL, DIMENSION(klon,klev),      INTENT(IN)   :: pplay           ! mid-layer pressure [Pa]
    116118  REAL, DIMENSION(klon,klev),      INTENT(IN)   :: t               ! temperature (K)
    117   REAL, DIMENSION(klon,klev),      INTENT(IN)   :: q               ! specific humidity [kg/kg]
     119  REAL, DIMENSION(klon,klev),      INTENT(IN)   :: q               ! total specific humidity (= vapor phase) [kg/kg]
    118120  INTEGER,                         INTENT(IN)   :: iflag_cld_th    ! flag that determines the distribution of convective clouds
    119121  INTEGER,                         INTENT(IN)   :: iflag_ice_thermo! flag to activate the ice thermodynamics
     
    152154  REAL, DIMENSION(klon,klev),      INTENT(OUT)  :: rneb             ! cloud fraction [-]
    153155  REAL, DIMENSION(klon,klev),      INTENT(OUT)  :: rneblsvol        ! cloud fraction per unit volume [-] 
    154   REAL, DIMENSION(klon,klev),      INTENT(OUT)  :: radliq           ! condensed water used in the radiation scheme [kg/kg]
     156  REAL, DIMENSION(klon,klev),      INTENT(OUT)  :: radocond         ! condensed water used in the radiation scheme [kg/kg]
    155157  REAL, DIMENSION(klon,klev),      INTENT(OUT)  :: radicefrac       ! ice fraction of condensed water for radiation scheme
    156158  REAL, DIMENSION(klon,klev),      INTENT(OUT)  :: rhcl             ! clear-sky relative humidity [-]
    157   REAL, DIMENSION(klon),           INTENT(OUT)  :: rain             ! large-scale rainfall [kg/s/m2]
    158   REAL, DIMENSION(klon),           INTENT(OUT)  :: snow             ! large-scale snowfall [kg/s/m2]
     159  REAL, DIMENSION(klon),           INTENT(OUT)  :: rain             ! surface large-scale rainfall [kg/s/m2]
     160  REAL, DIMENSION(klon),           INTENT(OUT)  :: snow             ! surface large-scale snowfall [kg/s/m2]
    159161  REAL, DIMENSION(klon,klev),      INTENT(OUT)  :: qsatl            ! saturation specific humidity wrt liquid [kg/kg]
    160162  REAL, DIMENSION(klon,klev),      INTENT(OUT)  :: qsats            ! saturation specific humidity wrt ice [kg/kg] 
     
    231233  REAL velo(klon,klev), vr
    232234  REAL qlmpc, qimpc, rnebmpc
    233   REAL radliqi(klon,klev), radliql(klon,klev)
     235  REAL radocondi(klon,klev), radocondl(klon,klev)
    234236
    235237  INTEGER i, k, n, kk
     
    295297d_qi(:,:) = 0.0
    296298rneb(:,:) = 0.0
    297 radliq(:,:) = 0.0
     299radocond(:,:) = 0.0
    298300radicefrac(:,:) = 0.0
    299301frac_nucl(:,:) = 1.0
     
    350352    ! P0> Thermalization of precipitation falling from the overlying layer
    351353    ! --------------------------------------------------------------------
    352     ! Computes air temperature variation due to latent heat transported by
     354    ! Computes air temperature variation due to enthalpy transported by
    353355    ! precipitation. Precipitation is then thermalized with the air in the
    354356    ! layer.
    355357    ! The precipitation should remain thermalized throughout the different
    356     ! thermodynamical transformations. The corresponding water mass should
     358    ! thermodynamical transformations.
     359    ! The corresponding water mass should
    357360    ! be added when calculating the layer's enthalpy change with
    358361    ! temperature
     362    ! See lmdzpedia page todoan
     363    ! todoan: check consistency with ice phase
     364    ! todoan: understand why several steps
    359365    ! ---------------------------------------------------------------------
    360366   
     
    409415            IF (zrfl(i)+zifl(i).GT.0.) THEN
    410416
    411             ! LTP: we only account for precipitation evaporation in the clear-sky (iflag_evap_prec=4).
     417            ! LudoTP: we only account for precipitation evaporation in the clear-sky (iflag_evap_prec=4).
    412418            ! c_iso: likely important to distinguish cs from neb isotope precipitation
    413419
     
    475481                ! redistribute zqev0 conserving the ratio liquid/ice
    476482
     483                ! todoan: check the consistency of this formula
    477484                IF (zqevt+zqevti.GT.zqev0) THEN
    478485                    zqev=zqev0*zqevt/(zqevt+zqevti)
     
    494501                zq(i) = zq(i) - (zrfln(i)+zifln(i)-zrfl(i)-zifl(i)) &
    495502                * (RG/(paprs(i,k)-paprs(i,k+1)))*dtime
     503
    496504                ! precip thermalization
    497505                zmqc(i) = zmqc(i) + (zrfln(i)+zifln(i)-zrfl(i)-zifl(i)) &
     
    525533
    526534                ! Melting:
    527                 zmelt = ((zt(i)-273.15)/(ztfondue-273.15)) ! JYG
     535                zmelt = ((zt(i)-RTT)/(ztfondue-RTT)) ! JYG
    528536                ! precip fraction that is melted
    529537                zmelt = MIN(MAX(zmelt,0.),1.)
    530538
    531                 ! Ice melting
     539                ! update of rainfall and snowfall due to melting
    532540                IF (iflag_evap_prec.EQ.4) THEN
    533541                    zrflclr(i)=zrflclr(i)+zmelt*ziflclr(i)
    534542                    zrflcld(i)=zrflcld(i)+zmelt*ziflcld(i)
    535543                    zrfl(i)=zrflclr(i)+zrflcld(i)
     544
     545                    ziflclr(i)=ziflclr(i)*(1.-zmelt)
     546                    ziflcld(i)=ziflcld(i)*(1.-zmelt)
     547                    zifl(i)=ziflclr(i)+ziflcld(i)
     548
    536549                ELSE
    537550                    zrfl(i)=zrfl(i)+zmelt*zifl(i)
    538                 ENDIF
     551
     552                    zifl(i)=zifl(i)*(1.-zmelt)
     553                ENDIF
     554
     555
    539556                ! c_iso: melting of isotopic precipi with zmelt (no fractionation)
    540557
     
    543560                *RLMLT/RCPD/(1.0+RVTMP2*(zq(i)+zmqc(i)))
    544561               
    545                 IF (iflag_evap_prec.EQ.4) THEN
    546                     ziflclr(i)=ziflclr(i)*(1.-zmelt)
    547                     ziflcld(i)=ziflcld(i)*(1.-zmelt)
    548                     zifl(i)=ziflclr(i)+ziflcld(i)
    549                 ELSE
    550                     zifl(i)=zifl(i)*(1.-zmelt)
    551                 ENDIF
    552                 !c_iso: same for isotopic precip.
    553562
    554563            ELSE
     
    908917    ENDIF
    909918
    910     ! Initialisation of zoliq and radliq variables
     919    ! Initialisation of zoliq and radocond variables
    911920
    912921    DO i = 1, klon
     
    919928            iwc(i)   = 0.
    920929            zneb(i)  = MAX(rneb(i,k),seuil_neb)
    921             radliq(i,k) = zoliq(i)/REAL(ninter+1)
     930            radocond(i,k) = zoliq(i)/REAL(ninter+1)
    922931            radicefrac(i,k) = zfice(i)
    923             radliqi(i,k)=zoliq(i)*zfice(i)/REAL(ninter+1)
    924             radliql(i,k)=zoliq(i)*(1.-zfice(i))/REAL(ninter+1)
     932            radocondi(i,k)=zoliq(i)*zfice(i)/REAL(ninter+1)
     933            radocondl(i,k)=zoliq(i)*(1.-zfice(i))/REAL(ninter+1)
    925934    ENDDO
    926935
     
    9921001                ! c_iso: call isotope_conversion (for readibility) or duplicate
    9931002
    994                 radliq(i,k) = radliq(i,k) + zoliq(i)/REAL(ninter+1)
    995                 radliql(i,k) = radliql(i,k) + zoliql(i)/REAL(ninter+1)
    996                 radliqi(i,k) = radliqi(i,k) + zoliqi(i)/REAL(ninter+1)
     1003                radocond(i,k) = radocond(i,k) + zoliq(i)/REAL(ninter+1)
     1004                radocondl(i,k) = radocondl(i,k) + zoliql(i)/REAL(ninter+1)
     1005                radocondi(i,k) = radocondi(i,k) + zoliqi(i)/REAL(ninter+1)
    9971006
    9981007            ENDIF ! rneb >0
     
    11091118
    11101119    ! Calculation of the concentration of condensates seen by the radiation scheme
    1111     ! for liquid phase, we take radliql
    1112     ! for ice phase, we take radliqi if we neglect snowfall, otherwise (ok_radliq_snow=true)
    1113     ! we recaulate radliqi to account for contributions from the precipitation flux
    1114 
    1115     IF ((ok_radliq_snow) .AND. (k .LT. klev)) THEN
     1120    ! for liquid phase, we take radocondl
     1121    ! for ice phase, we take radocondi if we neglect snowfall, otherwise (ok_radocond_snow=true)
     1122    ! we recaulate radocondi to account for contributions from the precipitation flux
     1123
     1124    IF ((ok_radocond_snow) .AND. (k .LT. klev)) THEN
    11161125        ! for the solid phase (crystals + snowflakes)
    1117         ! we recalculate radliqi by summing
     1126        ! we recalculate radocondi by summing
    11181127        ! the ice content calculated in the mesh
    11191128        ! + the contribution of the non-evaporated snowfall
     
    11211130        DO i=1,klon
    11221131           IF (ziflprev(i) .NE. 0.0) THEN
    1123               radliqi(i,k)=zoliq(i)*zfice(i)+zqpreci(i)+ziflprev(i)/zrho(i,k+1)/velo(i,k+1)
     1132              radocondi(i,k)=zoliq(i)*zfice(i)+zqpreci(i)+ziflprev(i)/zrho(i,k+1)/velo(i,k+1)
    11241133           ELSE
    1125               radliqi(i,k)=zoliq(i)*zfice(i)+zqpreci(i)
     1134              radocondi(i,k)=zoliq(i)*zfice(i)+zqpreci(i)
    11261135           ENDIF
    1127            radliq(i,k)=radliql(i,k)+radliqi(i,k)
     1136           radocond(i,k)=radocondl(i,k)+radocondi(i,k)
    11281137        ENDDO
    11291138    ENDIF
    11301139
    1131     ! caculate the percentage of ice in "radliq" so cloud+precip seen by the radiation scheme
     1140    ! caculate the percentage of ice in "radocond" so cloud+precip seen by the radiation scheme
    11321141    DO i=1,klon
    1133         IF (radliq(i,k) .GT. 0.) THEN
    1134             radicefrac(i,k)=MIN(MAX(radliqi(i,k)/radliq(i,k),0.),1.)
     1142        IF (radocond(i,k) .GT. 0.) THEN
     1143            radicefrac(i,k)=MIN(MAX(radocondi(i,k)/radocond(i,k),0.),1.)
    11351144        ENDIF
    11361145    ENDDO
  • LMDZ6/trunk/libf/phylmd/phys_output_ctrlout_mod.F90

    r4059 r4412  
    14131413    'ec550aer', 'Extinction at 550nm', 'm^-1', (/ ('', i=1, 10) /))
    14141414  TYPE(ctrl_out), SAVE :: o_lwcon = ctrl_out((/ 2, 5, 10, 10, 10, 10, 11, 11, 11, 11/), &
    1415     'lwcon', 'Cloud liquid water content', 'kg/kg', (/ ('', i=1, 10) /))
     1415    'lwcon', 'Cloud liquid water content seen by radiation', 'kg/kg', (/ ('', i=1, 10) /))
    14161416  TYPE(ctrl_out), SAVE :: o_iwcon = ctrl_out((/ 2, 5, 10, 10, 10, 10, 11, 11, 11, 11/), &
    1417     'iwcon', 'Cloud ice water content', 'kg/kg', (/ ('', i=1, 10) /))
     1417    'iwcon', 'Cloud ice water content seen by radiation', 'kg/kg', (/ ('', i=1, 10) /))
    14181418  TYPE(ctrl_out), SAVE :: o_temp = ctrl_out((/ 2, 3, 4, 10, 10, 10, 11, 11, 11, 11/), &
    14191419    'temp', 'Air temperature', 'K', (/ ('', i=1, 10) /))
  • LMDZ6/trunk/libf/phylmd/physiq_mod.F90

    r4389 r4412  
    827827    REAL dialiq(klon,klev)  ! eau liquide nuageuse
    828828    REAL diafra(klon,klev)  ! fraction nuageuse
    829     REAL cldliq(klon,klev)  ! eau liquide nuageuse
     829    REAL radocond(klon,klev)  ! eau condensee nuageuse
    830830    !
    831831    !XXX PB
     
    36373637         t_seri, q_seri,ptconv,ratqs, &
    36383638         d_t_lsc, d_q_lsc, d_ql_lsc, d_qi_lsc, rneb, rneblsvol, rneb_seri, &
    3639          cldliq, picefra, rain_lsc, snow_lsc, &
     3639         radocond, picefra, rain_lsc, snow_lsc, &
    36403640         frac_impa, frac_nucl, beta_prec_fisrt, &
    36413641         prfl, psfl, rhcl,  &
     
    36493649    CALL fisrtilp(phys_tstep,paprs,pplay, &
    36503650         t_seri, q_seri,ptconv,ratqs, &
    3651          d_t_lsc, d_q_lsc, d_ql_lsc, d_qi_lsc, rneb, cldliq, &
     3651         d_t_lsc, d_q_lsc, d_ql_lsc, d_qi_lsc, rneb, radocond, &
    36523652         rain_lsc, snow_lsc, &
    36533653         pfrac_impa, pfrac_nucl, pfrac_1nucl, &
     
    36963696          cldfra(i,k) = rneb(i,k)
    36973697          !CR: a quoi ca sert? Faut-il ajouter qs_seri?
    3698           IF (.NOT.new_oliq) cldliq(i,k) = ql_seri(i,k)
     3698          IF (.NOT.new_oliq) radocond(i,k) = ql_seri(i,k)
    36993699       ENDDO
    37003700    ENDDO
     
    37603760          DO i = 1, klon
    37613761             IF (diafra(i,k).GT.cldfra(i,k)) THEN
    3762                 cldliq(i,k) = dialiq(i,k)
     3762                radocond(i,k) = dialiq(i,k)
    37633763                cldfra(i,k) = diafra(i,k)
    37643764             ENDIF
     
    37973797                DO i=1,klon
    37983798                   IF (ptconv(i,k).AND.ptconvth(i,k)) THEN
    3799                       cldliq(i,k)=cldliq(i,k)+rnebcon(i,k)*clwcon(i,k)
     3799                      radocond(i,k)=radocond(i,k)+rnebcon(i,k)*clwcon(i,k)
    38003800                      cldfra(i,k)=min(cldfra(i,k)+rnebcon(i,k),1.)
    38013801                   ELSE IF (ptconv(i,k)) THEN
    38023802                      cldfra(i,k)=rnebcon(i,k)
    3803                       cldliq(i,k)=rnebcon(i,k)*clwcon(i,k)
     3803                      radocond(i,k)=rnebcon(i,k)*clwcon(i,k)
    38043804                   ENDIF
    38053805                ENDDO
     
    38103810                DO i=1,klon
    38113811                   cldfra(i,k)=min(cldfra(i,k)+rnebcon(i,k),1.)
    3812                    cldliq(i,k)=cldliq(i,k)+rnebcon(i,k)*clwcon(i,k)
     3812                   radocond(i,k)=radocond(i,k)+rnebcon(i,k)*clwcon(i,k)
    38133813                ENDDO
    38143814             ENDDO
     
    38283828                   IF (ptconv(i,k).AND. .NOT.ptconvth(i,k)) THEN
    38293829                      cldfra(i,k)=rnebcon(i,k)
    3830                       cldliq(i,k)=rnebcon(i,k)*clwcon(i,k)
     3830                      radocond(i,k)=rnebcon(i,k)*clwcon(i,k)
    38313831                   ENDIF
    38323832                ENDDO
     
    38393839          ! Ancienne version
    38403840          cldfra(:,:)=min(max(cldfra(:,:),rnebcon(:,:)),1.)
    3841           cldliq(:,:)=cldliq(:,:)+rnebcon(:,:)*clwcon(:,:)
     3841          radocond(:,:)=radocond(:,:)+rnebcon(:,:)*clwcon(:,:)
    38423842       ENDIF
    38433843
     
    38593859          DO i = 1, klon
    38603860             IF (diafra(i,k).GT.cldfra(i,k)) THEN
    3861                 cldliq(i,k) = dialiq(i,k)
     3861                radocond(i,k) = dialiq(i,k)
    38623862                cldfra(i,k) = diafra(i,k)
    38633863             ENDIF
     
    41684168          ENDIF
    41694169          CALL newmicro (flag_aerosol, ok_cdnc, bl95_b0, bl95_b1, &
    4170                paprs, pplay, t_seri, cldliq, picefra, cldfra, &
     4170               paprs, pplay, t_seri, radocond, picefra, cldfra, &
    41714171               cldtau, cldemi, cldh, cldl, cldm, cldt, cldq, &
    41724172               flwp, fiwp, flwc, fiwc, &
     
    41764176       ELSE
    41774177          CALL nuage (paprs, pplay, &
    4178                t_seri, cldliq, picefra, cldfra, cldtau, cldemi, &
     4178               t_seri, radocond, picefra, cldfra, cldtau, cldemi, &
    41794179               cldh, cldl, cldm, cldt, cldq, &
    41804180               ok_aie, &
     
    50035003         presnivs, pphis,     pphi,     albsol1, &
    50045004         sh_in,   ch_in,    rhcl,      cldfra,   rneb, &
    5005          diafra,   cldliq,    itop_con, ibas_con, &
     5005         diafra,   radocond,    itop_con, ibas_con, &
    50065006         pmflxr,   pmflxs,    prfl,     psfl, &
    50075007         da,       phi,       mp,       upwd, &
  • LMDZ6/trunk/libf/phylmd/phytrac_mod.F90

    r4389 r4412  
    184184    REAL,DIMENSION(klon),INTENT(IN)        :: pphis
    185185    REAL,DIMENSION(klev),INTENT(IN)        :: presnivs
    186     REAL,DIMENSION(klon,klev),INTENT(IN)   :: cldliq  ! eau liquide nuageuse
     186    REAL,DIMENSION(klon,klev),INTENT(IN)   :: cldliq  ! eau condensee totale
    187187    REAL,DIMENSION(klon,klev),INTENT(IN)   :: cldfra  ! fraction nuageuse (tous les nuages)
    188188    REAL,DIMENSION(klon,klev),INTENT(IN)   :: diafra  ! fraction nuageuse (convection ou stratus artificiels)
  • LMDZ6/trunk/libf/phylmd/tracinca_mod.F90

    r4389 r4412  
    8989    REAL,DIMENSION(klon,klev),INTENT(IN)   :: pphi    ! geopotentiel
    9090    REAL,DIMENSION(klon),INTENT(IN)        :: pphis
    91     REAL,DIMENSION(klon,klev),INTENT(IN)   :: cldliq  ! eau liquide nuageuse
     91    REAL,DIMENSION(klon,klev),INTENT(IN)   :: cldliq  ! eau condensee pour le radiatif
    9292    REAL,DIMENSION(klon,klev),INTENT(IN)   :: cldfra  ! fraction nuageuse (tous les nuages)
    9393    REAL,DIMENSION(klon,klev),INTENT(IN)   :: diafra  ! fraction nuageuse (convection ou stratus artificiels)
  • LMDZ6/trunk/libf/phylmd/write_bilKP_ave.h

    r3102 r4412  
    4949      CALL histwrite_phy(nid_bilKPave,"play",itau_w,paprs)
    5050c
    51 cym      CALL gr_fi_ecrit(klev,klon,iim,jjmp1, cldliq, zx_tmp_3d)
     51cym      CALL gr_fi_ecrit(klev,klon,iim,jjmp1, radocond, zx_tmp_3d)
    5252      CALL histwrite_phy(nid_bilKPave,"oliq",itau_w,cldliq)
    5353c
  • LMDZ6/trunk/libf/phylmd/write_bilKP_ins.h

    r3102 r4412  
    4949      CALL histwrite_phy(nid_bilKPins,"play",itau_w,paprs)
    5050c
    51 cym      CALL gr_fi_ecrit(klev,klon,iim,jjmp1, cldliq, zx_tmp_3d)
     51cym      CALL gr_fi_ecrit(klev,klon,iim,jjmp1, radocond, zx_tmp_3d)
    5252      CALL histwrite_phy(nid_bilKPins,"oliq",itau_w,cldliq)
    5353c
Note: See TracChangeset for help on using the changeset viewer.