/[lmdze]/trunk/phylmd/physiq.f90
ViewVC logotype

Diff of /trunk/phylmd/physiq.f90

Parent Directory Parent Directory | Revision Log Revision Log | View Patch Patch

trunk/phylmd/physiq.f revision 307 by guez, Tue Sep 11 12:52:28 2018 UTC trunk/phylmd/physiq.f90 revision 338 by guez, Mon Sep 16 17:25:30 2019 UTC
# Line 29  contains Line 29  contains
29      USE conf_gcm_m, ONLY: lmt_pas      USE conf_gcm_m, ONLY: lmt_pas
30      USE conf_phys_m, ONLY: conf_phys      USE conf_phys_m, ONLY: conf_phys
31      use conflx_m, only: conflx      use conflx_m, only: conflx
32      USE ctherm, ONLY: iflag_thermals, nsplit_thermals      USE ctherm_m, ONLY: iflag_thermals, ctherm
33      use diagcld2_m, only: diagcld2      use diagcld2_m, only: diagcld2
34      USE dimensions, ONLY: llm, nqmx      USE dimensions, ONLY: llm, nqmx
35      USE dimphy, ONLY: klon      USE dimphy, ONLY: klon
36      USE dimsoil, ONLY: nsoilmx      USE dimsoil, ONLY: nsoilmx
37      use drag_noro_m, only: drag_noro      use drag_noro_m, only: drag_noro
38      use dynetat0_m, only: day_ref, annee_ref      use dynetat0_chosen_m, only: day_ref, annee_ref
39      USE fcttre, ONLY: foeew      USE fcttre, ONLY: foeew
40      use fisrtilp_m, only: fisrtilp      use fisrtilp_m, only: fisrtilp
41      USE hgardfou_m, ONLY: hgardfou      USE hgardfou_m, ONLY: hgardfou
42      USE histsync_m, ONLY: histsync      USE histsync_m, ONLY: histsync
43      USE histwrite_phy_m, ONLY: histwrite_phy      USE histwrite_phy_m, ONLY: histwrite_phy
44      USE indicesol, ONLY: clnsurf, epsfra, is_lic, is_oce, is_sic, is_ter, &      USE indicesol, ONLY: clnsurf, epsfra, nbsrf
          nbsrf  
45      USE ini_histins_m, ONLY: ini_histins, nid_ins      USE ini_histins_m, ONLY: ini_histins, nid_ins
46      use lift_noro_m, only: lift_noro      use lift_noro_m, only: lift_noro
47      use netcdf95, only: NF95_CLOSE      use netcdf95, only: NF95_CLOSE
48      use newmicro_m, only: newmicro      use newmicro_m, only: newmicro
49      use nr_util, only: assert      use nr_util, only: assert
     use nuage_m, only: nuage  
50      USE orbite_m, ONLY: orbite      USE orbite_m, ONLY: orbite
51      USE ozonecm_m, ONLY: ozonecm      USE ozonecm_m, ONLY: ozonecm
52      USE phyetat0_m, ONLY: phyetat0      USE phyetat0_m, ONLY: phyetat0
# Line 144  contains Line 142  contains
142      ! Radiative transfer computations are made every "radpas" call to      ! Radiative transfer computations are made every "radpas" call to
143      ! "physiq".      ! "physiq".
144    
145      REAL, save:: radsol(klon) ! bilan radiatif au sol calcule par code radiatif      REAL, save:: radsol(klon)
146      REAL, save:: ftsol(klon, nbsrf) ! skin temperature of surface fraction      ! Bilan radiatif net au sol (W/m2), positif vers le bas. Must be
147        ! saved because radlwsw is not called at every time step.
148        
149        REAL, save:: ftsol(klon, nbsrf) ! skin temperature of surface fraction, in K
150    
151      REAL, save:: ftsoil(klon, nsoilmx, nbsrf)      REAL, save:: ftsoil(klon, nsoilmx, nbsrf)
152      ! soil temperature of surface fraction      ! soil temperature of surface fraction
153    
154      REAL fluxlat(klon, nbsrf)      REAL fluxlat(klon, nbsrf) ! flux de chaleur latente, en W m-2
155    
156      REAL, save:: fqsurf(klon, nbsrf)      REAL, save:: fqsurf(klon, nbsrf)
157      ! humidite de l'air au contact de la surface      ! humidite de l'air au contact de la surface
158    
159      REAL, save:: qsol(klon) ! column-density of water in soil, in kg m-2      REAL, save:: qsol(klon) ! column-density of water in soil, in kg m-2
160      REAL, save:: fsnow(klon, nbsrf) ! \'epaisseur neigeuse  
161        REAL, save:: fsnow(klon, nbsrf)
162        ! column-density of mass of snow at the surface, in kg m-2
163    
164      REAL, save:: falbe(klon, nbsrf) ! albedo visible par type de surface      REAL, save:: falbe(klon, nbsrf) ! albedo visible par type de surface
165    
166      ! Param\`etres de l'orographie \`a l'\'echelle sous-maille (OESM) :      ! Param\`etres de l'orographie \`a l'\'echelle sous-maille (OESM) :
# Line 215  contains Line 219  contains
219      REAL sens(klon) ! flux de chaleur sensible au sol      REAL sens(klon) ! flux de chaleur sensible au sol
220      real dflux_t(klon) ! derivee du flux de chaleur sensible au sol      real dflux_t(klon) ! derivee du flux de chaleur sensible au sol
221      REAL, save:: dlw(klon) ! derivative of infra-red flux      REAL, save:: dlw(klon) ! derivative of infra-red flux
222      REAL bils(klon) ! bilan de chaleur au sol      REAL fder(klon) ! d\'erive de flux (sensible et latente)
     REAL fder(klon) ! Derive de flux (sensible et latente)  
223      REAL ve(klon) ! integr. verticale du transport meri. de l'energie      REAL ve(klon) ! integr. verticale du transport meri. de l'energie
224      REAL vq(klon) ! integr. verticale du transport meri. de l'eau      REAL vq(klon) ! integr. verticale du transport meri. de l'eau
225      REAL ue(klon) ! integr. verticale du transport zonal de l'energie      REAL ue(klon) ! integr. verticale du transport zonal de l'energie
# Line 241  contains Line 244  contains
244      REAL diafra(klon, llm) ! fraction nuageuse      REAL diafra(klon, llm) ! fraction nuageuse
245      REAL cldliq(klon, llm) ! eau liquide nuageuse      REAL cldliq(klon, llm) ! eau liquide nuageuse
246      REAL cldfra(klon, llm) ! fraction nuageuse      REAL cldfra(klon, llm) ! fraction nuageuse
247      REAL cldtau(klon, llm) ! epaisseur optique      REAL cldtau(klon, llm) ! \'epaisseur optique
248      REAL cldemi(klon, llm) ! emissivite infrarouge      REAL cldemi(klon, llm) ! \'emissivit\'e infrarouge
249    
250      REAL flux_q(klon, nbsrf) ! flux turbulent d'humidite à la surface      REAL flux_q(klon, nbsrf) ! flux turbulent d'humidite à la surface
251      REAL flux_t(klon, nbsrf) ! flux turbulent de chaleur à la surface  
252        REAL flux_t(klon, nbsrf)
253        ! flux de chaleur sensible (c_p T) (W / m2) (orientation positive
254        ! vers le bas) à la surface
255    
256      REAL flux_u(klon, nbsrf), flux_v(klon, nbsrf)      REAL flux_u(klon, nbsrf), flux_v(klon, nbsrf)
257      ! tension du vent (flux turbulent de vent) à la surface, en Pa      ! tension du vent (flux turbulent de vent) à la surface, en Pa
# Line 257  contains Line 263  contains
263      REAL, save:: cool(klon, llm) ! refroidissement infrarouge      REAL, save:: cool(klon, llm) ! refroidissement infrarouge
264      REAL, save:: cool0(klon, llm) ! refroidissement infrarouge ciel clair      REAL, save:: cool0(klon, llm) ! refroidissement infrarouge ciel clair
265      REAL, save:: topsw(klon), toplw(klon), solsw(klon)      REAL, save:: topsw(klon), toplw(klon), solsw(klon)
266      REAL, save:: sollw(klon) ! rayonnement infrarouge montant \`a la surface  
267      real, save:: sollwdown(klon) ! downward LW flux at surface      REAL, save:: sollw(klon) ! surface net downward longwave flux, in W m-2
268        real, save:: sollwdown(klon) ! downwelling longwave flux at surface
269      REAL, save:: topsw0(klon), toplw0(klon), solsw0(klon), sollw0(klon)      REAL, save:: topsw0(klon), toplw0(klon), solsw0(klon), sollw0(klon)
270      REAL, save:: albpla(klon)      REAL, save:: albpla(klon)
271    
# Line 273  contains Line 280  contains
280      real longi      real longi
281      REAL z_avant(klon), z_apres(klon), z_factor(klon)      REAL z_avant(klon), z_apres(klon), z_factor(klon)
282      REAL zb      REAL zb
283      REAL zx_t, zx_qs, zcor      REAL zx_qs, zcor
284      real zqsat(klon, llm)      real zqsat(klon, llm)
285      INTEGER i, k, iq, nsrf      INTEGER i, k, iq, nsrf
286      REAL zphi(klon, llm)      REAL zphi(klon, llm)
# Line 328  contains Line 335  contains
335      real rain_lsc(klon)      real rain_lsc(klon)
336      REAL snow_con(klon) ! neige (mm / s)      REAL snow_con(klon) ! neige (mm / s)
337      real snow_lsc(klon)      real snow_lsc(klon)
     REAL d_ts(klon, nbsrf) ! variation of ftsol  
338    
339      REAL d_u_vdf(klon, llm), d_v_vdf(klon, llm)      REAL d_u_vdf(klon, llm), d_v_vdf(klon, llm)
340      REAL d_t_vdf(klon, llm), d_q_vdf(klon, llm)      REAL d_t_vdf(klon, llm), d_q_vdf(klon, llm)
# Line 342  contains Line 348  contains
348      real ratqss(klon, llm), ratqsc(klon, llm)      real ratqss(klon, llm), ratqsc(klon, llm)
349      real:: ratqsbas = 0.01, ratqshaut = 0.3      real:: ratqsbas = 0.01, ratqshaut = 0.3
350    
351      ! Parametres lies au nouveau schema de nuages (SB, PDF)      ! Param\`etres li\'es au nouveau sch\'ema de nuages :
352      real:: fact_cldcon = 0.375      real:: fact_cldcon = 0.375
353      real:: facttemps = 1.e-4      real:: facttemps = 1.e-4
     logical:: ok_newmicro = .true.  
354      real facteur      real facteur
355    
356      integer:: iflag_cldcon = 1      integer:: iflag_cldcon = 1
# Line 399  contains Line 404  contains
404    
405      integer, save:: ncid_startphy      integer, save:: ncid_startphy
406    
407      namelist /physiq_nml/ fact_cldcon, facttemps, ok_newmicro, iflag_cldcon, &      namelist /physiq_nml/ fact_cldcon, facttemps, iflag_cldcon, ratqsbas, &
408           ratqsbas, ratqshaut, ok_ade, bl95_b0, bl95_b1, iflag_thermals, &           ratqshaut, ok_ade, bl95_b0, bl95_b1
          nsplit_thermals  
409    
410      !----------------------------------------------------------------      !----------------------------------------------------------------
411    
# Line 429  contains Line 433  contains
433         pblt =0.         pblt =0.
434         therm =0.         therm =0.
435    
        iflag_thermals = 0  
        nsplit_thermals = 1  
436         print *, "Enter namelist 'physiq_nml'."         print *, "Enter namelist 'physiq_nml'."
437         read(unit=*, nml=physiq_nml)         read(unit=*, nml=physiq_nml)
438         write(unit_nml, nml=physiq_nml)         write(unit_nml, nml=physiq_nml)
439    
440           call ctherm
441         call conf_phys         call conf_phys
442    
443         ! Initialiser les compteurs:         ! Initialiser les compteurs:
# Line 466  contains Line 469  contains
469         ENDIF         ENDIF
470    
471         ! Initialisation des sorties         ! Initialisation des sorties
472         call ini_histins(ok_newmicro)         call ini_histins
473         CALL phyredem0         CALL phyredem0
474         call conf_interface         call conf_interface
475      ENDIF test_firstcal      ENDIF test_firstcal
# Line 539  contains Line 542  contains
542      CALL pbl_surface(pctsrf, t_seri, q_seri, u_seri, v_seri, julien, mu0, &      CALL pbl_surface(pctsrf, t_seri, q_seri, u_seri, v_seri, julien, mu0, &
543           ftsol, cdmmax, cdhmax, ftsoil, qsol, paprs, play, fsnow, fqsurf, &           ftsol, cdmmax, cdhmax, ftsoil, qsol, paprs, play, fsnow, fqsurf, &
544           falbe, fluxlat, rain_fall, snow_fall, frugs, agesno, rugoro, d_t_vdf, &           falbe, fluxlat, rain_fall, snow_fall, frugs, agesno, rugoro, d_t_vdf, &
545           d_q_vdf, d_u_vdf, d_v_vdf, d_ts, flux_t, flux_q, flux_u, flux_v, &           d_q_vdf, d_u_vdf, d_v_vdf, flux_t, flux_q, flux_u, flux_v, cdragh, &
546           cdragh, cdragm, q2, dflux_t, dflux_q, coefh, t2m, q2m, u10m_srf, &           cdragm, q2, dflux_t, dflux_q, coefh, t2m, q2m, u10m_srf, v10m_srf, &
547           v10m_srf, pblh, capCL, oliqCL, cteiCL, pblT, therm, plcl, fqcalving, &           pblh, capCL, oliqCL, cteiCL, pblT, therm, plcl, fqcalving, ffonte, &
548           ffonte, run_off_lic_0, albsol, sollw, solsw, tsol)           run_off_lic_0, albsol, sollw, solsw, tsol)
549    
550      ! Incr\'ementation des flux      ! Incr\'ementation des flux
551    
552      sens = - sum(flux_t * pctsrf, dim = 2)      sens = sum(flux_t * pctsrf, dim = 2)
553      evap = - sum(flux_q * pctsrf, dim = 2)      evap = - sum(flux_q * pctsrf, dim = 2)
554      fder = dlw + dflux_t + dflux_q      fder = dlw + dflux_t + dflux_q
555    
# Line 560  contains Line 563  contains
563      ENDDO      ENDDO
564    
565      call assert(abs(sum(pctsrf, dim = 2) - 1.) <= EPSFRA, 'physiq: pctsrf')      call assert(abs(sum(pctsrf, dim = 2) - 1.) <= EPSFRA, 'physiq: pctsrf')
     ftsol = ftsol + d_ts ! update surface temperature  
566      tsol = sum(ftsol * pctsrf, dim = 2)      tsol = sum(ftsol * pctsrf, dim = 2)
567      zxfluxlat = sum(fluxlat * pctsrf, dim = 2)      zxfluxlat = sum(fluxlat * pctsrf, dim = 2)
568      zt2m = sum(t2m * pctsrf, dim = 2)      zt2m = sum(t2m * pctsrf, dim = 2)
# Line 650  contains Line 652  contains
652         z_factor = (z_avant - (rain_con + snow_con) * dtphys) / z_apres         z_factor = (z_avant - (rain_con + snow_con) * dtphys) / z_apres
653         DO k = 1, llm         DO k = 1, llm
654            DO i = 1, klon            DO i = 1, klon
655               IF (z_factor(i) > 1. + 1E-8 .OR. z_factor(i) < 1. - 1E-8) THEN               IF (z_factor(i) /= 1.) THEN
656                  q_seri(i, k) = q_seri(i, k) * z_factor(i)                  q_seri(i, k) = q_seri(i, k) * z_factor(i)
657               ENDIF               ENDIF
658            ENDDO            ENDDO
# Line 666  contains Line 668  contains
668      fm_therm = 0.      fm_therm = 0.
669      entr_therm = 0.      entr_therm = 0.
670    
671      if (iflag_thermals == 0) then      if (iflag_thermals) then
672         ! Ajustement sec         call calltherm(play, paprs, pphi, u_seri, v_seri, t_seri, q_seri, &
673                d_u_ajs, d_v_ajs, d_t_ajs, d_q_ajs, fm_therm, entr_therm)
674        else
675         CALL ajsec(paprs, play, t_seri, q_seri, d_t_ajs, d_q_ajs)         CALL ajsec(paprs, play, t_seri, q_seri, d_t_ajs, d_q_ajs)
676         t_seri = t_seri + d_t_ajs         t_seri = t_seri + d_t_ajs
677         q_seri = q_seri + d_q_ajs         q_seri = q_seri + d_q_ajs
     else  
        call calltherm(play, paprs, pphi, u_seri, v_seri, t_seri, q_seri, &  
             d_u_ajs, d_v_ajs, d_t_ajs, d_q_ajs, fm_therm, entr_therm)  
678      endif      endif
679    
680      ! Caclul des ratqs      ! Caclul des ratqs
# Line 806  contains Line 807  contains
807      ! Humidit\'e relative pour diagnostic :      ! Humidit\'e relative pour diagnostic :
808      DO k = 1, llm      DO k = 1, llm
809         DO i = 1, klon         DO i = 1, klon
810            zx_t = t_seri(i, k)            zx_qs = r2es * FOEEW(t_seri(i, k), rtt >= t_seri(i, k)) / play(i, k)
           zx_qs = r2es * FOEEW(zx_t, rtt >= zx_t) / play(i, k)  
811            zx_qs = MIN(0.5, zx_qs)            zx_qs = MIN(0.5, zx_qs)
812            zcor = 1. / (1. - retv * zx_qs)            zcor = 1. / (1. - retv * zx_qs)
813            zx_qs = zx_qs * zcor            zx_qs = zx_qs * zcor
# Line 818  contains Line 818  contains
818    
819      ! Param\`etres optiques des nuages et quelques param\`etres pour      ! Param\`etres optiques des nuages et quelques param\`etres pour
820      ! diagnostics :      ! diagnostics :
821      if (ok_newmicro) then      CALL newmicro(paprs, play, t_seri, cldliq, cldfra, cldtau, cldemi, cldh, &
822         CALL newmicro(paprs, play, t_seri, cldliq, cldfra, cldtau, cldemi, &           cldl, cldm, cldt, cldq, flwp, fiwp, flwc, fiwc)
             cldh, cldl, cldm, cldt, cldq, flwp, fiwp, flwc, fiwc)  
     else  
        CALL nuage(paprs, play, t_seri, cldliq, cldfra, cldtau, cldemi, cldh, &  
             cldl, cldm, cldt, cldq)  
     endif  
823    
824      IF (MOD(itap - 1, radpas) == 0) THEN      IF (MOD(itap - 1, radpas) == 0) THEN
825         wo = ozonecm(REAL(julien), paprs)         wo = ozonecm(REAL(julien), paprs)
# Line 844  contains Line 839  contains
839         ENDDO         ENDDO
840      ENDDO      ENDDO
841    
     ! Calculer le bilan du sol et la d\'erive de temp\'erature (couplage)  
     DO i = 1, klon  
        bils(i) = radsol(i) - sens(i) + zxfluxlat(i)  
     ENDDO  
   
842      ! Param\'etrisation de l'orographie \`a l'\'echelle sous-maille :      ! Param\'etrisation de l'orographie \`a l'\'echelle sous-maille :
843    
844      IF (ok_orodr) THEN      IF (ok_orodr) THEN
# Line 912  contains Line 902  contains
902    
903      ! diag. bilKP      ! diag. bilKP
904    
905      CALL transp_lay(paprs, t_seri, q_seri, u_seri, v_seri, zphi, &      CALL transp_lay(paprs, t_seri, q_seri, u_seri, v_seri, zphi, ve_lay, &
906           ve_lay, vq_lay, ue_lay, uq_lay)           vq_lay, ue_lay, uq_lay)
907    
908      ! Accumuler les variables a stocker dans les fichiers histoire:      ! Accumuler les variables a stocker dans les fichiers histoire:
909    
# Line 982  contains Line 972  contains
972      CALL histwrite_phy("topl", toplw)      CALL histwrite_phy("topl", toplw)
973      CALL histwrite_phy("evap", evap)      CALL histwrite_phy("evap", evap)
974      CALL histwrite_phy("sols", solsw)      CALL histwrite_phy("sols", solsw)
975      CALL histwrite_phy("soll", sollw)      CALL histwrite_phy("rls", sollw)
976      CALL histwrite_phy("solldown", sollwdown)      CALL histwrite_phy("solldown", sollwdown)
977      CALL histwrite_phy("bils", bils)      CALL histwrite_phy("bils", radsol + sens + zxfluxlat)
978      CALL histwrite_phy("sens", - sens)      CALL histwrite_phy("sens", sens)
979      CALL histwrite_phy("fder", fder)      CALL histwrite_phy("fder", fder)
     CALL histwrite_phy("dtsvdfo", d_ts(:, is_oce))  
     CALL histwrite_phy("dtsvdft", d_ts(:, is_ter))  
     CALL histwrite_phy("dtsvdfg", d_ts(:, is_lic))  
     CALL histwrite_phy("dtsvdfi", d_ts(:, is_sic))  
980      CALL histwrite_phy("zxfqcalving", sum(fqcalving * pctsrf, dim = 2))      CALL histwrite_phy("zxfqcalving", sum(fqcalving * pctsrf, dim = 2))
981      CALL histwrite_phy("albs", albsol)      CALL histwrite_phy("albs", albsol)
982      CALL histwrite_phy("tro3", wo * dobson_u * 1e3 / zmasse / rmo3 * md)      CALL histwrite_phy("tro3", wo * dobson_u * 1e3 / zmasse / rmo3 * md)
# Line 1013  contains Line 999  contains
999      CALL histwrite_phy("d_t_ec", d_t_ec)      CALL histwrite_phy("d_t_ec", d_t_ec)
1000      CALL histwrite_phy("dtsw0", heat0 / 86400.)      CALL histwrite_phy("dtsw0", heat0 / 86400.)
1001      CALL histwrite_phy("dtlw0", - cool0 / 86400.)      CALL histwrite_phy("dtlw0", - cool0 / 86400.)
1002        call histwrite_phy("pmflxr", pmflxr(:, :llm))
1003      CALL histwrite_phy("msnow", sum(fsnow * pctsrf, dim = 2))      CALL histwrite_phy("msnow", sum(fsnow * pctsrf, dim = 2))
1004      call histwrite_phy("qsurf", sum(fqsurf * pctsrf, dim = 2))      call histwrite_phy("qsurf", sum(fqsurf * pctsrf, dim = 2))
1005      call histwrite_phy("flat", zxfluxlat)      call histwrite_phy("flat", zxfluxlat)
1006    
1007      DO nsrf = 1, nbsrf      DO nsrf = 1, nbsrf
        CALL histwrite_phy("pourc_"//clnsurf(nsrf), pctsrf(:, nsrf) * 100.)  
1008         CALL histwrite_phy("fract_"//clnsurf(nsrf), pctsrf(:, nsrf))         CALL histwrite_phy("fract_"//clnsurf(nsrf), pctsrf(:, nsrf))
1009         CALL histwrite_phy("sens_"//clnsurf(nsrf), flux_t(:, nsrf))         CALL histwrite_phy("sens_"//clnsurf(nsrf), flux_t(:, nsrf))
1010         CALL histwrite_phy("lat_"//clnsurf(nsrf), fluxlat(:, nsrf))         CALL histwrite_phy("lat_"//clnsurf(nsrf), fluxlat(:, nsrf))

Legend:
Removed from v.307  
changed lines
  Added in v.338

  ViewVC Help
Powered by ViewVC 1.1.21