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

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

  ViewVC Help
Powered by ViewVC 1.1.21