/[lmdze]/trunk/Sources/dyn3d/etat0.f
ViewVC logotype

Diff of /trunk/Sources/dyn3d/etat0.f

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

trunk/dyn3d/etat0.f revision 82 by guez, Wed Mar 5 14:57:53 2014 UTC trunk/Sources/dyn3d/etat0.f revision 212 by guez, Thu Jan 12 12:31:31 2017 UTC
# Line 13  module etat0_mod Line 13  module etat0_mod
13    
14  contains  contains
15    
16    SUBROUTINE etat0    SUBROUTINE etat0(phis)
17    
18      ! From "etat0_netcdf.F", version 1.3 2005/05/25 13:10:09      ! From "etat0_netcdf.F", version 1.3, 2005/05/25 13:10:09
19    
20      use caldyn0_m, only: caldyn0      use caldyn0_m, only: caldyn0
21      use comconst, only: cpp, kappa, iniconst      use comconst, only: cpp, kappa, iniconst
22      use comgeom, only: rlatu, rlonv, rlonu, rlatv, aire_2d, apoln, apols, &      use comgeom, only: aire_2d, apoln, apols, cu_2d, cv_2d, inigeom
23           cu_2d, cv_2d, inigeom      use conf_gcm_m, only: nday
     use conf_gcm_m, only: dayref, anneeref  
24      use dimens_m, only: iim, jjm, llm, nqmx      use dimens_m, only: iim, jjm, llm, nqmx
25      use dimphy, only: zmasq      use dimphy, only: zmasq
26      use dimsoil, only: nsoilmx      use dimsoil, only: nsoilmx
27      use disvert_m, only: ap, bp, preff, pa, disvert      use disvert_m, only: ap, bp, preff, pa, disvert
28        use dynetat0_m, only: day_ref, annee_ref, xprimp025, xprimm025, rlatu1, &
29             rlatu2, rlatu, rlatv, yprimu1, yprimu2, rlonu, rlonv, xprimu, xprimv
30      use dynredem0_m, only: dynredem0      use dynredem0_m, only: dynredem0
31      use dynredem1_m, only: dynredem1      use dynredem1_m, only: dynredem1
32      use exner_hyb_m, only: exner_hyb      use exner_hyb_m, only: exner_hyb
33        use fxhyp_m, only: fxhyp
34        use fyhyp_m, only: fyhyp
35      use geopot_m, only: geopot      use geopot_m, only: geopot
36      use grid_atob, only: grille_m      use grille_m_m, only: grille_m
37      use grid_change, only: init_dyn_phy, dyn_phy      use grid_change, only: init_dyn_phy, dyn_phy
     use histclo_m, only: histclo  
38      use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra      use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra
39      use iniadvtrac_m, only: iniadvtrac      use iniadvtrac_m, only: iniadvtrac
40      use inifilr_m, only: inifilr      use inifilr_m, only: inifilr
41      use massdair_m, only: massdair      use massdair_m, only: massdair
42      use netcdf, only: nf90_nowrite      use netcdf, only: nf90_nowrite
43      use netcdf95, only: nf95_close, nf95_get_var, nf95_gw_var, &      use netcdf95, only: nf95_close, nf95_get_var, nf95_gw_var, nf95_put_var, &
44           nf95_inq_varid, nf95_open           nf95_inq_varid, nf95_open
45      use nr_util, only: pi      use nr_util, only: pi, assert
46      use paramet_m, only: ip1jm, ip1jmp1      use phyetat0_m, only: rlat, rlon, itau_phy
47        use phyredem0_m, only: phyredem0, ncid_restartphy
48      use phyredem_m, only: phyredem      use phyredem_m, only: phyredem
     use pressure_var, only: pls, p3d  
49      use q_sat_m, only: q_sat      use q_sat_m, only: q_sat
50      use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz      use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz
51      use regr_pr_o3_m, only: regr_pr_o3      use regr_pr_o3_m, only: regr_pr_o3
     use serre, only: alphax  
52      use startdyn, only: start_init_dyn      use startdyn, only: start_init_dyn
53      USE start_init_orog_m, only: start_init_orog, mask      USE start_init_orog_m, only: start_init_orog, mask
54      use start_init_phys_m, only: start_init_phys      use start_init_phys_m, only: start_init_phys
55      use start_inter_3d_m, only: start_inter_3d      use start_inter_3d_m, only: start_inter_3d
56      use temps, only: itau_phy, annee_ref, day_ref      use test_disvert_m, only: test_disvert
57        use unit_nml_m, only: unit_nml
58    
59      ! Variables local to the procedure:      REAL, intent(out):: phis(:, :) ! (iim + 1, jjm + 1)
60        ! surface geopotential, in m2 s-2
61    
62      REAL latfi(klon), lonfi(klon)      ! Local:
     ! (latitude and longitude of a point of the scalar grid identified  
     ! by a simple index, in °)  
63    
64      REAL, dimension(iim + 1, jjm + 1, llm):: ucov, t3d, teta      REAL, dimension(iim + 1, jjm + 1, llm):: ucov, t3d, teta
65      REAL vcov(iim + 1, jjm, llm)      REAL vcov(iim + 1, jjm, llm)
# Line 69  contains Line 70  contains
70      ! and pressure level "pls(i, j, l)".)      ! and pressure level "pls(i, j, l)".)
71    
72      real qsat(iim + 1, jjm + 1, llm) ! mass fraction of saturating water vapor      real qsat(iim + 1, jjm + 1, llm) ! mass fraction of saturating water vapor
73      REAL tsol(klon), qsol(klon), sn(klon)      REAL qsolsrf(klon, nbsrf), snsrf(klon, nbsrf)
     REAL tsolsrf(klon, nbsrf), qsolsrf(klon, nbsrf), snsrf(klon, nbsrf)  
74      REAL albe(klon, nbsrf), evap(klon, nbsrf)      REAL albe(klon, nbsrf), evap(klon, nbsrf)
     REAL alblw(klon, nbsrf)  
75      REAL tsoil(klon, nsoilmx, nbsrf)      REAL tsoil(klon, nsoilmx, nbsrf)
76      REAL radsol(klon), rain_fall(klon), snow_fall(klon)      REAL null_array(klon)
77      REAL solsw(klon), sollw(klon), fder(klon)      REAL solsw(klon), sollw(klon)
78      !IM "slab" ocean      !IM "slab" ocean
     REAL tslab(klon)  
     real seaice(klon) ! kg m-2  
79      REAL frugs(klon, nbsrf), agesno(klon, nbsrf)      REAL frugs(klon, nbsrf), agesno(klon, nbsrf)
80      REAL rugmer(klon)      REAL rugmer(klon)
     REAL phis(iim + 1, jjm + 1) ! surface geopotential, in m2 s-2  
81      real, dimension(iim + 1, jjm + 1):: zmea_2d, zstd_2d, zsig_2d, zgam_2d      real, dimension(iim + 1, jjm + 1):: zmea_2d, zstd_2d, zsig_2d, zgam_2d
82      real, dimension(iim + 1, jjm + 1):: zthe_2d, zpic_2d, zval_2d      real, dimension(iim + 1, jjm + 1):: zthe_2d, zpic_2d, zval_2d
83      real, dimension(iim + 1, jjm + 1):: tsol_2d, qsol_2d, ps      real, dimension(iim + 1, jjm + 1):: tsol_2d, qsol_2d, ps
# Line 90  contains Line 86  contains
86      REAL zthe(klon)      REAL zthe(klon)
87      REAL zpic(klon), zval(klon)      REAL zpic(klon), zval(klon)
88      REAL t_ancien(klon, llm), q_ancien(klon, llm)      REAL t_ancien(klon, llm), q_ancien(klon, llm)
     REAL run_off_lic_0(klon)  
89      real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm)      real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm)
90    
91      ! Déclarations pour lecture glace de mer :      ! D\'eclarations pour lecture glace de mer :
92      INTEGER iml_lic, jml_lic      INTEGER iml_lic, jml_lic
93      INTEGER ncid, varid      INTEGER ncid, varid
94      REAL, pointer:: dlon_lic(:), dlat_lic(:)      REAL, pointer:: dlon_lic(:), dlat_lic(:)
# Line 104  contains Line 99  contains
99    
100      REAL pk(iim + 1, jjm + 1, llm) ! fonction d'Exner aux milieux des couches      REAL pk(iim + 1, jjm + 1, llm) ! fonction d'Exner aux milieux des couches
101      real pks(iim + 1, jjm + 1)      real pks(iim + 1, jjm + 1)
   
102      REAL masse(iim + 1, jjm + 1, llm)      REAL masse(iim + 1, jjm + 1, llm)
103      REAL phi(iim + 1, jjm + 1, llm)      REAL phi(iim + 1, jjm + 1, llm)
     REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)  
     REAL w(ip1jmp1, llm)  
   
104      real sig1(klon, llm) ! section adiabatic updraft      real sig1(klon, llm) ! section adiabatic updraft
105      real w01(klon, llm) ! vertical velocity within adiabatic updraft      real w01(klon, llm) ! vertical velocity within adiabatic updraft
106    
107        real pls(iim + 1, jjm + 1, llm)
108        ! (pressure at mid-layer of LMDZ grid, in Pa)
109        ! "pls(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)",
110        ! for layer "l")
111    
112        REAL p3d(iim + 1, jjm + 1, llm+1) ! pressure at layer interfaces, in Pa
113        ! ("p3d(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)",
114        ! for interface "l")
115    
116        namelist /etat0_nml/ day_ref, annee_ref
117    
118      !---------------------------------      !---------------------------------
119    
120      print *, "Call sequence information: etat0"      print *, "Call sequence information: etat0"
121    
122        print *, "Enter namelist 'etat0_nml'."
123        read(unit=*, nml=etat0_nml)
124        write(unit_nml, nml=etat0_nml)
125    
126      CALL iniconst      CALL iniconst
127    
128      ! Construct a grid:      ! Construct a grid:
129    
130      pa = 5e4      pa = 5e4
131      CALL disvert      CALL disvert
132        call test_disvert
133    
134        CALL fyhyp(rlatu, rlatv, rlatu2, yprimu2, rlatu1, yprimu1)
135        CALL fxhyp(xprimm025, rlonv, xprimv, rlonu, xprimu, xprimp025)
136    
137        rlatu(1) = pi / 2.
138        rlatu(jjm + 1) = -rlatu(1)
139    
140      CALL inigeom      CALL inigeom
141      CALL inifilr      CALL inifilr
142    
143      latfi(1) = 90.      rlat(1) = 90.
144      latfi(2:klon-1) = pack(spread(rlatu(2:jjm), 1, iim), .true.) * 180. / pi      rlat(2:klon-1) = pack(spread(rlatu(2:jjm), 1, iim), .true.) * 180. / pi
145      ! (with conversion to degrees)      ! (with conversion to degrees)
146      latfi(klon) = - 90.      rlat(klon) = - 90.
147    
148      lonfi(1) = 0.      rlon(1) = 0.
149      lonfi(2:klon-1) = pack(spread(rlonv(:iim), 2, jjm - 1), .true.) * 180. / pi      rlon(2:klon-1) = pack(spread(rlonv(:iim), 2, jjm - 1), .true.) * 180. / pi
150      ! (with conversion to degrees)      ! (with conversion to degrees)
151      lonfi(klon) = 0.      rlon(klon) = 0.
152    
153      call start_init_orog(phis, zmea_2d, zstd_2d, zsig_2d, zgam_2d, zthe_2d, &      call start_init_orog(phis, zmea_2d, zstd_2d, zsig_2d, zgam_2d, zthe_2d, &
154           zpic_2d, zval_2d) ! also compute "mask"           zpic_2d, zval_2d) ! also compute "mask"
# Line 148  contains Line 162  contains
162      ! Compute pressure on intermediate levels:      ! Compute pressure on intermediate levels:
163      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * ps      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * ps
164      CALL exner_hyb(ps, p3d, pks, pk)      CALL exner_hyb(ps, p3d, pks, pk)
165      IF (MINVAL(pk) == MAXVAL(pk)) then      call assert(MINVAL(pk) /= MAXVAL(pk), '"pk" should not be constant')
        print *, '"pk" should not be constant'  
        stop 1  
     end IF  
166    
167      pls = preff * (pk / cpp)**(1. / kappa)      pls = preff * (pk / cpp)**(1. / kappa)
168      PRINT *, "minval(pls) = ", minval(pls)      PRINT *, "minval(pls) = ", minval(pls)
# Line 177  contains Line 188  contains
188              / apols              / apols
189      ENDDO      ENDDO
190    
191      ! Calcul de l'humidité à saturation :      ! Calcul de l'humidit\'e \`a saturation :
192      qsat = q_sat(t3d, pls)      qsat = q_sat(t3d, pls)
193      PRINT *, "minval(qsat) = ", minval(qsat)      PRINT *, "minval(qsat) = ", minval(qsat)
194      print *, "maxval(qsat) = ", maxval(qsat)      print *, "maxval(qsat) = ", maxval(qsat)
# Line 198  contains Line 209  contains
209      if (nqmx >= 5) then      if (nqmx >= 5) then
210         ! Ozone:         ! Ozone:
211         call regr_lat_time_coefoz         call regr_lat_time_coefoz
212         call regr_pr_o3(q(:, :, :, 5))         call regr_pr_o3(p3d, q(:, :, :, 5))
213         ! Convert from mole fraction to mass fraction:         ! Convert from mole fraction to mass fraction:
214         q(:, :, :, 5) = q(:, :, :, 5) * 48. / 29.         q(:, :, :, 5) = q(:, :, :, 5) * 48. / 29.
215      end if      end if
216    
217      tsol = pack(tsol_2d, dyn_phy)      null_array = 0.
     qsol = pack(qsol_2d, dyn_phy)  
     sn = 0. ! snow  
     radsol = 0.  
     tslab = 0. ! IM "slab" ocean  
     seaice = 0.  
218      rugmer = 0.001      rugmer = 0.001
219      zmea = pack(zmea_2d, dyn_phy)      zmea = pack(zmea_2d, dyn_phy)
220      zstd = pack(zstd_2d, dyn_phy)      zstd = pack(zstd_2d, dyn_phy)
# Line 238  contains Line 244  contains
244    
245      call nf95_close(ncid)      call nf95_close(ncid)
246    
247      ! Interpolation sur la grille T du modèle :      ! Interpolation sur la grille T du mod\`ele :
248      PRINT *, 'Dimensions de "landiceref.nc"'      PRINT *, 'Dimensions de "landiceref.nc"'
249      print *, "iml_lic = ", iml_lic      print *, "iml_lic = ", iml_lic
250      print *, "jml_lic = ", jml_lic      print *, "jml_lic = ", jml_lic
251    
252      ! Si les coordonnées sont en degrés, on les transforme :      ! Si les coordonn\'ees sont en degr\'es, on les transforme :
253      IF (MAXVAL(dlon_lic) > pi) THEN      IF (MAXVAL(dlon_lic) > pi) THEN
254         dlon_lic = dlon_lic * pi / 180.         dlon_lic = dlon_lic * pi / 180.
255      ENDIF      ENDIF
# Line 260  contains Line 266  contains
266      ! Passage sur la grille physique      ! Passage sur la grille physique
267      pctsrf = 0.      pctsrf = 0.
268      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)
269      ! Adéquation avec le maque terre/mer      ! Ad\'equation avec le maque terre/mer
270      WHERE (pctsrf(:, is_lic) < EPSFRA) pctsrf(:, is_lic) = 0.      WHERE (pctsrf(:, is_lic) < EPSFRA) pctsrf(:, is_lic) = 0.
271      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.
272      pctsrf(:, is_ter) = zmasq      pctsrf(:, is_ter) = zmasq
# Line 277  contains Line 283  contains
283         end where         end where
284      end where      end where
285    
286      ! Sous-surface océan et glace de mer (pour démarrer on met glace      ! Sous-surface oc\'ean et glace de mer (pour d\'emarrer on met glace
287      ! de mer à 0) :      ! de mer \`a 0) :
288      pctsrf(:, is_oce) = 1. - zmasq      pctsrf(:, is_oce) = 1. - zmasq
289      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.
290    
291      ! Vérification que somme des sous-surfaces vaut 1 :      ! V\'erification que la somme des sous-surfaces vaut 1 :
292      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)
293      IF (ji /= 0) then      IF (ji /= 0) then
294         PRINT *, 'Problème répartition sous maille pour ', ji, 'points'         PRINT *, 'Bad surface percentages for ', ji, 'points'
295      end IF      end IF
296    
297      ! Calcul intermédiaire :      ! Calcul interm\'ediaire :
298      CALL massdair(p3d, masse)      CALL massdair(p3d, masse)
299    
     print *, 'ALPHAX = ', alphax  
   
300      forall (l = 1:llm)      forall (l = 1:llm)
301         masse(:, 1, l) = SUM(aire_2d(:iim, 1) * masse(:iim, 1, l)) / apoln         masse(:, 1, l) = SUM(aire_2d(:iim, 1) * masse(:iim, 1, l)) / apoln
302         masse(:, jjm + 1, l) = &         masse(:, jjm + 1, l) = &
303              SUM(aire_2d(:iim, jjm + 1) * masse(:iim, jjm + 1, l)) / apols              SUM(aire_2d(:iim, jjm + 1) * masse(:iim, jjm + 1, l)) / apols
304      END forall      END forall
305    
     ! Initialisation pour traceurs:  
306      call iniadvtrac      call iniadvtrac
     itau_phy = 0  
     day_ref = dayref  
     annee_ref = anneeref  
   
307      CALL geopot(teta, pk , pks, phis, phi)      CALL geopot(teta, pk , pks, phis, phi)
308      CALL caldyn0(ucov, vcov, teta, ps, masse, pk, phis, phi, w, pbaru, &      CALL caldyn0(ucov, vcov, teta, ps, pk, phis, phi)
309           pbarv)      CALL dynredem0(day_ref, phis)
310      CALL dynredem0("start.nc", dayref, phis)      CALL dynredem1(vcov, ucov, teta, q, masse, ps, itau = 0)
     CALL dynredem1("start.nc", vcov, ucov, teta, q, masse, ps, itau=0)  
311    
312      ! Initialisations :      ! Initialisations :
313      tsolsrf(:, is_ter) = tsol      snsrf = 0.
     tsolsrf(:, is_lic) = tsol  
     tsolsrf(:, is_oce) = tsol  
     tsolsrf(:, is_sic) = tsol  
     snsrf(:, is_ter) = sn  
     snsrf(:, is_lic) = sn  
     snsrf(:, is_oce) = sn  
     snsrf(:, is_sic) = sn  
314      albe(:, is_ter) = 0.08      albe(:, is_ter) = 0.08
315      albe(:, is_lic) = 0.6      albe(:, is_lic) = 0.6
316      albe(:, is_oce) = 0.5      albe(:, is_oce) = 0.5
317      albe(:, is_sic) = 0.6      albe(:, is_sic) = 0.6
     alblw = albe  
318      evap = 0.      evap = 0.
319      qsolsrf(:, is_ter) = 150.      qsolsrf = 150.
320      qsolsrf(:, is_lic) = 150.      tsoil = spread(spread(pack(tsol_2d, dyn_phy), 2, nsoilmx), 3, nbsrf)
     qsolsrf(:, is_oce) = 150.  
     qsolsrf(:, is_sic) = 150.  
     tsoil = spread(spread(tsol, 2, nsoilmx), 3, nbsrf)  
     rain_fall = 0.  
     snow_fall = 0.  
321      solsw = 165.      solsw = 165.
322      sollw = -53.      sollw = -53.
323      t_ancien = 273.15      t_ancien = 273.15
324      q_ancien = 0.      q_ancien = 0.
325      agesno = 0.      agesno = 0.
     !IM "slab" ocean  
     tslab = tsolsrf(:, is_oce)  
     seaice = 0.  
326    
327      frugs(:, is_oce) = rugmer      frugs(:, is_oce) = rugmer
328      frugs(:, is_ter) = MAX(1e-5, zstd * zsig / 2)      frugs(:, is_ter) = MAX(1e-5, zstd * zsig / 2)
329      frugs(:, is_lic) = MAX(1e-5, zstd * zsig / 2)      frugs(:, is_lic) = MAX(1e-5, zstd * zsig / 2)
330      frugs(:, is_sic) = 0.001      frugs(:, is_sic) = 0.001
     fder = 0.  
331      clwcon = 0.      clwcon = 0.
332      rnebcon = 0.      rnebcon = 0.
333      ratqs = 0.      ratqs = 0.
     run_off_lic_0 = 0.  
334      sig1 = 0.      sig1 = 0.
335      w01 = 0.      w01 = 0.
336    
337      call phyredem("startphy.nc", latfi, lonfi, pctsrf, &      nday = 0
338           tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, &      itau_phy = 0 ! side effect
339           evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &      call phyredem0
340           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, &  
341           t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0, sig1, w01)      call nf95_inq_varid(ncid_restartphy, "trs", varid)
342      CALL histclo      call nf95_put_var(ncid_restartphy, varid, null_array)
343    
344        call phyredem(pctsrf, tsoil(:, 1, :), tsoil, qsolsrf, &
345             pack(qsol_2d, dyn_phy), snsrf, albe, evap, null_array, null_array, &
346             solsw, sollw, null_array, null_array, frugs, agesno, zmea, zstd, &
347             zsig, zgam, zthe, zpic, zval, t_ancien, q_ancien, rnebcon, ratqs, &
348             clwcon, null_array, sig1, w01)
349    
350    END SUBROUTINE etat0    END SUBROUTINE etat0
351    

Legend:
Removed from v.82  
changed lines
  Added in v.212

  ViewVC Help
Powered by ViewVC 1.1.21