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

Diff of /trunk/dyn3d/etat0.f

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

revision 3 by guez, Wed Feb 27 13:16:39 2008 UTC revision 43 by guez, Fri Apr 8 12:43:31 2011 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
23        use comconst, only: dtvr, daysec, cpp, kappa
     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  
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 flincom, only: flinclo, flinopen_nozoom, flininfo
35        use flinget_m, only: flinget
36        use geopot_m, only: geopot
37      use grid_atob, only: grille_m      use grid_atob, only: grille_m
38      use grid_change, only: init_dyn_phy, dyn_phy      use grid_change, only: init_dyn_phy, dyn_phy
39        use histcom, only: histclo
40        use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra
41        use iniadvtrac_m, only: iniadvtrac
42        use inidissip_m, only: inidissip
43        use inigeom_m, only: inigeom
44        use nr_util, only: pi
45        use paramet_m, only: ip1jm, ip1jmp1
46        use phyredem_m, only: phyredem
47        use pressure_var, only: pls, p3d
48      use q_sat_m, only: q_sat      use q_sat_m, only: q_sat
49      use exner_hyb_m, only: exner_hyb      use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz
50      use regr_coefoz_m, only: regr_coefoz      use regr_pr_o3_m, only: regr_pr_o3
51      use advtrac_m, only: iniadvtrac      use serre, only: alphax
52      use netcdf95, only: nf95_open, nf95_close, nf95_inq_varid, nf90_nowrite, &      USE start_init_orog_m, only: start_init_orog, mask, phis
53           nf90_get_var, handle_err      use start_init_phys_m, only: start_init_phys
54      use pressure_m, only: pls, p3d      use startdyn, only: start_inter_3d, start_init_dyn
55        use temps, only: itau_phy, annee_ref, day_ref
56    
57      ! Variables local to the procedure:      ! Variables local to the procedure:
58    
# Line 76  contains Line 83  contains
83      REAL rugmer(klon)      REAL rugmer(klon)
84      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
85      real, dimension(iim + 1, jjm + 1):: zthe_2d, zpic_2d, zval_2d      real, dimension(iim + 1, jjm + 1):: zthe_2d, zpic_2d, zval_2d
86      real, dimension(iim + 1, jjm + 1):: tsol_2d, psol      real, dimension(iim + 1, jjm + 1):: tsol_2d, qsol_2d, psol
87      REAL zmea(klon), zstd(klon)      REAL zmea(klon), zstd(klon)
88      REAL zsig(klon), zgam(klon)      REAL zsig(klon), zgam(klon)
89      REAL zthe(klon)      REAL zthe(klon)
90      REAL zpic(klon), zval(klon)      REAL zpic(klon), zval(klon)
     REAL rugsrel(klon)  
91      REAL t_ancien(klon, llm), q_ancien(klon, llm)      !      REAL t_ancien(klon, llm), q_ancien(klon, llm)      !
92      REAL run_off_lic_0(klon)      REAL run_off_lic_0(klon)
93      real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm)      real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm)
# Line 95  contains Line 101  contains
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)
# Line 105  contains Line 110  contains
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      real trash
     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 133  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)) stop '"pk" should not be constant'
152    
153      pls(:, :, :) = preff * (pk(:, :, :) / cpp)**(1. / kappa)      pls = preff * (pk / cpp)**(1. / kappa)
154      PRINT *, "minval(pls(:, :, :)) = ", minval(pls(:, :, :))      PRINT *, "minval(pls) = ", minval(pls)
155      print *, "maxval(pls(:, :, :)) = ", maxval(pls(:, :, :))      print *, "maxval(pls) = ", maxval(pls)
156    
157      uvent(:, :, :) = start_inter_3d('U', rlonv, rlatv, pls)      call start_inter_3d('U', rlonv, rlatv, pls, uvent)
158      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, :)
159      uvent(iim+1, :, :) = uvent(1, :, :)      uvent(iim+1, :, :) = uvent(1, :, :)
160    
161      vvent(:, :, :) = start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :))      call start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :), vvent)
162      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, :)
163      vvent(iim + 1, :, :) = vvent(1, :, :)      vvent(iim + 1, :, :) = vvent(1, :, :)
164    
165      t3d(:, :, :) = start_inter_3d('TEMP', rlonu, rlatv, pls)      call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d)
166      PRINT *,  'minval(t3d(:, :, :)) = ', minval(t3d(:, :, :))      PRINT *,  'minval(t3d) = ', minval(t3d)
167      print *, "maxval(t3d(:, :, :)) = ", maxval(t3d(:, :, :))      print *, "maxval(t3d) = ", maxval(t3d)
168    
169      tpot(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :)      tpot(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :)
170      tpot(iim + 1, :, :) = tpot(1, :, :)      tpot(iim + 1, :, :) = tpot(1, :, :)
# Line 170  contains Line 175  contains
175      ENDDO      ENDDO
176    
177      ! Calcul de l'humidité à saturation :      ! Calcul de l'humidité à saturation :
178      qsat(:, :, :) = q_sat(t3d, pls)      qsat = q_sat(t3d, pls)
179      PRINT *, "minval(qsat(:, :, :)) = ", minval(qsat(:, :, :))      PRINT *, "minval(qsat) = ", minval(qsat)
180      print *, "maxval(qsat(:, :, :)) = ", maxval(qsat(:, :, :))      print *, "maxval(qsat) = ", maxval(qsat)
181      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'
182    
183      ! Water vapor:      ! Water vapor:
184      q3d(:, :, :, 1) = 0.01 * start_inter_3d('R', rlonu, rlatv, pls) * qsat      call start_inter_3d('R', rlonu, rlatv, pls, q3d(:, :, :, 1))
185        q3d(:, :, :, 1) = 0.01 * q3d(:, :, :, 1) * qsat
186      WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10      WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10
187      DO l = 1, llm      DO l = 1, llm
188         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 186  contains Line 192  contains
192    
193      q3d(:, :, :, 2:4) = 0. ! liquid water, radon and lead      q3d(:, :, :, 2:4) = 0. ! liquid water, radon and lead
194    
195      ! Ozone:      if (nqmx >= 5) then
196           ! Ozone:
197      ! Compute ozone parameters on the LMDZ grid:         call regr_lat_time_coefoz
198      call regr_coefoz         call regr_pr_o3(q3d(:, :, :, 5))
199           ! Convert from mole fraction to mass fraction:
200      ! Find the month containing the day number "dayref":         q3d(:, :, :, 5) = q3d(:, :, :, 5)  * 48. / 29.
201      month = (dayref - 1) / 30 + 1      end if
202      print *, "month = ", month  
203        tsol = pack(tsol_2d, dyn_phy)
204      call nf95_open("coefoz_LMDZ.nc", nf90_nowrite, ncid)      qsol = pack(qsol_2d, dyn_phy)
205        sn = 0. ! snow
206      ! Get data at the right month from the input file:      radsol = 0.
207      call nf95_inq_varid(ncid, "r_Mob", varid)      tslab = 0. ! IM "slab" ocean
208      ncerr = nf90_get_var(ncid, varid, q3d(:, :, :, 5), &      seaice = 0.
209           start=(/1, 1, 1, month/))      rugmer = 0.001
210      call handle_err("nf90_get_var r_Mob", ncerr)      zmea = pack(relief, dyn_phy)
211        zstd = pack(zstd_2d, dyn_phy)
212      call nf95_close(ncid)      zsig = pack(zsig_2d, dyn_phy)
213      ! Latitudes are in increasing order in the input file while      zgam = pack(zgam_2d, dyn_phy)
214      ! "rlatu" is in decreasing order so we need to invert order. Also, we      zthe = pack(zthe_2d, dyn_phy)
215      ! compute mass fraction from mole fraction:      zpic = pack(zpic_2d, dyn_phy)
216      q3d(:, :, :, 5) = q3d(:, jjm+1:1:-1, :, 5)  * 48. / 29.      zval = pack(zval_2d, dyn_phy)
   
     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)  
   
     rugsrel(:) = 0.  
     IF (ok_orodr) rugsrel(:) = MAX(1.e-05, zstd(:) * zsig(:) / 2)  
217    
218      ! On initialise les sous-surfaces:      ! On initialise les sous-surfaces:
219      ! 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 237  contains Line 225  contains
225      ALLOCATE(dlon_lic(iml_lic))      ALLOCATE(dlon_lic(iml_lic))
226      ALLOCATE(dlat_lic(jml_lic))      ALLOCATE(dlat_lic(jml_lic))
227      ALLOCATE(fraclic(iml_lic, jml_lic))      ALLOCATE(fraclic(iml_lic, jml_lic))
228      CALL flinopen_nozoom("landiceref.nc", iml_lic, jml_lic, &      CALL flinopen_nozoom(iml_lic, jml_lic, &
229           llm_tmp, lon_lic, lat_lic, lev, ttm_tmp, itaul, date, dt,  &           llm_tmp, lon_lic, lat_lic, lev, ttm_tmp, itaul, date, trash,  &
230           fid)           fid)
231      CALL flinget(fid, 'landice', iml_lic, jml_lic, llm_tmp, ttm_tmp &      CALL flinget(fid, 'landice', iml_lic, jml_lic, llm_tmp, ttm_tmp &
232           , 1, 1, fraclic)           , 1, 1, fraclic)
# Line 250  contains Line 238  contains
238      print *, "jml_lic = ", jml_lic      print *, "jml_lic = ", jml_lic
239    
240      ! Si les coordonnées sont en degrés, on les transforme :      ! Si les coordonnées sont en degrés, on les transforme :
241      IF (MAXVAL( lon_lic(:, :) ) > pi)  THEN      IF (MAXVAL( lon_lic ) > pi)  THEN
242         lon_lic(:, :) = lon_lic(:, :) * pi / 180.         lon_lic = lon_lic * pi / 180.
243      ENDIF      ENDIF
244      IF (maxval( lat_lic(:, :) ) > pi) THEN      IF (maxval( lat_lic ) > pi) THEN
245         lat_lic(:, :) = lat_lic(:, :) * pi/ 180.         lat_lic = lat_lic * pi/ 180.
246      ENDIF      ENDIF
247    
248      dlon_lic(:) = lon_lic(:, 1)      dlon_lic = lon_lic(:, 1)
249      dlat_lic(:) = lat_lic(1, :)      dlat_lic = lat_lic(1, :)
250    
251      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &
252           rlatu)           rlatu)
253      flic_tmp(iim + 1, :) = flic_tmp(1, :)      flic_tmp(iim + 1, :) = flic_tmp(1, :)
254    
255      ! Passage sur la grille physique      ! Passage sur la grille physique
256      pctsrf(:, :)=0.      pctsrf = 0.
257      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)
258      ! Adéquation avec le maque terre/mer      ! Adéquation avec le maque terre/mer
259      WHERE (pctsrf(:, is_lic) < EPSFRA ) pctsrf(:, is_lic) = 0.      WHERE (pctsrf(:, is_lic) < EPSFRA ) pctsrf(:, is_lic) = 0.
260      WHERE (zmasq(:) < EPSFRA) pctsrf(:, is_lic) = 0.      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.
261      pctsrf(:, is_ter) = zmasq(:)      pctsrf(:, is_ter) = zmasq
262      where (zmasq(:) > EPSFRA)      where (zmasq > EPSFRA)
263         where (pctsrf(:, is_lic) >= zmasq(:))         where (pctsrf(:, is_lic) >= zmasq)
264            pctsrf(:, is_lic) = zmasq(:)            pctsrf(:, is_lic) = zmasq
265            pctsrf(:, is_ter) = 0.            pctsrf(:, is_ter) = 0.
266         elsewhere         elsewhere
267            pctsrf(:, is_ter) = zmasq(:) - pctsrf(:, is_lic)            pctsrf(:, is_ter) = zmasq - pctsrf(:, is_lic)
268            where (pctsrf(:, is_ter) < EPSFRA)            where (pctsrf(:, is_ter) < EPSFRA)
269               pctsrf(:, is_ter) = 0.               pctsrf(:, is_ter) = 0.
270               pctsrf(:, is_lic) = zmasq(:)               pctsrf(:, is_lic) = zmasq
271            end where            end where
272         end where         end where
273      end where      end where
274    
275      ! 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
276      ! de mer à 0) :      ! de mer à 0) :
277      pctsrf(:, is_oce) = 1. - zmasq(:)      pctsrf(:, is_oce) = 1. - zmasq
278      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.
279    
280      ! Vérification que somme des sous-surfaces vaut 1:      ! Vérification que somme des sous-surfaces vaut 1:
281      ji = count(abs(sum(pctsrf(:, :), dim = 2) - 1. ) > EPSFRA)      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)
282      IF (ji /= 0) PRINT *, 'Problème répartition sous maille pour', ji, 'points'      IF (ji /= 0) then
283           PRINT *, 'Problème répartition sous maille pour ', ji, 'points'
284        end IF
285    
286      ! Calcul intermédiaire:      ! Calcul intermédiaire:
287      CALL massdair(p3d, masse)      CALL massdair(p3d, masse)
# Line 305  contains Line 295  contains
295      END forall      END forall
296    
297      ! Initialisation pour traceurs:      ! Initialisation pour traceurs:
298      call iniadvtrac(nq)      call iniadvtrac
299      ! Ecriture:      CALL inidissip
     CALL inidissip(lstardis, nitergdiv, nitergrot, niterh, tetagdiv, &  
          tetagrot, tetatemp)  
     itau_dyn = 0  
300      itau_phy = 0      itau_phy = 0
301      day_ref = dayref      day_ref = dayref
302      annee_ref = anneeref      annee_ref = anneeref
303    
304      CALL geopot(ip1jmp1, tpot, pk , pks,  phis  , phi)      CALL geopot(ip1jmp1, tpot, pk , pks,  phis, phi)
305      CALL caldyn0(0, uvent, vvent, tpot, psol, masse, pk, phis, phi, w, &      CALL caldyn0(uvent, vvent, tpot, psol, masse, pk, phis, phi, w, pbaru, &
306           pbaru, pbarv, 0)           pbarv)
307      CALL dynredem0("start.nc", dayref, phis, nqmx)      CALL dynredem0("start.nc", dayref, phis)
308      CALL dynredem1("start.nc", 0., vvent, uvent, tpot, q3d, nqmx, masse, psol)      CALL dynredem1("start.nc", vvent, uvent, tpot, q3d, masse, psol, itau=0)
309    
310      ! Ecriture état initial physique:      ! Ecriture état initial physique:
     print *, 'dtvr = ', dtvr  
311      print *, "iphysiq = ", iphysiq      print *, "iphysiq = ", iphysiq
     print *, "nbapp_rad = ", nbapp_rad  
312      phystep   = dtvr * REAL(iphysiq)      phystep   = dtvr * REAL(iphysiq)
     radpas    = NINT (86400./phystep/ nbapp_rad)  
313      print *, 'phystep = ', phystep      print *, 'phystep = ', phystep
     print *, "radpas = ", radpas  
314    
315      ! Initialisations :      ! Initialisations :
316      tsolsrf(:, is_ter) = tsol      tsolsrf(:, is_ter) = tsol
# Line 343  contains Line 326  contains
326      albe(:, is_oce) = 0.5      albe(:, is_oce) = 0.5
327      albe(:, is_sic) = 0.6      albe(:, is_sic) = 0.6
328      alblw = albe      alblw = albe
329      evap(:, :) = 0.      evap = 0.
330      qsolsrf(:, is_ter) = 150.      qsolsrf(:, is_ter) = 150.
331      qsolsrf(:, is_lic) = 150.      qsolsrf(:, is_lic) = 150.
332      qsolsrf(:, is_oce) = 150.      qsolsrf(:, is_oce) = 150.
# Line 357  contains Line 340  contains
340      q_ancien = 0.      q_ancien = 0.
341      agesno = 0.      agesno = 0.
342      !IM "slab" ocean      !IM "slab" ocean
343      tslab(:) = tsolsrf(:, is_oce)      tslab = tsolsrf(:, is_oce)
344      seaice = 0.      seaice = 0.
345    
346      frugs(:, is_oce) = rugmer(:)      frugs(:, is_oce) = rugmer
347      frugs(:, is_ter) = MAX(1.e-05, zstd(:) * zsig(:) / 2)      frugs(:, is_ter) = MAX(1.e-05, zstd * zsig / 2)
348      frugs(:, is_lic) = MAX(1.e-05, zstd(:) * zsig(:) / 2)      frugs(:, is_lic) = MAX(1.e-05, zstd * zsig / 2)
349      frugs(:, is_sic) = 0.001      frugs(:, is_sic) = 0.001
350      fder = 0.      fder = 0.
351      clwcon = 0.      clwcon = 0.
# Line 370  contains Line 353  contains
353      ratqs = 0.      ratqs = 0.
354      run_off_lic_0 = 0.      run_off_lic_0 = 0.
355    
356      call phyredem("startphy.nc", phystep, radpas, latfi, lonfi, pctsrf, &      call phyredem("startphy.nc", latfi, lonfi, pctsrf, &
357           tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, &           tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, &
358           evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &           evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &
359           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, rugsrel, &           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, &
360           t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0)           t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0)
361      CALL histclo      CALL histclo
362    

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

  ViewVC Help
Powered by ViewVC 1.1.21