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

Diff of /trunk/dyn3d/etat0.f

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

trunk/libf/dyn3d/etat0.f90 revision 3 by guez, Wed Feb 27 13:16:39 2008 UTC trunk/dyn3d/etat0.f90 revision 78 by guez, Wed Feb 5 17:51:07 2014 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".      use caldyn0_m, only: caldyn0
21        use comconst, only: dtvr, daysec, cpp, kappa
22      USE ioipsl, only: flinget, flinclo, flinopen_nozoom, flininfo, histclo      use comgeom, only: rlatu, rlonv, rlonu, rlatv, aire_2d, apoln, apols, &
23             cu_2d, cv_2d, inigeom
24      USE start_init_orog_m, only: start_init_orog, masque, phis      use conf_gcm_m, only: day_step, iphysiq, dayref, anneeref
     use start_init_phys_m, only: qsol_2d  
     use startdyn, only: start_inter_3d, start_init_dyn  
25      use dimens_m, only: iim, jjm, llm, nqmx      use dimens_m, only: iim, jjm, llm, nqmx
     use paramet_m, only: ip1jm, ip1jmp1  
     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  
26      use dimphy, only: zmasq      use dimphy, only: zmasq
     use conf_gcm_m, only: day_step, iphysiq, dayref, anneeref  
     use comgeom, only: rlatu, rlonv, rlonu, rlatv, aire_2d, apoln, apols, &  
          cu_2d, cv_2d  
     use serre, only: alphax  
27      use dimsoil, only: nsoilmx      use dimsoil, only: nsoilmx
28      use temps, only: itau_dyn, itau_phy, annee_ref, day_ref, dt      use disvert_m, only: ap, bp, preff, pa
29      use clesphys, only: ok_orodr, nbapp_rad      use dynredem0_m, only: dynredem0
30        use dynredem1_m, only: dynredem1
31        use exner_hyb_m, only: exner_hyb
32        use geopot_m, only: geopot
33      use grid_atob, only: grille_m      use grid_atob, only: grille_m
34      use grid_change, only: init_dyn_phy, dyn_phy      use grid_change, only: init_dyn_phy, dyn_phy
35        use histclo_m, only: histclo
36        use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra
37        use iniadvtrac_m, only: iniadvtrac
38        use inifilr_m, only: inifilr
39        use massdair_m, only: massdair
40        use netcdf, only: nf90_nowrite
41        use netcdf95, only: nf95_close, nf95_get_var, nf95_gw_var, &
42             nf95_inq_varid, nf95_open
43        use nr_util, only: pi
44        use paramet_m, only: ip1jm, ip1jmp1
45        use phyredem_m, only: phyredem
46        use pressure_var, only: pls, p3d
47      use q_sat_m, only: q_sat      use q_sat_m, only: q_sat
48      use exner_hyb_m, only: exner_hyb      use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz
49      use regr_coefoz_m, only: regr_coefoz      use regr_pr_o3_m, only: regr_pr_o3
50      use advtrac_m, only: iniadvtrac      use serre, only: alphax
51      use netcdf95, only: nf95_open, nf95_close, nf95_inq_varid, nf90_nowrite, &      use startdyn, only: start_init_dyn
52           nf90_get_var, handle_err      USE start_init_orog_m, only: start_init_orog, mask
53      use pressure_m, only: pls, p3d      use start_init_phys_m, only: start_init_phys
54        use start_inter_3d_m, only: start_inter_3d
55        use temps, only: itau_phy, annee_ref, day_ref
56    
57      ! Variables local to the procedure:      ! Variables local to the procedure:
58    
# Line 53  contains Line 60  contains
60      ! (latitude and longitude of a point of the scalar grid identified      ! (latitude and longitude of a point of the scalar grid identified
61      ! by a simple index, in °)      ! by a simple index, in °)
62    
63      REAL, dimension(iim + 1, jjm + 1, llm):: uvent, t3d, tpot      REAL, dimension(iim + 1, jjm + 1, llm):: ucov, t3d, teta
64      REAL vvent(iim + 1, jjm, llm)      REAL vcov(iim + 1, jjm, llm)
65    
66      REAL q3d(iim + 1, jjm + 1, llm, nqmx)      REAL q(iim + 1, jjm + 1, llm, nqmx)
67      ! (mass fractions of trace species      ! (mass fractions of trace species
68      ! "q3d(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)"      ! "q(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)"
69      ! and pressure level "pls(i, j, l)".)      ! and pressure level "pls(i, j, l)".)
70    
71      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
# Line 74  contains Line 81  contains
81      real seaice(klon) ! kg m-2      real seaice(klon) ! kg m-2
82      REAL frugs(klon, nbsrf), agesno(klon, nbsrf)      REAL frugs(klon, nbsrf), agesno(klon, nbsrf)
83      REAL rugmer(klon)      REAL rugmer(klon)
84      real, dimension(iim + 1, jjm + 1):: relief, zstd_2d, zsig_2d, zgam_2d      REAL phis(iim + 1, jjm + 1) ! surface geopotential, in m2 s-2
85        real, dimension(iim + 1, jjm + 1):: zmea_2d, zstd_2d, zsig_2d, zgam_2d
86      real, dimension(iim + 1, jjm + 1):: zthe_2d, zpic_2d, zval_2d      real, dimension(iim + 1, jjm + 1):: zthe_2d, zpic_2d, zval_2d
87      real, dimension(iim + 1, jjm + 1):: tsol_2d, psol      real, dimension(iim + 1, jjm + 1):: tsol_2d, qsol_2d, ps
88      REAL zmea(klon), zstd(klon)      REAL zmea(klon), zstd(klon)
89      REAL zsig(klon), zgam(klon)      REAL zsig(klon), zgam(klon)
90      REAL zthe(klon)      REAL zthe(klon)
91      REAL zpic(klon), zval(klon)      REAL zpic(klon), zval(klon)
92      REAL rugsrel(klon)      REAL t_ancien(klon, llm), q_ancien(klon, llm)
     REAL t_ancien(klon, llm), q_ancien(klon, llm)      !  
93      REAL run_off_lic_0(klon)      REAL run_off_lic_0(klon)
94      real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm)      real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm)
95      ! déclarations pour lecture glace de mer  
96      INTEGER iml_lic, jml_lic, llm_tmp, ttm_tmp      ! Déclarations pour lecture glace de mer :
97      INTEGER itaul(1), fid      INTEGER iml_lic, jml_lic
98      REAL lev(1), date      INTEGER ncid, varid
99      REAL, ALLOCATABLE:: lon_lic(:, :), lat_lic(:, :)      REAL, pointer:: dlon_lic(:), dlat_lic(:)
     REAL, ALLOCATABLE:: dlon_lic(:), dlat_lic(:)  
100      REAL, ALLOCATABLE:: fraclic(:, :) ! fraction land ice      REAL, ALLOCATABLE:: fraclic(:, :) ! fraction land ice
101      REAL flic_tmp(iim + 1, jjm + 1) !fraction land ice temporary      REAL flic_tmp(iim + 1, jjm + 1) ! fraction land ice temporary
102    
103      INTEGER l, ji      INTEGER l, ji
     INTEGER nq  
104    
105      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
106      real pks(iim + 1, jjm + 1)      real pks(iim + 1, jjm + 1)
107    
108      REAL masse(iim + 1, jjm + 1, llm)      REAL masse(iim + 1, jjm + 1, llm)
109      REAL phi(ip1jmp1, llm)      REAL phi(iim + 1, jjm + 1, llm)
110      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)
111      REAL w(ip1jmp1, llm)      REAL w(ip1jmp1, llm)
112      REAL phystep      REAL phystep
113      INTEGER radpas  
114      integer ncid, varid, ncerr, month      real sig1(klon, llm) ! section adiabatic updraft
115        real w01(klon, llm) ! vertical velocity within adiabatic updraft
116    
117      !---------------------------------      !---------------------------------
118    
119      print *, "Call sequence information: etat0"      print *, "Call sequence information: etat0"
120    
     ! Construct a grid:  
   
121      dtvr = daysec / real(day_step)      dtvr = daysec / real(day_step)
122      print *, 'dtvr = ', dtvr      print *, 'dtvr = ', dtvr
123    
124        ! Construct a grid:
125    
126      pa = 5e4      pa = 5e4
127      CALL iniconst      CALL iniconst
128      CALL inigeom      CALL inigeom
# Line 132  contains Line 138  contains
138      ! (with conversion to degrees)      ! (with conversion to degrees)
139      lonfi(klon) = 0.      lonfi(klon) = 0.
140    
141      call start_init_orog(relief, zstd_2d, zsig_2d, zgam_2d, zthe_2d, zpic_2d, &      call start_init_orog(phis, zmea_2d, zstd_2d, zsig_2d, zgam_2d, zthe_2d, &
142           zval_2d) ! also compute "masque" and "phis"           zpic_2d, zval_2d) ! also compute "mask"
143      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
144      zmasq = pack(masque, dyn_phy)      zmasq = pack(mask, dyn_phy)
145      PRINT *, 'Masque construit'      PRINT *, 'Masque construit'
146    
147      CALL start_init_dyn(tsol_2d, psol) ! also compute "qsol_2d"      call start_init_phys(tsol_2d, qsol_2d)
148        CALL start_init_dyn(tsol_2d, phis, ps)
149    
150      ! Compute pressure on intermediate levels:      ! Compute pressure on intermediate levels:
151      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * psol(:, :)      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * ps
152      CALL exner_hyb(psol, p3d, pks, pk)      CALL exner_hyb(ps, p3d, pks, pk)
153      IF (MINVAL(pk) == MAXVAL(pk)) stop '"pk" should not be constant'      IF (MINVAL(pk) == MAXVAL(pk)) then
154           print *, '"pk" should not be constant'
155      pls(:, :, :) = preff * (pk(:, :, :) / cpp)**(1. / kappa)         stop 1
156      PRINT *, "minval(pls(:, :, :)) = ", minval(pls(:, :, :))      end IF
157      print *, "maxval(pls(:, :, :)) = ", maxval(pls(:, :, :))  
158        pls = preff * (pk / cpp)**(1. / kappa)
159      uvent(:, :, :) = start_inter_3d('U', rlonv, rlatv, pls)      PRINT *, "minval(pls) = ", minval(pls)
160      forall (l = 1: llm) uvent(:iim, :, l) = uvent(:iim, :, l) * cu_2d(:iim, :)      print *, "maxval(pls) = ", maxval(pls)
161      uvent(iim+1, :, :) = uvent(1, :, :)  
162        call start_inter_3d('U', rlonv, rlatv, pls, ucov)
163      vvent(:, :, :) = start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :))      forall (l = 1: llm) ucov(:iim, :, l) = ucov(:iim, :, l) * cu_2d(:iim, :)
164      forall (l = 1: llm) vvent(:iim, :, l) = vvent(:iim, :, l) * cv_2d(:iim, :)      ucov(iim+1, :, :) = ucov(1, :, :)
165      vvent(iim + 1, :, :) = vvent(1, :, :)  
166        call start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :), vcov)
167      t3d(:, :, :) = start_inter_3d('TEMP', rlonu, rlatv, pls)      forall (l = 1: llm) vcov(:iim, :, l) = vcov(:iim, :, l) * cv_2d(:iim, :)
168      PRINT *,  'minval(t3d(:, :, :)) = ', minval(t3d(:, :, :))      vcov(iim + 1, :, :) = vcov(1, :, :)
169      print *, "maxval(t3d(:, :, :)) = ", maxval(t3d(:, :, :))  
170        call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d)
171      tpot(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :)      PRINT *, 'minval(t3d) = ', minval(t3d)
172      tpot(iim + 1, :, :) = tpot(1, :, :)      print *, "maxval(t3d) = ", maxval(t3d)
173      DO l=1, llm  
174         tpot(:, 1, l) = SUM(aire_2d(:, 1) * tpot(:, 1, l)) / apoln      teta(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :)
175         tpot(:, jjm + 1, l) = SUM(aire_2d(:, jjm + 1) * tpot(:, jjm + 1, l)) &      teta(iim + 1, :, :) = teta(1, :, :)
176        DO l = 1, llm
177           teta(:, 1, l) = SUM(aire_2d(:, 1) * teta(:, 1, l)) / apoln
178           teta(:, jjm + 1, l) = SUM(aire_2d(:, jjm + 1) * teta(:, jjm + 1, l)) &
179              / apols              / apols
180      ENDDO      ENDDO
181    
182      ! Calcul de l'humidité à saturation :      ! Calcul de l'humidité à saturation :
183      qsat(:, :, :) = q_sat(t3d, pls)      qsat = q_sat(t3d, pls)
184      PRINT *, "minval(qsat(:, :, :)) = ", minval(qsat(:, :, :))      PRINT *, "minval(qsat) = ", minval(qsat)
185      print *, "maxval(qsat(:, :, :)) = ", maxval(qsat(:, :, :))      print *, "maxval(qsat) = ", maxval(qsat)
186      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'
187    
188      ! Water vapor:      ! Water vapor:
189      q3d(:, :, :, 1) = 0.01 * start_inter_3d('R', rlonu, rlatv, pls) * qsat      call start_inter_3d('R', rlonu, rlatv, pls, q(:, :, :, 1))
190      WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10      q(:, :, :, 1) = 0.01 * q(:, :, :, 1) * qsat
191        WHERE (q(:, :, :, 1) < 0.) q(:, :, :, 1) = 1E-10
192      DO l = 1, llm      DO l = 1, llm
193         q3d(:, 1, l, 1) = SUM(aire_2d(:, 1) * q3d(:, 1, l, 1)) / apoln         q(:, 1, l, 1) = SUM(aire_2d(:, 1) * q(:, 1, l, 1)) / apoln
194         q3d(:, jjm + 1, l, 1) &         q(:, jjm + 1, l, 1) &
195              = SUM(aire_2d(:, jjm + 1) * q3d(:, jjm + 1, l, 1)) / apols              = SUM(aire_2d(:, jjm + 1) * q(:, jjm + 1, l, 1)) / apols
196      ENDDO      ENDDO
197    
198      q3d(:, :, :, 2:4) = 0. ! liquid water, radon and lead      q(:, :, :, 2:4) = 0. ! liquid water, radon and lead
   
     ! Ozone:  
199    
200      ! Compute ozone parameters on the LMDZ grid:      if (nqmx >= 5) then
201      call regr_coefoz         ! Ozone:
202           call regr_lat_time_coefoz
203      ! Find the month containing the day number "dayref":         call regr_pr_o3(q(:, :, :, 5))
204      month = (dayref - 1) / 30 + 1         ! Convert from mole fraction to mass fraction:
205      print *, "month = ", month         q(:, :, :, 5) = q(:, :, :, 5) * 48. / 29.
206        end if
207    
208        tsol = pack(tsol_2d, dyn_phy)
209        qsol = pack(qsol_2d, dyn_phy)
210        sn = 0. ! snow
211        radsol = 0.
212        tslab = 0. ! IM "slab" ocean
213        seaice = 0.
214        rugmer = 0.001
215        zmea = pack(zmea_2d, dyn_phy)
216        zstd = pack(zstd_2d, dyn_phy)
217        zsig = pack(zsig_2d, dyn_phy)
218        zgam = pack(zgam_2d, dyn_phy)
219        zthe = pack(zthe_2d, dyn_phy)
220        zpic = pack(zpic_2d, dyn_phy)
221        zval = pack(zval_2d, dyn_phy)
222    
223      call nf95_open("coefoz_LMDZ.nc", nf90_nowrite, ncid)      ! On initialise les sous-surfaces.
224        ! Lecture du fichier glace de terre pour fixer la fraction de terre
225        ! et de glace de terre :
226    
227      ! Get data at the right month from the input file:      call nf95_open("landiceref.nc", nf90_nowrite, ncid)
     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)  
228    
229      call nf95_close(ncid)      call nf95_inq_varid(ncid, 'longitude', varid)
230      ! Latitudes are in increasing order in the input file while      call nf95_gw_var(ncid, varid, dlon_lic)
231      ! "rlatu" is in decreasing order so we need to invert order. Also, we      iml_lic = size(dlon_lic)
     ! compute mass fraction from mole fraction:  
     q3d(:, :, :, 5) = q3d(:, jjm+1:1:-1, :, 5)  * 48. / 29.  
   
     tsol(:) = pack(tsol_2d, dyn_phy)  
     qsol(:) = pack(qsol_2d, dyn_phy)  
     sn(:) = 0. ! snow  
     radsol(:) = 0.  
     tslab(:) = 0. ! IM "slab" ocean  
     seaice(:) = 0.  
     rugmer(:) = 0.001  
     zmea(:) = pack(relief, dyn_phy)  
     zstd(:) = pack(zstd_2d, dyn_phy)  
     zsig(:) = pack(zsig_2d, dyn_phy)  
     zgam(:) = pack(zgam_2d, dyn_phy)  
     zthe(:) = pack(zthe_2d, dyn_phy)  
     zpic(:) = pack(zpic_2d, dyn_phy)  
     zval(:) = pack(zval_2d, dyn_phy)  
232    
233      rugsrel(:) = 0.      call nf95_inq_varid(ncid, 'latitude', varid)
234      IF (ok_orodr) rugsrel(:) = MAX(1.e-05, zstd(:) * zsig(:) / 2)      call nf95_gw_var(ncid, varid, dlat_lic)
235        jml_lic = size(dlat_lic)
236    
237      ! On initialise les sous-surfaces:      call nf95_inq_varid(ncid, 'landice', varid)
     ! Lecture du fichier glace de terre pour fixer la fraction de terre  
     ! et de glace de terre:  
     CALL flininfo("landiceref.nc", iml_lic, jml_lic, llm_tmp, &  
          ttm_tmp, fid)  
     ALLOCATE(lat_lic(iml_lic, jml_lic))  
     ALLOCATE(lon_lic(iml_lic, jml_lic))  
     ALLOCATE(dlon_lic(iml_lic))  
     ALLOCATE(dlat_lic(jml_lic))  
238      ALLOCATE(fraclic(iml_lic, jml_lic))      ALLOCATE(fraclic(iml_lic, jml_lic))
239      CALL flinopen_nozoom("landiceref.nc", iml_lic, jml_lic, &      call nf95_get_var(ncid, varid, fraclic)
240           llm_tmp, lon_lic, lat_lic, lev, ttm_tmp, itaul, date, dt,  &  
241           fid)      call nf95_close(ncid)
     CALL flinget(fid, 'landice', iml_lic, jml_lic, llm_tmp, ttm_tmp &  
          , 1, 1, fraclic)  
     CALL flinclo(fid)  
242    
243      ! Interpolation sur la grille T du modèle :      ! Interpolation sur la grille T du modèle :
244      PRINT *, 'Dimensions de "landice"'      PRINT *, 'Dimensions de "landiceref.nc"'
245      print *, "iml_lic = ", iml_lic      print *, "iml_lic = ", iml_lic
246      print *, "jml_lic = ", jml_lic      print *, "jml_lic = ", jml_lic
247    
248      ! Si les coordonnées sont en degrés, on les transforme :      ! Si les coordonnées sont en degrés, on les transforme :
249      IF (MAXVAL( lon_lic(:, :) ) > pi)  THEN      IF (MAXVAL(dlon_lic) > pi) THEN
250         lon_lic(:, :) = lon_lic(:, :) * pi / 180.         dlon_lic = dlon_lic * pi / 180.
251      ENDIF      ENDIF
252      IF (maxval( lat_lic(:, :) ) > pi) THEN      IF (maxval(dlat_lic) > pi) THEN
253         lat_lic(:, :) = lat_lic(:, :) * pi/ 180.         dlat_lic = dlat_lic * pi/ 180.
254      ENDIF      ENDIF
255    
     dlon_lic(:) = lon_lic(:, 1)  
     dlat_lic(:) = lat_lic(1, :)  
   
256      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &
257           rlatu)           rlatu)
258      flic_tmp(iim + 1, :) = flic_tmp(1, :)      flic_tmp(iim + 1, :) = flic_tmp(1, :)
259    
260        deallocate(dlon_lic, dlat_lic) ! pointers
261    
262      ! Passage sur la grille physique      ! Passage sur la grille physique
263      pctsrf(:, :)=0.      pctsrf = 0.
264      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)
265      ! Adéquation avec le maque terre/mer      ! Adéquation avec le maque terre/mer
266      WHERE (pctsrf(:, is_lic) < EPSFRA ) pctsrf(:, is_lic) = 0.      WHERE (pctsrf(:, is_lic) < EPSFRA) pctsrf(:, is_lic) = 0.
267      WHERE (zmasq(:) < EPSFRA) pctsrf(:, is_lic) = 0.      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.
268      pctsrf(:, is_ter) = zmasq(:)      pctsrf(:, is_ter) = zmasq
269      where (zmasq(:) > EPSFRA)      where (zmasq > EPSFRA)
270         where (pctsrf(:, is_lic) >= zmasq(:))         where (pctsrf(:, is_lic) >= zmasq)
271            pctsrf(:, is_lic) = zmasq(:)            pctsrf(:, is_lic) = zmasq
272            pctsrf(:, is_ter) = 0.            pctsrf(:, is_ter) = 0.
273         elsewhere         elsewhere
274            pctsrf(:, is_ter) = zmasq(:) - pctsrf(:, is_lic)            pctsrf(:, is_ter) = zmasq - pctsrf(:, is_lic)
275            where (pctsrf(:, is_ter) < EPSFRA)            where (pctsrf(:, is_ter) < EPSFRA)
276               pctsrf(:, is_ter) = 0.               pctsrf(:, is_ter) = 0.
277               pctsrf(:, is_lic) = zmasq(:)               pctsrf(:, is_lic) = zmasq
278            end where            end where
279         end where         end where
280      end where      end where
281    
282      ! 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
283      ! de mer à 0) :      ! de mer à 0) :
284      pctsrf(:, is_oce) = 1. - zmasq(:)      pctsrf(:, is_oce) = 1. - zmasq
285      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.
286    
287      ! Vérification que somme des sous-surfaces vaut 1:      ! Vérification que somme des sous-surfaces vaut 1 :
288      ji = count(abs(sum(pctsrf(:, :), dim = 2) - 1. ) > EPSFRA)      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)
289      IF (ji /= 0) PRINT *, 'Problème répartition sous maille pour', ji, 'points'      IF (ji /= 0) then
290           PRINT *, 'Problème répartition sous maille pour ', ji, 'points'
291        end IF
292    
293      ! Calcul intermédiaire:      ! Calcul intermédiaire :
294      CALL massdair(p3d, masse)      CALL massdair(p3d, masse)
295    
296      print *, 'ALPHAX = ', alphax      print *, 'ALPHAX = ', alphax
297    
298      forall  (l = 1:llm)      forall (l = 1:llm)
299         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
300         masse(:, jjm + 1, l) = &         masse(:, jjm + 1, l) = &
301              SUM(aire_2d(:iim, jjm + 1) * masse(:iim, jjm + 1, l)) / apols              SUM(aire_2d(:iim, jjm + 1) * masse(:iim, jjm + 1, l)) / apols
302      END forall      END forall
303    
304      ! Initialisation pour traceurs:      ! Initialisation pour traceurs:
305      call iniadvtrac(nq)      call iniadvtrac
     ! Ecriture:  
     CALL inidissip(lstardis, nitergdiv, nitergrot, niterh, tetagdiv, &  
          tetagrot, tetatemp)  
     itau_dyn = 0  
306      itau_phy = 0      itau_phy = 0
307      day_ref = dayref      day_ref = dayref
308      annee_ref = anneeref      annee_ref = anneeref
309    
310      CALL geopot(ip1jmp1, tpot, pk , pks,  phis  , phi)      CALL geopot(teta, pk , pks, phis, phi)
311      CALL caldyn0(0, uvent, vvent, tpot, psol, masse, pk, phis, phi, w, &      CALL caldyn0(ucov, vcov, teta, ps, masse, pk, phis, phi, w, pbaru, &
312           pbaru, pbarv, 0)           pbarv)
313      CALL dynredem0("start.nc", dayref, phis, nqmx)      CALL dynredem0("start.nc", dayref, phis)
314      CALL dynredem1("start.nc", 0., vvent, uvent, tpot, q3d, nqmx, masse, psol)      CALL dynredem1("start.nc", vcov, ucov, teta, q, masse, ps, itau=0)
315    
316      ! Ecriture état initial physique:      ! Ecriture état initial physique:
     print *, 'dtvr = ', dtvr  
317      print *, "iphysiq = ", iphysiq      print *, "iphysiq = ", iphysiq
318      print *, "nbapp_rad = ", nbapp_rad      phystep = dtvr * REAL(iphysiq)
     phystep   = dtvr * REAL(iphysiq)  
     radpas    = NINT (86400./phystep/ nbapp_rad)  
319      print *, 'phystep = ', phystep      print *, 'phystep = ', phystep
     print *, "radpas = ", radpas  
320    
321      ! Initialisations :      ! Initialisations :
322      tsolsrf(:, is_ter) = tsol      tsolsrf(:, is_ter) = tsol
# Line 343  contains Line 332  contains
332      albe(:, is_oce) = 0.5      albe(:, is_oce) = 0.5
333      albe(:, is_sic) = 0.6      albe(:, is_sic) = 0.6
334      alblw = albe      alblw = albe
335      evap(:, :) = 0.      evap = 0.
336      qsolsrf(:, is_ter) = 150.      qsolsrf(:, is_ter) = 150.
337      qsolsrf(:, is_lic) = 150.      qsolsrf(:, is_lic) = 150.
338      qsolsrf(:, is_oce) = 150.      qsolsrf(:, is_oce) = 150.
# Line 357  contains Line 346  contains
346      q_ancien = 0.      q_ancien = 0.
347      agesno = 0.      agesno = 0.
348      !IM "slab" ocean      !IM "slab" ocean
349      tslab(:) = tsolsrf(:, is_oce)      tslab = tsolsrf(:, is_oce)
350      seaice = 0.      seaice = 0.
351    
352      frugs(:, is_oce) = rugmer(:)      frugs(:, is_oce) = rugmer
353      frugs(:, is_ter) = MAX(1.e-05, zstd(:) * zsig(:) / 2)      frugs(:, is_ter) = MAX(1e-5, zstd * zsig / 2)
354      frugs(:, is_lic) = MAX(1.e-05, zstd(:) * zsig(:) / 2)      frugs(:, is_lic) = MAX(1e-5, zstd * zsig / 2)
355      frugs(:, is_sic) = 0.001      frugs(:, is_sic) = 0.001
356      fder = 0.      fder = 0.
357      clwcon = 0.      clwcon = 0.
358      rnebcon = 0.      rnebcon = 0.
359      ratqs = 0.      ratqs = 0.
360      run_off_lic_0 = 0.      run_off_lic_0 = 0.
361        sig1 = 0.
362        w01 = 0.
363    
364      call phyredem("startphy.nc", phystep, radpas, latfi, lonfi, pctsrf, &      call phyredem("startphy.nc", latfi, lonfi, pctsrf, &
365           tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, &           tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, &
366           evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &           evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &
367           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, rugsrel, &           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, &
368           t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0)           t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0, sig1, w01)
369      CALL histclo      CALL histclo
370    
371    END SUBROUTINE etat0    END SUBROUTINE etat0

Legend:
Removed from v.3  
changed lines
  Added in v.78

  ViewVC Help
Powered by ViewVC 1.1.21