/[lmdze]/trunk/libf/dyn3d/etat0.f90
ViewVC logotype

Diff of /trunk/libf/dyn3d/etat0.f90

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

revision 5 by guez, Mon Mar 3 16:32:04 2008 UTC revision 30 by guez, Thu Apr 1 09:07:28 2010 UTC
# Line 6  module etat0_mod Line 6  module etat0_mod
6    IMPLICIT NONE    IMPLICIT NONE
7    
8    REAL pctsrf(klon, nbsrf)    REAL pctsrf(klon, nbsrf)
9      ! ("pctsrf(i, :)" is the composition of the surface at horizontal
10      !  position "i")
11    
12    private nbsrf, klon    private nbsrf, klon
13    
# Line 15  contains Line 17  contains
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      ! This subroutine creates "masque".      ! This subroutine creates "mask".
21    
22      USE ioipsl, only: flinget, flinclo, flinopen_nozoom, flininfo, histclo      use caldyn0_m, only: caldyn0
   
     USE start_init_orog_m, only: start_init_orog, masque, phis  
     use start_init_phys_m, only: qsol_2d  
     use startdyn, only: start_inter_3d, start_init_dyn  
     use dimens_m, only: iim, jjm, llm, nqmx  
     use paramet_m, only: ip1jm, ip1jmp1  
23      use comconst, only: dtvr, daysec, cpp, kappa, pi      use comconst, only: dtvr, daysec, cpp, kappa, pi
     use comdissnew, only: lstardis, nitergdiv, nitergrot, niterh, &  
          tetagdiv, tetagrot, tetatemp  
     use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra  
     use comvert, only: ap, bp, preff, pa  
     use dimphy, only: zmasq  
     use conf_gcm_m, only: day_step, iphysiq, dayref, anneeref  
24      use comgeom, only: rlatu, rlonv, rlonu, rlatv, aire_2d, apoln, apols, &      use comgeom, only: rlatu, rlonv, rlonu, rlatv, aire_2d, apoln, apols, &
25           cu_2d, cv_2d           cu_2d, cv_2d
26      use serre, only: alphax      use comvert, only: ap, bp, preff, pa
27        use conf_gcm_m, only: day_step, iphysiq, dayref, anneeref
28        use dimens_m, only: iim, jjm, llm, nqmx
29        use dimphy, only: zmasq
30      use dimsoil, only: nsoilmx      use dimsoil, only: nsoilmx
31      use temps, only: itau_dyn, itau_phy, annee_ref, day_ref, dt      use dynredem0_m, only: dynredem0
32      use clesphys, only: ok_orodr, nbapp_rad      use dynredem1_m, only: dynredem1
33        use exner_hyb_m, only: exner_hyb
34      use grid_atob, only: grille_m      use grid_atob, only: grille_m
35      use grid_change, only: init_dyn_phy, dyn_phy      use grid_change, only: init_dyn_phy, dyn_phy
36        use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra
37        use iniadvtrac_m, only: iniadvtrac
38        use inidissip_m, only: inidissip
39        use inigeom_m, only: inigeom
40        USE flincom, only: flinget, flinclo, flinopen_nozoom, flininfo
41        use histcom, only: histclo
42        use paramet_m, only: ip1jm, ip1jmp1
43        use phyredem_m, only: phyredem
44        use pressure_var, only: pls, p3d
45      use q_sat_m, only: q_sat      use q_sat_m, only: q_sat
46      use exner_hyb_m, only: exner_hyb      use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz
47      use regr_coefoz_m, only: regr_coefoz      use regr_pr_o3_m, only: regr_pr_o3
48      use advtrac_m, only: iniadvtrac      use serre, only: alphax
49      use netcdf95, only: nf95_open, nf95_close, nf95_inq_varid, nf90_nowrite, &      USE start_init_orog_m, only: start_init_orog, mask, phis
50           nf90_get_var, handle_err      use start_init_phys_m, only: qsol_2d
51      use pressure_m, only: pls, p3d      use startdyn, only: start_inter_3d, start_init_dyn
52        use temps, only: itau_phy, annee_ref, day_ref
53    
54      ! Variables local to the procedure:      ! Variables local to the procedure:
55    
# Line 81  contains Line 85  contains
85      REAL zsig(klon), zgam(klon)      REAL zsig(klon), zgam(klon)
86      REAL zthe(klon)      REAL zthe(klon)
87      REAL zpic(klon), zval(klon)      REAL zpic(klon), zval(klon)
     REAL rugsrel(klon)  
88      REAL t_ancien(klon, llm), q_ancien(klon, llm)      !      REAL t_ancien(klon, llm), q_ancien(klon, llm)      !
89      REAL run_off_lic_0(klon)      REAL run_off_lic_0(klon)
90      real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm)      real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm)
# Line 104  contains Line 107  contains
107      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)
108      REAL w(ip1jmp1, llm)      REAL w(ip1jmp1, llm)
109      REAL phystep      REAL phystep
110      INTEGER radpas      real trash
     integer ncid, varid, ncerr, month  
111    
112      !---------------------------------      !---------------------------------
113    
# Line 132  contains Line 134  contains
134      lonfi(klon) = 0.      lonfi(klon) = 0.
135    
136      call start_init_orog(relief, zstd_2d, zsig_2d, zgam_2d, zthe_2d, zpic_2d, &      call start_init_orog(relief, zstd_2d, zsig_2d, zgam_2d, zthe_2d, zpic_2d, &
137           zval_2d) ! also compute "masque" and "phis"           zval_2d) ! also compute "mask" and "phis"
138      call init_dyn_phy ! define the mask "dyn_phy" for distinct grid points      call init_dyn_phy ! define the mask "dyn_phy" for distinct grid points
139      zmasq = pack(masque, dyn_phy)      zmasq = pack(mask, dyn_phy)
140      PRINT *, 'Masque construit'      PRINT *, 'Masque construit'
141    
142      CALL start_init_dyn(tsol_2d, psol) ! also compute "qsol_2d"      CALL start_init_dyn(tsol_2d, psol) ! also compute "qsol_2d"
143    
144      ! Compute pressure on intermediate levels:      ! Compute pressure on intermediate levels:
145      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * psol(:, :)      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * psol
146      CALL exner_hyb(psol, p3d, pks, pk)      CALL exner_hyb(psol, p3d, pks, pk)
147      IF (MINVAL(pk) == MAXVAL(pk)) stop '"pk" should not be constant'      IF (MINVAL(pk) == MAXVAL(pk)) stop '"pk" should not be constant'
148    
# Line 148  contains Line 150  contains
150      PRINT *, "minval(pls(:, :, :)) = ", minval(pls(:, :, :))      PRINT *, "minval(pls(:, :, :)) = ", minval(pls(:, :, :))
151      print *, "maxval(pls(:, :, :)) = ", maxval(pls(:, :, :))      print *, "maxval(pls(:, :, :)) = ", maxval(pls(:, :, :))
152    
153      uvent(:, :, :) = start_inter_3d('U', rlonv, rlatv, pls)      call start_inter_3d('U', rlonv, rlatv, pls, uvent)
154      forall (l = 1: llm) uvent(:iim, :, l) = uvent(:iim, :, l) * cu_2d(:iim, :)      forall (l = 1: llm) uvent(:iim, :, l) = uvent(:iim, :, l) * cu_2d(:iim, :)
155      uvent(iim+1, :, :) = uvent(1, :, :)      uvent(iim+1, :, :) = uvent(1, :, :)
156    
157      vvent(:, :, :) = start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :))      call start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :), vvent)
158      forall (l = 1: llm) vvent(:iim, :, l) = vvent(:iim, :, l) * cv_2d(:iim, :)      forall (l = 1: llm) vvent(:iim, :, l) = vvent(:iim, :, l) * cv_2d(:iim, :)
159      vvent(iim + 1, :, :) = vvent(1, :, :)      vvent(iim + 1, :, :) = vvent(1, :, :)
160    
161      t3d(:, :, :) = start_inter_3d('TEMP', rlonu, rlatv, pls)      call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d)
162      PRINT *,  'minval(t3d(:, :, :)) = ', minval(t3d(:, :, :))      PRINT *,  'minval(t3d(:, :, :)) = ', minval(t3d(:, :, :))
163      print *, "maxval(t3d(:, :, :)) = ", maxval(t3d(:, :, :))      print *, "maxval(t3d(:, :, :)) = ", maxval(t3d(:, :, :))
164    
# Line 175  contains Line 177  contains
177      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'
178    
179      ! Water vapor:      ! Water vapor:
180      q3d(:, :, :, 1) = 0.01 * start_inter_3d('R', rlonu, rlatv, pls) * qsat      call start_inter_3d('R', rlonu, rlatv, pls, q3d(:, :, :, 1))
181        q3d(:, :, :, 1) = 0.01 * q3d(:, :, :, 1) * qsat
182      WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10      WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10
183      DO l = 1, llm      DO l = 1, llm
184         q3d(:, 1, l, 1) = SUM(aire_2d(:, 1) * q3d(:, 1, l, 1)) / apoln         q3d(:, 1, l, 1) = SUM(aire_2d(:, 1) * q3d(:, 1, l, 1)) / apoln
# Line 187  contains Line 190  contains
190    
191      if (nqmx >= 5) then      if (nqmx >= 5) then
192         ! Ozone:         ! Ozone:
193           call regr_lat_time_coefoz
194         ! Compute ozone parameters on the LMDZ grid:         call regr_pr_o3(q3d(:, :, :, 5))
195         call regr_coefoz         ! Convert from mole fraction to mass fraction:
196           q3d(:, :, :, 5) = q3d(:, :, :, 5)  * 48. / 29.
        ! Find the month containing the day number "dayref":  
        month = (dayref - 1) / 30 + 1  
        print *, "month = ", month  
   
        call nf95_open("coefoz_LMDZ.nc", nf90_nowrite, ncid)  
   
        ! Get data at the right month from the input file:  
        call nf95_inq_varid(ncid, "r_Mob", varid)  
        ncerr = nf90_get_var(ncid, varid, q3d(:, :, :, 5), &  
             start=(/1, 1, 1, month/))  
        call handle_err("nf90_get_var r_Mob", ncerr)  
   
        call nf95_close(ncid)  
        ! Latitudes are in increasing order in the input file while  
        ! "rlatu" is in decreasing order so we need to invert order. Also, we  
        ! compute mass fraction from mole fraction:  
        q3d(:, :, :, 5) = q3d(:, jjm+1:1:-1, :, 5)  * 48. / 29.  
197      end if      end if
198    
199      tsol(:) = pack(tsol_2d, dyn_phy)      tsol = pack(tsol_2d, dyn_phy)
200      qsol(:) = pack(qsol_2d, dyn_phy)      qsol = pack(qsol_2d, dyn_phy)
201      sn(:) = 0. ! snow      sn = 0. ! snow
202      radsol(:) = 0.      radsol = 0.
203      tslab(:) = 0. ! IM "slab" ocean      tslab = 0. ! IM "slab" ocean
204      seaice(:) = 0.      seaice = 0.
205      rugmer(:) = 0.001      rugmer = 0.001
206      zmea(:) = pack(relief, dyn_phy)      zmea = pack(relief, dyn_phy)
207      zstd(:) = pack(zstd_2d, dyn_phy)      zstd = pack(zstd_2d, dyn_phy)
208      zsig(:) = pack(zsig_2d, dyn_phy)      zsig = pack(zsig_2d, dyn_phy)
209      zgam(:) = pack(zgam_2d, dyn_phy)      zgam = pack(zgam_2d, dyn_phy)
210      zthe(:) = pack(zthe_2d, dyn_phy)      zthe = pack(zthe_2d, dyn_phy)
211      zpic(:) = pack(zpic_2d, dyn_phy)      zpic = pack(zpic_2d, dyn_phy)
212      zval(:) = pack(zval_2d, dyn_phy)      zval = pack(zval_2d, dyn_phy)
   
     rugsrel(:) = 0.  
     IF (ok_orodr) rugsrel(:) = MAX(1.e-05, zstd(:) * zsig(:) / 2)  
213    
214      ! On initialise les sous-surfaces:      ! On initialise les sous-surfaces:
215      ! Lecture du fichier glace de terre pour fixer la fraction de terre      ! Lecture du fichier glace de terre pour fixer la fraction de terre
# Line 239  contains Line 222  contains
222      ALLOCATE(dlat_lic(jml_lic))      ALLOCATE(dlat_lic(jml_lic))
223      ALLOCATE(fraclic(iml_lic, jml_lic))      ALLOCATE(fraclic(iml_lic, jml_lic))
224      CALL flinopen_nozoom("landiceref.nc", iml_lic, jml_lic, &      CALL flinopen_nozoom("landiceref.nc", iml_lic, jml_lic, &
225           llm_tmp, lon_lic, lat_lic, lev, ttm_tmp, itaul, date, dt,  &           llm_tmp, lon_lic, lat_lic, lev, ttm_tmp, itaul, date, trash,  &
226           fid)           fid)
227      CALL flinget(fid, 'landice', iml_lic, jml_lic, llm_tmp, ttm_tmp &      CALL flinget(fid, 'landice', iml_lic, jml_lic, llm_tmp, ttm_tmp &
228           , 1, 1, fraclic)           , 1, 1, fraclic)
# Line 251  contains Line 234  contains
234      print *, "jml_lic = ", jml_lic      print *, "jml_lic = ", jml_lic
235    
236      ! Si les coordonnées sont en degrés, on les transforme :      ! Si les coordonnées sont en degrés, on les transforme :
237      IF (MAXVAL( lon_lic(:, :) ) > pi)  THEN      IF (MAXVAL( lon_lic ) > pi)  THEN
238         lon_lic(:, :) = lon_lic(:, :) * pi / 180.         lon_lic = lon_lic * pi / 180.
239      ENDIF      ENDIF
240      IF (maxval( lat_lic(:, :) ) > pi) THEN      IF (maxval( lat_lic ) > pi) THEN
241         lat_lic(:, :) = lat_lic(:, :) * pi/ 180.         lat_lic = lat_lic * pi/ 180.
242      ENDIF      ENDIF
243    
244      dlon_lic(:) = lon_lic(:, 1)      dlon_lic = lon_lic(:, 1)
245      dlat_lic(:) = lat_lic(1, :)      dlat_lic = lat_lic(1, :)
246    
247      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &
248           rlatu)           rlatu)
249      flic_tmp(iim + 1, :) = flic_tmp(1, :)      flic_tmp(iim + 1, :) = flic_tmp(1, :)
250    
251      ! Passage sur la grille physique      ! Passage sur la grille physique
252      pctsrf(:, :)=0.      pctsrf = 0.
253      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)
254      ! Adéquation avec le maque terre/mer      ! Adéquation avec le maque terre/mer
255      WHERE (pctsrf(:, is_lic) < EPSFRA ) pctsrf(:, is_lic) = 0.      WHERE (pctsrf(:, is_lic) < EPSFRA ) pctsrf(:, is_lic) = 0.
256      WHERE (zmasq(:) < EPSFRA) pctsrf(:, is_lic) = 0.      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.
257      pctsrf(:, is_ter) = zmasq(:)      pctsrf(:, is_ter) = zmasq
258      where (zmasq(:) > EPSFRA)      where (zmasq > EPSFRA)
259         where (pctsrf(:, is_lic) >= zmasq(:))         where (pctsrf(:, is_lic) >= zmasq)
260            pctsrf(:, is_lic) = zmasq(:)            pctsrf(:, is_lic) = zmasq
261            pctsrf(:, is_ter) = 0.            pctsrf(:, is_ter) = 0.
262         elsewhere         elsewhere
263            pctsrf(:, is_ter) = zmasq(:) - pctsrf(:, is_lic)            pctsrf(:, is_ter) = zmasq - pctsrf(:, is_lic)
264            where (pctsrf(:, is_ter) < EPSFRA)            where (pctsrf(:, is_ter) < EPSFRA)
265               pctsrf(:, is_ter) = 0.               pctsrf(:, is_ter) = 0.
266               pctsrf(:, is_lic) = zmasq(:)               pctsrf(:, is_lic) = zmasq
267            end where            end where
268         end where         end where
269      end where      end where
270    
271      ! Sous-surface océan et glace de mer (pour démarrer on met glace      ! Sous-surface océan et glace de mer (pour démarrer on met glace
272      ! de mer à 0) :      ! de mer à 0) :
273      pctsrf(:, is_oce) = 1. - zmasq(:)      pctsrf(:, is_oce) = 1. - zmasq
274      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.
275    
276      ! Vérification que somme des sous-surfaces vaut 1:      ! Vérification que somme des sous-surfaces vaut 1:
277      ji = count(abs(sum(pctsrf(:, :), dim = 2) - 1. ) > EPSFRA)      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)
278      IF (ji /= 0) PRINT *, 'Problème répartition sous maille pour', ji, 'points'      IF (ji /= 0) then
279           PRINT *, 'Problème répartition sous maille pour ', ji, 'points'
280        end IF
281    
282      ! Calcul intermédiaire:      ! Calcul intermédiaire:
283      CALL massdair(p3d, masse)      CALL massdair(p3d, masse)
# Line 307  contains Line 292  contains
292    
293      ! Initialisation pour traceurs:      ! Initialisation pour traceurs:
294      call iniadvtrac      call iniadvtrac
295      ! Ecriture:      CALL inidissip
     CALL inidissip(lstardis, nitergdiv, nitergrot, niterh, tetagdiv, &  
          tetagrot, tetatemp)  
     itau_dyn = 0  
296      itau_phy = 0      itau_phy = 0
297      day_ref = dayref      day_ref = dayref
298      annee_ref = anneeref      annee_ref = anneeref
299    
300      CALL geopot(ip1jmp1, tpot, pk , pks,  phis  , phi)      CALL geopot(ip1jmp1, tpot, pk , pks,  phis, phi)
301      CALL caldyn0(0, uvent, vvent, tpot, psol, masse, pk, phis, phi, w, &      CALL caldyn0(uvent, vvent, tpot, psol, masse, pk, phis, phi, w, pbaru, &
302           pbaru, pbarv, 0)           pbarv)
303      CALL dynredem0("start.nc", dayref, phis)      CALL dynredem0("start.nc", dayref, phis)
304      CALL dynredem1("start.nc", 0., vvent, uvent, tpot, q3d, masse, psol)      CALL dynredem1("start.nc", vvent, uvent, tpot, q3d, masse, psol, itau=0)
305    
306      ! Ecriture état initial physique:      ! Ecriture état initial physique:
     print *, 'dtvr = ', dtvr  
307      print *, "iphysiq = ", iphysiq      print *, "iphysiq = ", iphysiq
     print *, "nbapp_rad = ", nbapp_rad  
308      phystep   = dtvr * REAL(iphysiq)      phystep   = dtvr * REAL(iphysiq)
     radpas    = NINT (86400./phystep/ nbapp_rad)  
309      print *, 'phystep = ', phystep      print *, 'phystep = ', phystep
     print *, "radpas = ", radpas  
310    
311      ! Initialisations :      ! Initialisations :
312      tsolsrf(:, is_ter) = tsol      tsolsrf(:, is_ter) = tsol
# Line 344  contains Line 322  contains
322      albe(:, is_oce) = 0.5      albe(:, is_oce) = 0.5
323      albe(:, is_sic) = 0.6      albe(:, is_sic) = 0.6
324      alblw = albe      alblw = albe
325      evap(:, :) = 0.      evap = 0.
326      qsolsrf(:, is_ter) = 150.      qsolsrf(:, is_ter) = 150.
327      qsolsrf(:, is_lic) = 150.      qsolsrf(:, is_lic) = 150.
328      qsolsrf(:, is_oce) = 150.      qsolsrf(:, is_oce) = 150.
# Line 358  contains Line 336  contains
336      q_ancien = 0.      q_ancien = 0.
337      agesno = 0.      agesno = 0.
338      !IM "slab" ocean      !IM "slab" ocean
339      tslab(:) = tsolsrf(:, is_oce)      tslab = tsolsrf(:, is_oce)
340      seaice = 0.      seaice = 0.
341    
342      frugs(:, is_oce) = rugmer(:)      frugs(:, is_oce) = rugmer
343      frugs(:, is_ter) = MAX(1.e-05, zstd(:) * zsig(:) / 2)      frugs(:, is_ter) = MAX(1.e-05, zstd * zsig / 2)
344      frugs(:, is_lic) = MAX(1.e-05, zstd(:) * zsig(:) / 2)      frugs(:, is_lic) = MAX(1.e-05, zstd * zsig / 2)
345      frugs(:, is_sic) = 0.001      frugs(:, is_sic) = 0.001
346      fder = 0.      fder = 0.
347      clwcon = 0.      clwcon = 0.
# Line 371  contains Line 349  contains
349      ratqs = 0.      ratqs = 0.
350      run_off_lic_0 = 0.      run_off_lic_0 = 0.
351    
352      call phyredem("startphy.nc", phystep, radpas, latfi, lonfi, pctsrf, &      call phyredem("startphy.nc", latfi, lonfi, pctsrf, &
353           tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, &           tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, &
354           evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &           evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &
355           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, rugsrel, &           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, &
356           t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0)           t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0)
357      CALL histclo      CALL histclo
358    

Legend:
Removed from v.5  
changed lines
  Added in v.30

  ViewVC Help
Powered by ViewVC 1.1.21