/[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 12 by guez, Mon Jul 21 16:05:07 2008 UTC revision 28 by guez, Fri Mar 26 18:33:04 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 clesphys2, 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 q_sat_m, only: q_sat      use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra
37      use exner_hyb_m, only: exner_hyb      use iniadvtrac_m, only: iniadvtrac
38      use advtrac_m, only: iniadvtrac      use inidissip_m, only: inidissip
39        use inigeom_m, only: inigeom
40        USE ioipsl, only: flinget, flinclo, flinopen_nozoom, flininfo, histclo
41        use paramet_m, only: ip1jm, ip1jmp1
42        use phyredem_m, only: phyredem
43      use pressure_var, only: pls, p3d      use pressure_var, only: pls, p3d
44      use dynredem0_m, only: dynredem0      use q_sat_m, only: q_sat
45      use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz      use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz
46      use regr_pr_o3_m, only: regr_pr_o3      use regr_pr_o3_m, only: regr_pr_o3
47        use serre, only: alphax
48        USE start_init_orog_m, only: start_init_orog, mask, phis
49        use start_init_phys_m, only: qsol_2d
50        use startdyn, only: start_inter_3d, start_init_dyn
51        use temps, only: itau_phy, annee_ref, day_ref
52    
53      ! Variables local to the procedure:      ! Variables local to the procedure:
54    
# Line 81  contains Line 84  contains
84      REAL zsig(klon), zgam(klon)      REAL zsig(klon), zgam(klon)
85      REAL zthe(klon)      REAL zthe(klon)
86      REAL zpic(klon), zval(klon)      REAL zpic(klon), zval(klon)
     REAL rugsrel(klon)  
87      REAL t_ancien(klon, llm), q_ancien(klon, llm)      !      REAL t_ancien(klon, llm), q_ancien(klon, llm)      !
88      REAL run_off_lic_0(klon)      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)
# Line 104  contains Line 106  contains
106      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)
107      REAL w(ip1jmp1, llm)      REAL w(ip1jmp1, llm)
108      REAL phystep      REAL phystep
109      INTEGER radpas      real trash
110    
111      !---------------------------------      !---------------------------------
112    
# Line 131  contains Line 133  contains
133      lonfi(klon) = 0.      lonfi(klon) = 0.
134    
135      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, &
136           zval_2d) ! also compute "masque" and "phis"           zval_2d) ! also compute "mask" and "phis"
137      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
138      zmasq = pack(masque, dyn_phy)      zmasq = pack(mask, dyn_phy)
139      PRINT *, 'Masque construit'      PRINT *, 'Masque construit'
140    
141      CALL start_init_dyn(tsol_2d, psol) ! also compute "qsol_2d"      CALL start_init_dyn(tsol_2d, psol) ! also compute "qsol_2d"
142    
143      ! Compute pressure on intermediate levels:      ! Compute pressure on intermediate levels:
144      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * psol(:, :)      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * psol
145      CALL exner_hyb(psol, p3d, pks, pk)      CALL exner_hyb(psol, p3d, pks, pk)
146      IF (MINVAL(pk) == MAXVAL(pk)) stop '"pk" should not be constant'      IF (MINVAL(pk) == MAXVAL(pk)) stop '"pk" should not be constant'
147    
# Line 147  contains Line 149  contains
149      PRINT *, "minval(pls(:, :, :)) = ", minval(pls(:, :, :))      PRINT *, "minval(pls(:, :, :)) = ", minval(pls(:, :, :))
150      print *, "maxval(pls(:, :, :)) = ", maxval(pls(:, :, :))      print *, "maxval(pls(:, :, :)) = ", maxval(pls(:, :, :))
151    
152      uvent(:, :, :) = start_inter_3d('U', rlonv, rlatv, pls)      call start_inter_3d('U', rlonv, rlatv, pls, uvent)
153      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, :)
154      uvent(iim+1, :, :) = uvent(1, :, :)      uvent(iim+1, :, :) = uvent(1, :, :)
155    
156      vvent(:, :, :) = start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :))      call start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :), vvent)
157      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, :)
158      vvent(iim + 1, :, :) = vvent(1, :, :)      vvent(iim + 1, :, :) = vvent(1, :, :)
159    
160      t3d(:, :, :) = start_inter_3d('TEMP', rlonu, rlatv, pls)      call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d)
161      PRINT *,  'minval(t3d(:, :, :)) = ', minval(t3d(:, :, :))      PRINT *,  'minval(t3d(:, :, :)) = ', minval(t3d(:, :, :))
162      print *, "maxval(t3d(:, :, :)) = ", maxval(t3d(:, :, :))      print *, "maxval(t3d(:, :, :)) = ", maxval(t3d(:, :, :))
163    
# Line 174  contains Line 176  contains
176      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'
177    
178      ! Water vapor:      ! Water vapor:
179      q3d(:, :, :, 1) = 0.01 * start_inter_3d('R', rlonu, rlatv, pls) * qsat      call start_inter_3d('R', rlonu, rlatv, pls, q3d(:, :, :, 1))
180        q3d(:, :, :, 1) = 0.01 * q3d(:, :, :, 1) * qsat
181      WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10      WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10
182      DO l = 1, llm      DO l = 1, llm
183         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 192  contains Line 195  contains
195         q3d(:, :, :, 5) = q3d(:, :, :, 5)  * 48. / 29.         q3d(:, :, :, 5) = q3d(:, :, :, 5)  * 48. / 29.
196      end if      end if
197    
198      tsol(:) = pack(tsol_2d, dyn_phy)      tsol = pack(tsol_2d, dyn_phy)
199      qsol(:) = pack(qsol_2d, dyn_phy)      qsol = pack(qsol_2d, dyn_phy)
200      sn(:) = 0. ! snow      sn = 0. ! snow
201      radsol(:) = 0.      radsol = 0.
202      tslab(:) = 0. ! IM "slab" ocean      tslab = 0. ! IM "slab" ocean
203      seaice(:) = 0.      seaice = 0.
204      rugmer(:) = 0.001      rugmer = 0.001
205      zmea(:) = pack(relief, dyn_phy)      zmea = pack(relief, dyn_phy)
206      zstd(:) = pack(zstd_2d, dyn_phy)      zstd = pack(zstd_2d, dyn_phy)
207      zsig(:) = pack(zsig_2d, dyn_phy)      zsig = pack(zsig_2d, dyn_phy)
208      zgam(:) = pack(zgam_2d, dyn_phy)      zgam = pack(zgam_2d, dyn_phy)
209      zthe(:) = pack(zthe_2d, dyn_phy)      zthe = pack(zthe_2d, dyn_phy)
210      zpic(:) = pack(zpic_2d, dyn_phy)      zpic = pack(zpic_2d, dyn_phy)
211      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)  
212    
213      ! On initialise les sous-surfaces:      ! On initialise les sous-surfaces:
214      ! 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 221  contains Line 221  contains
221      ALLOCATE(dlat_lic(jml_lic))      ALLOCATE(dlat_lic(jml_lic))
222      ALLOCATE(fraclic(iml_lic, jml_lic))      ALLOCATE(fraclic(iml_lic, jml_lic))
223      CALL flinopen_nozoom("landiceref.nc", iml_lic, jml_lic, &      CALL flinopen_nozoom("landiceref.nc", iml_lic, jml_lic, &
224           llm_tmp, lon_lic, lat_lic, lev, ttm_tmp, itaul, date, dt,  &           llm_tmp, lon_lic, lat_lic, lev, ttm_tmp, itaul, date, trash,  &
225           fid)           fid)
226      CALL flinget(fid, 'landice', iml_lic, jml_lic, llm_tmp, ttm_tmp &      CALL flinget(fid, 'landice', iml_lic, jml_lic, llm_tmp, ttm_tmp &
227           , 1, 1, fraclic)           , 1, 1, fraclic)
# Line 233  contains Line 233  contains
233      print *, "jml_lic = ", jml_lic      print *, "jml_lic = ", jml_lic
234    
235      ! Si les coordonnées sont en degrés, on les transforme :      ! Si les coordonnées sont en degrés, on les transforme :
236      IF (MAXVAL( lon_lic(:, :) ) > pi)  THEN      IF (MAXVAL( lon_lic ) > pi)  THEN
237         lon_lic(:, :) = lon_lic(:, :) * pi / 180.         lon_lic = lon_lic * pi / 180.
238      ENDIF      ENDIF
239      IF (maxval( lat_lic(:, :) ) > pi) THEN      IF (maxval( lat_lic ) > pi) THEN
240         lat_lic(:, :) = lat_lic(:, :) * pi/ 180.         lat_lic = lat_lic * pi/ 180.
241      ENDIF      ENDIF
242    
243      dlon_lic(:) = lon_lic(:, 1)      dlon_lic = lon_lic(:, 1)
244      dlat_lic(:) = lat_lic(1, :)      dlat_lic = lat_lic(1, :)
245    
246      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &
247           rlatu)           rlatu)
248      flic_tmp(iim + 1, :) = flic_tmp(1, :)      flic_tmp(iim + 1, :) = flic_tmp(1, :)
249    
250      ! Passage sur la grille physique      ! Passage sur la grille physique
251      pctsrf(:, :)=0.      pctsrf = 0.
252      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)
253      ! Adéquation avec le maque terre/mer      ! Adéquation avec le maque terre/mer
254      WHERE (pctsrf(:, is_lic) < EPSFRA ) pctsrf(:, is_lic) = 0.      WHERE (pctsrf(:, is_lic) < EPSFRA ) pctsrf(:, is_lic) = 0.
255      WHERE (zmasq(:) < EPSFRA) pctsrf(:, is_lic) = 0.      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.
256      pctsrf(:, is_ter) = zmasq(:)      pctsrf(:, is_ter) = zmasq
257      where (zmasq(:) > EPSFRA)      where (zmasq > EPSFRA)
258         where (pctsrf(:, is_lic) >= zmasq(:))         where (pctsrf(:, is_lic) >= zmasq)
259            pctsrf(:, is_lic) = zmasq(:)            pctsrf(:, is_lic) = zmasq
260            pctsrf(:, is_ter) = 0.            pctsrf(:, is_ter) = 0.
261         elsewhere         elsewhere
262            pctsrf(:, is_ter) = zmasq(:) - pctsrf(:, is_lic)            pctsrf(:, is_ter) = zmasq - pctsrf(:, is_lic)
263            where (pctsrf(:, is_ter) < EPSFRA)            where (pctsrf(:, is_ter) < EPSFRA)
264               pctsrf(:, is_ter) = 0.               pctsrf(:, is_ter) = 0.
265               pctsrf(:, is_lic) = zmasq(:)               pctsrf(:, is_lic) = zmasq
266            end where            end where
267         end where         end where
268      end where      end where
269    
270      ! 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
271      ! de mer à 0) :      ! de mer à 0) :
272      pctsrf(:, is_oce) = 1. - zmasq(:)      pctsrf(:, is_oce) = 1. - zmasq
273      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.
274    
275      ! Vérification que somme des sous-surfaces vaut 1:      ! Vérification que somme des sous-surfaces vaut 1:
276      ji = count(abs(sum(pctsrf(:, :), dim = 2) - 1. ) > EPSFRA)      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)
277      IF (ji /= 0) PRINT *, 'Problème répartition sous maille pour', ji, 'points'      IF (ji /= 0) then
278           PRINT *, 'Problème répartition sous maille pour ', ji, 'points'
279        end IF
280    
281      ! Calcul intermédiaire:      ! Calcul intermédiaire:
282      CALL massdair(p3d, masse)      CALL massdair(p3d, masse)
# Line 289  contains Line 291  contains
291    
292      ! Initialisation pour traceurs:      ! Initialisation pour traceurs:
293      call iniadvtrac      call iniadvtrac
294      ! Ecriture:      CALL inidissip
     CALL inidissip(lstardis, nitergdiv, nitergrot, niterh, tetagdiv, &  
          tetagrot, tetatemp)  
     itau_dyn = 0  
295      itau_phy = 0      itau_phy = 0
296      day_ref = dayref      day_ref = dayref
297      annee_ref = anneeref      annee_ref = anneeref
298    
299      CALL geopot(ip1jmp1, tpot, pk , pks,  phis  , phi)      CALL geopot(ip1jmp1, tpot, pk , pks,  phis, phi)
300      CALL caldyn0(0, uvent, vvent, tpot, psol, masse, pk, phis, phi, w, &      CALL caldyn0(uvent, vvent, tpot, psol, masse, pk, phis, phi, w, pbaru, &
301           pbaru, pbarv, 0)           pbarv)
302      CALL dynredem0("start.nc", dayref, phis)      CALL dynredem0("start.nc", dayref, phis)
303      CALL dynredem1("start.nc", 0., vvent, uvent, tpot, q3d, masse, psol)      CALL dynredem1("start.nc", vvent, uvent, tpot, q3d, masse, psol, itau=0)
304    
305      ! Ecriture état initial physique:      ! Ecriture état initial physique:
     print *, 'dtvr = ', dtvr  
306      print *, "iphysiq = ", iphysiq      print *, "iphysiq = ", iphysiq
     print *, "nbapp_rad = ", nbapp_rad  
307      phystep   = dtvr * REAL(iphysiq)      phystep   = dtvr * REAL(iphysiq)
     radpas    = NINT (86400./phystep/ nbapp_rad)  
308      print *, 'phystep = ', phystep      print *, 'phystep = ', phystep
     print *, "radpas = ", radpas  
309    
310      ! Initialisations :      ! Initialisations :
311      tsolsrf(:, is_ter) = tsol      tsolsrf(:, is_ter) = tsol
# Line 326  contains Line 321  contains
321      albe(:, is_oce) = 0.5      albe(:, is_oce) = 0.5
322      albe(:, is_sic) = 0.6      albe(:, is_sic) = 0.6
323      alblw = albe      alblw = albe
324      evap(:, :) = 0.      evap = 0.
325      qsolsrf(:, is_ter) = 150.      qsolsrf(:, is_ter) = 150.
326      qsolsrf(:, is_lic) = 150.      qsolsrf(:, is_lic) = 150.
327      qsolsrf(:, is_oce) = 150.      qsolsrf(:, is_oce) = 150.
# Line 340  contains Line 335  contains
335      q_ancien = 0.      q_ancien = 0.
336      agesno = 0.      agesno = 0.
337      !IM "slab" ocean      !IM "slab" ocean
338      tslab(:) = tsolsrf(:, is_oce)      tslab = tsolsrf(:, is_oce)
339      seaice = 0.      seaice = 0.
340    
341      frugs(:, is_oce) = rugmer(:)      frugs(:, is_oce) = rugmer
342      frugs(:, is_ter) = MAX(1.e-05, zstd(:) * zsig(:) / 2)      frugs(:, is_ter) = MAX(1.e-05, zstd * zsig / 2)
343      frugs(:, is_lic) = MAX(1.e-05, zstd(:) * zsig(:) / 2)      frugs(:, is_lic) = MAX(1.e-05, zstd * zsig / 2)
344      frugs(:, is_sic) = 0.001      frugs(:, is_sic) = 0.001
345      fder = 0.      fder = 0.
346      clwcon = 0.      clwcon = 0.
# Line 353  contains Line 348  contains
348      ratqs = 0.      ratqs = 0.
349      run_off_lic_0 = 0.      run_off_lic_0 = 0.
350    
351      call phyredem("startphy.nc", radpas, latfi, lonfi, pctsrf, &      call phyredem("startphy.nc", latfi, lonfi, pctsrf, &
352           tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, &           tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, &
353           evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &           evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &
354           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, rugsrel, &           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, &
355           t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0)           t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0)
356      CALL histclo      CALL histclo
357    

Legend:
Removed from v.12  
changed lines
  Added in v.28

  ViewVC Help
Powered by ViewVC 1.1.21