/[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 65 by guez, Thu Sep 20 09:57:03 2012 UTC trunk/dyn3d/etat0.f revision 99 by guez, Wed Jul 2 18:39:15 2014 UTC
# Line 7  module etat0_mod Line 7  module etat0_mod
7    
8    REAL pctsrf(klon, nbsrf)    REAL pctsrf(klon, nbsrf)
9    ! ("pctsrf(i, :)" is the composition of the surface at horizontal    ! ("pctsrf(i, :)" is the composition of the surface at horizontal
10    !  position "i")    ! position "i")
11    
12    private nbsrf, klon    private nbsrf, klon
13    
# Line 15  contains Line 15  contains
15    
16    SUBROUTINE etat0    SUBROUTINE etat0
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      use caldyn0_m, only: caldyn0      use caldyn0_m, only: caldyn0
21      use comconst, only: dtvr, daysec, cpp, kappa      use comconst, only: cpp, kappa, iniconst
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, inigeom
24      use comvert, only: ap, bp, preff, pa      use conf_gcm_m, only: dayref, anneeref
     use conf_gcm_m, only: day_step, iphysiq, dayref, anneeref  
25      use dimens_m, only: iim, jjm, llm, nqmx      use dimens_m, only: iim, jjm, llm, nqmx
26      use dimphy, only: zmasq      use dimphy, only: zmasq
27      use dimsoil, only: nsoilmx      use dimsoil, only: nsoilmx
28        use disvert_m, only: ap, bp, preff, pa, disvert
29      use dynredem0_m, only: dynredem0      use dynredem0_m, only: dynredem0
30      use dynredem1_m, only: dynredem1      use dynredem1_m, only: dynredem1
31      use exner_hyb_m, only: exner_hyb      use exner_hyb_m, only: exner_hyb
     USE flincom, only: flinclo, flinopen_nozoom, flininfo  
32      use geopot_m, only: geopot      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      use histclo_m, only: histclo
36      use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra      use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra
37      use iniadvtrac_m, only: iniadvtrac      use iniadvtrac_m, only: iniadvtrac
     use inidissip_m, only: inidissip  
38      use inifilr_m, only: inifilr      use inifilr_m, only: inifilr
39      use inigeom_m, only: inigeom      use massdair_m, only: massdair
40      use netcdf, only: nf90_nowrite      use netcdf, only: nf90_nowrite
41      use netcdf95, only: nf95_open, nf95_close, nf95_get_var, nf95_inq_varid      use netcdf95, only: nf95_close, nf95_get_var, nf95_gw_var, &
42      use nr_util, only: pi           nf95_inq_varid, nf95_open
43        use nr_util, only: pi, assert
44      use paramet_m, only: ip1jm, ip1jmp1      use paramet_m, only: ip1jm, ip1jmp1
45      use phyredem_m, only: phyredem      use phyredem_m, only: phyredem
     use pressure_var, only: pls, p3d  
46      use q_sat_m, only: q_sat      use q_sat_m, only: q_sat
47      use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz      use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz
48      use regr_pr_o3_m, only: regr_pr_o3      use regr_pr_o3_m, only: regr_pr_o3
49      use serre, only: alphax      use serre, only: alphax
     USE start_init_orog_m, only: start_init_orog, mask, phis  
     use start_init_phys_m, only: start_init_phys  
50      use startdyn, only: start_init_dyn      use startdyn, only: start_init_dyn
51        USE start_init_orog_m, only: start_init_orog, mask
52        use start_init_phys_m, only: start_init_phys
53      use start_inter_3d_m, only: start_inter_3d      use start_inter_3d_m, only: start_inter_3d
54      use temps, only: itau_phy, annee_ref, day_ref      use temps, only: itau_phy, annee_ref, day_ref
55        use test_disvert_m, only: test_disvert
56    
57      ! Variables local to the procedure:      ! Variables local to the procedure:
58    
59      REAL latfi(klon), lonfi(klon)      REAL latfi(klon), lonfi(klon)
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 degrees)
62    
63      REAL, dimension(iim + 1, jjm + 1, llm):: ucov, t3d, tpot      REAL, dimension(iim + 1, jjm + 1, llm):: ucov, t3d, teta
64      REAL vcov(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
72      REAL tsol(klon), qsol(klon), sn(klon)      REAL sn(klon)
73      REAL tsolsrf(klon, nbsrf), qsolsrf(klon, nbsrf), snsrf(klon, nbsrf)      REAL qsolsrf(klon, nbsrf), snsrf(klon, nbsrf)
74      REAL albe(klon, nbsrf), evap(klon, nbsrf)      REAL albe(klon, nbsrf), evap(klon, nbsrf)
75      REAL alblw(klon, nbsrf)      REAL alblw(klon, nbsrf)
76      REAL tsoil(klon, nsoilmx, nbsrf)      REAL tsoil(klon, nsoilmx, nbsrf)
77      REAL radsol(klon), rain_fall(klon), snow_fall(klon)      REAL radsol(klon), rain_fall(klon), snow_fall(klon)
78      REAL solsw(klon), sollw(klon), fder(klon)      REAL solsw(klon), sollw(klon), fder(klon)
79      !IM "slab" ocean      !IM "slab" ocean
     REAL tslab(klon)  
80      real seaice(klon) ! kg m-2      real seaice(klon) ! kg m-2
81      REAL frugs(klon, nbsrf), agesno(klon, nbsrf)      REAL frugs(klon, nbsrf), agesno(klon, nbsrf)
82      REAL rugmer(klon)      REAL rugmer(klon)
83      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
84        real, dimension(iim + 1, jjm + 1):: zmea_2d, 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, qsol_2d, psol      real, dimension(iim + 1, jjm + 1):: tsol_2d, qsol_2d, ps
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)
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)
94      ! déclarations pour lecture glace de mer  
95      INTEGER iml_lic, jml_lic, llm_tmp, ttm_tmp      ! D\'eclarations pour lecture glace de mer :
96      INTEGER itaul(1), fid, ncid, varid      INTEGER iml_lic, jml_lic
97      REAL lev(1), date      INTEGER ncid, varid
98      REAL, ALLOCATABLE:: lon_lic(:, :), lat_lic(:, :)      REAL, pointer:: dlon_lic(:), dlat_lic(:)
     REAL, ALLOCATABLE:: dlon_lic(:), dlat_lic(:)  
99      REAL, ALLOCATABLE:: fraclic(:, :) ! fraction land ice      REAL, ALLOCATABLE:: fraclic(:, :) ! fraction land ice
100      REAL flic_tmp(iim + 1, jjm + 1) !fraction land ice temporary      REAL flic_tmp(iim + 1, jjm + 1) ! fraction land ice temporary
101    
102      INTEGER l, ji      INTEGER l, ji
103    
# Line 107  contains Line 105  contains
105      real pks(iim + 1, jjm + 1)      real pks(iim + 1, jjm + 1)
106    
107      REAL masse(iim + 1, jjm + 1, llm)      REAL masse(iim + 1, jjm + 1, llm)
108      REAL phi(ip1jmp1, llm)      REAL phi(iim + 1, jjm + 1, llm)
109      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)
110      REAL w(ip1jmp1, llm)      REAL w(iim + 1, jjm + 1, llm)
111      REAL phystep  
112      real trash      real sig1(klon, llm) ! section adiabatic updraft
113        real w01(klon, llm) ! vertical velocity within adiabatic updraft
114    
115        real pls(iim + 1, jjm + 1, llm)
116        ! (pressure at mid-layer of LMDZ grid, in Pa)
117        ! "pls(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)",
118        ! for layer "l")
119    
120        REAL p3d(iim + 1, jjm + 1, llm+1) ! pressure at layer interfaces, in Pa
121        ! ("p3d(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)",
122        ! for interface "l")
123    
124      !---------------------------------      !---------------------------------
125    
126      print *, "Call sequence information: etat0"      print *, "Call sequence information: etat0"
127    
128      dtvr = daysec / real(day_step)      CALL iniconst
     print *, 'dtvr = ', dtvr  
129    
130      ! Construct a grid:      ! Construct a grid:
131    
132      pa = 5e4      pa = 5e4
133      CALL iniconst      CALL disvert
134        call test_disvert
135      CALL inigeom      CALL inigeom
136      CALL inifilr      CALL inifilr
137    
# Line 137  contains Line 145  contains
145      ! (with conversion to degrees)      ! (with conversion to degrees)
146      lonfi(klon) = 0.      lonfi(klon) = 0.
147    
148      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, &
149           zval_2d) ! also compute "mask" and "phis"           zpic_2d, zval_2d) ! also compute "mask"
150      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
151      zmasq = pack(mask, dyn_phy)      zmasq = pack(mask, dyn_phy)
152      PRINT *, 'Masque construit'      PRINT *, 'Masque construit'
153    
154      call start_init_phys(tsol_2d, qsol_2d)      call start_init_phys(tsol_2d, qsol_2d)
155      CALL start_init_dyn(tsol_2d, psol)      CALL start_init_dyn(tsol_2d, phis, ps)
156    
157      ! Compute pressure on intermediate levels:      ! Compute pressure on intermediate levels:
158      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * psol      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * ps
159      CALL exner_hyb(psol, p3d, pks, pk)      CALL exner_hyb(ps, p3d, pks, pk)
160      IF (MINVAL(pk) == MAXVAL(pk)) then      call assert(MINVAL(pk) /= MAXVAL(pk), '"pk" should not be constant')
        print *, '"pk" should not be constant'  
        stop 1  
     end IF  
161    
162      pls = preff * (pk / cpp)**(1. / kappa)      pls = preff * (pk / cpp)**(1. / kappa)
163      PRINT *, "minval(pls) = ", minval(pls)      PRINT *, "minval(pls) = ", minval(pls)
# Line 167  contains Line 172  contains
172      vcov(iim + 1, :, :) = vcov(1, :, :)      vcov(iim + 1, :, :) = vcov(1, :, :)
173    
174      call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d)      call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d)
175      PRINT *,  'minval(t3d) = ', minval(t3d)      PRINT *, 'minval(t3d) = ', minval(t3d)
176      print *, "maxval(t3d) = ", maxval(t3d)      print *, "maxval(t3d) = ", maxval(t3d)
177    
178      tpot(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :)      teta(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :)
179      tpot(iim + 1, :, :) = tpot(1, :, :)      teta(iim + 1, :, :) = teta(1, :, :)
180      DO l=1, llm      DO l = 1, llm
181         tpot(:, 1, l) = SUM(aire_2d(:, 1) * tpot(:, 1, l)) / apoln         teta(:, 1, l) = SUM(aire_2d(:, 1) * teta(:, 1, l)) / apoln
182         tpot(:, jjm + 1, l) = SUM(aire_2d(:, jjm + 1) * tpot(:, jjm + 1, l)) &         teta(:, jjm + 1, l) = SUM(aire_2d(:, jjm + 1) * teta(:, jjm + 1, l)) &
183              / apols              / apols
184      ENDDO      ENDDO
185    
186      ! Calcul de l'humidité à saturation :      ! Calcul de l'humidit\'e \`a saturation :
187      qsat = q_sat(t3d, pls)      qsat = q_sat(t3d, pls)
188      PRINT *, "minval(qsat) = ", minval(qsat)      PRINT *, "minval(qsat) = ", minval(qsat)
189      print *, "maxval(qsat) = ", maxval(qsat)      print *, "maxval(qsat) = ", maxval(qsat)
190      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'
191    
192      ! Water vapor:      ! Water vapor:
193      call start_inter_3d('R', rlonu, rlatv, pls, q3d(:, :, :, 1))      call start_inter_3d('R', rlonu, rlatv, pls, q(:, :, :, 1))
194      q3d(:, :, :, 1) = 0.01 * q3d(:, :, :, 1) * qsat      q(:, :, :, 1) = 0.01 * q(:, :, :, 1) * qsat
195      WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10      WHERE (q(:, :, :, 1) < 0.) q(:, :, :, 1) = 1E-10
196      DO l = 1, llm      DO l = 1, llm
197         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
198         q3d(:, jjm + 1, l, 1) &         q(:, jjm + 1, l, 1) &
199              = SUM(aire_2d(:, jjm + 1) * q3d(:, jjm + 1, l, 1)) / apols              = SUM(aire_2d(:, jjm + 1) * q(:, jjm + 1, l, 1)) / apols
200      ENDDO      ENDDO
201    
202      q3d(:, :, :, 2:4) = 0. ! liquid water, radon and lead      q(:, :, :, 2:4) = 0. ! liquid water, radon and lead
203    
204      if (nqmx >= 5) then      if (nqmx >= 5) then
205         ! Ozone:         ! Ozone:
206         call regr_lat_time_coefoz         call regr_lat_time_coefoz
207         call regr_pr_o3(q3d(:, :, :, 5))         call regr_pr_o3(p3d, q(:, :, :, 5))
208         ! Convert from mole fraction to mass fraction:         ! Convert from mole fraction to mass fraction:
209         q3d(:, :, :, 5) = q3d(:, :, :, 5)  * 48. / 29.         q(:, :, :, 5) = q(:, :, :, 5) * 48. / 29.
210      end if      end if
211    
     tsol = pack(tsol_2d, dyn_phy)  
     qsol = pack(qsol_2d, dyn_phy)  
212      sn = 0. ! snow      sn = 0. ! snow
213      radsol = 0.      radsol = 0.
     tslab = 0. ! IM "slab" ocean  
214      seaice = 0.      seaice = 0.
215      rugmer = 0.001      rugmer = 0.001
216      zmea = pack(relief, dyn_phy)      zmea = pack(zmea_2d, dyn_phy)
217      zstd = pack(zstd_2d, dyn_phy)      zstd = pack(zstd_2d, dyn_phy)
218      zsig = pack(zsig_2d, dyn_phy)      zsig = pack(zsig_2d, dyn_phy)
219      zgam = pack(zgam_2d, dyn_phy)      zgam = pack(zgam_2d, dyn_phy)
# Line 222  contains Line 224  contains
224      ! On initialise les sous-surfaces.      ! On initialise les sous-surfaces.
225      ! Lecture du fichier glace de terre pour fixer la fraction de terre      ! Lecture du fichier glace de terre pour fixer la fraction de terre
226      ! et de glace de terre :      ! et de glace de terre :
227      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))  
     ALLOCATE(fraclic(iml_lic, jml_lic))  
     CALL flinopen_nozoom(iml_lic, jml_lic, &  
          llm_tmp, lon_lic, lat_lic, lev, ttm_tmp, itaul, date, trash,  &  
          fid)  
     CALL flinclo(fid)  
228      call nf95_open("landiceref.nc", nf90_nowrite, ncid)      call nf95_open("landiceref.nc", nf90_nowrite, ncid)
229    
230        call nf95_inq_varid(ncid, 'longitude', varid)
231        call nf95_gw_var(ncid, varid, dlon_lic)
232        iml_lic = size(dlon_lic)
233    
234        call nf95_inq_varid(ncid, 'latitude', varid)
235        call nf95_gw_var(ncid, varid, dlat_lic)
236        jml_lic = size(dlat_lic)
237    
238      call nf95_inq_varid(ncid, 'landice', varid)      call nf95_inq_varid(ncid, 'landice', varid)
239        ALLOCATE(fraclic(iml_lic, jml_lic))
240      call nf95_get_var(ncid, varid, fraclic)      call nf95_get_var(ncid, varid, fraclic)
241    
242      call nf95_close(ncid)      call nf95_close(ncid)
243    
244      ! Interpolation sur la grille T du modèle :      ! Interpolation sur la grille T du mod\`ele :
245      PRINT *, 'Dimensions de "landice"'      PRINT *, 'Dimensions de "landiceref.nc"'
246      print *, "iml_lic = ", iml_lic      print *, "iml_lic = ", iml_lic
247      print *, "jml_lic = ", jml_lic      print *, "jml_lic = ", jml_lic
248    
249      ! Si les coordonnées sont en degrés, on les transforme :      ! Si les coordonn\'ees sont en degr\'es, on les transforme :
250      IF (MAXVAL( lon_lic ) > pi)  THEN      IF (MAXVAL(dlon_lic) > pi) THEN
251         lon_lic = lon_lic * pi / 180.         dlon_lic = dlon_lic * pi / 180.
252      ENDIF      ENDIF
253      IF (maxval( lat_lic ) > pi) THEN      IF (maxval(dlat_lic) > pi) THEN
254         lat_lic = lat_lic * pi/ 180.         dlat_lic = dlat_lic * pi/ 180.
255      ENDIF      ENDIF
256    
     dlon_lic = lon_lic(:, 1)  
     dlat_lic = lat_lic(1, :)  
   
257      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &
258           rlatu)           rlatu)
259      flic_tmp(iim + 1, :) = flic_tmp(1, :)      flic_tmp(iim + 1, :) = flic_tmp(1, :)
260    
261        deallocate(dlon_lic, dlat_lic) ! pointers
262    
263      ! Passage sur la grille physique      ! Passage sur la grille physique
264      pctsrf = 0.      pctsrf = 0.
265      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)
266      ! Adéquation avec le maque terre/mer      ! Ad\'equation avec le maque terre/mer
267      WHERE (pctsrf(:, is_lic) < EPSFRA ) pctsrf(:, is_lic) = 0.      WHERE (pctsrf(:, is_lic) < EPSFRA) pctsrf(:, is_lic) = 0.
268      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.
269      pctsrf(:, is_ter) = zmasq      pctsrf(:, is_ter) = zmasq
270      where (zmasq > EPSFRA)      where (zmasq > EPSFRA)
# Line 278  contains Line 280  contains
280         end where         end where
281      end where      end where
282    
283      ! Sous-surface océan et glace de mer (pour démarrer on met glace      ! Sous-surface oc\'ean et glace de mer (pour d\'emarrer on met glace
284      ! de mer à 0) :      ! de mer \`a 0) :
285      pctsrf(:, is_oce) = 1. - zmasq      pctsrf(:, is_oce) = 1. - zmasq
286      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.
287    
288      ! Vérification que somme des sous-surfaces vaut 1:      ! V\'erification que somme des sous-surfaces vaut 1 :
289      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)
290      IF (ji /= 0) then      IF (ji /= 0) then
291         PRINT *, 'Problème répartition sous maille pour ', ji, 'points'         PRINT *, 'Bad surface percentages for ', ji, 'points'
292      end IF      end IF
293    
294      ! Calcul intermédiaire:      ! Calcul interm\'ediaire :
295      CALL massdair(p3d, masse)      CALL massdair(p3d, masse)
296    
297      print *, 'ALPHAX = ', alphax      print *, 'ALPHAX = ', alphax
298    
299      forall  (l = 1:llm)      forall (l = 1:llm)
300         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
301         masse(:, jjm + 1, l) = &         masse(:, jjm + 1, l) = &
302              SUM(aire_2d(:iim, jjm + 1) * masse(:iim, jjm + 1, l)) / apols              SUM(aire_2d(:iim, jjm + 1) * masse(:iim, jjm + 1, l)) / apols
# Line 302  contains Line 304  contains
304    
305      ! Initialisation pour traceurs:      ! Initialisation pour traceurs:
306      call iniadvtrac      call iniadvtrac
     CALL inidissip  
307      itau_phy = 0      itau_phy = 0
308      day_ref = dayref      day_ref = dayref
309      annee_ref = anneeref      annee_ref = anneeref
310    
311      CALL geopot(ip1jmp1, tpot, pk , pks,  phis, phi)      CALL geopot(teta, pk , pks, phis, phi)
312      CALL caldyn0(ucov, vcov, tpot, psol, masse, pk, phis, phi, w, pbaru, &      CALL caldyn0(ucov, vcov, teta, ps, masse, pk, phis, phi, w, pbaru, &
313           pbarv)           pbarv)
314      CALL dynredem0("start.nc", dayref, phis)      CALL dynredem0("start.nc", dayref, phis)
315      CALL dynredem1("start.nc", vcov, ucov, tpot, q3d, masse, psol, itau=0)      CALL dynredem1("start.nc", vcov, ucov, teta, q, masse, ps, itau=0)
   
     ! Ecriture état initial physique:  
     print *, "iphysiq = ", iphysiq  
     phystep   = dtvr * REAL(iphysiq)  
     print *, 'phystep = ', phystep  
316    
317      ! Initialisations :      ! Initialisations :
     tsolsrf(:, is_ter) = tsol  
     tsolsrf(:, is_lic) = tsol  
     tsolsrf(:, is_oce) = tsol  
     tsolsrf(:, is_sic) = tsol  
318      snsrf(:, is_ter) = sn      snsrf(:, is_ter) = sn
319      snsrf(:, is_lic) = sn      snsrf(:, is_lic) = sn
320      snsrf(:, is_oce) = sn      snsrf(:, is_oce) = sn
# Line 333  contains Line 325  contains
325      albe(:, is_sic) = 0.6      albe(:, is_sic) = 0.6
326      alblw = albe      alblw = albe
327      evap = 0.      evap = 0.
328      qsolsrf(:, is_ter) = 150.      qsolsrf = 150.
329      qsolsrf(:, is_lic) = 150.      tsoil = spread(spread(pack(tsol_2d, dyn_phy), 2, nsoilmx), 3, nbsrf)
     qsolsrf(:, is_oce) = 150.  
     qsolsrf(:, is_sic) = 150.  
     tsoil = spread(spread(tsol, 2, nsoilmx), 3, nbsrf)  
330      rain_fall = 0.      rain_fall = 0.
331      snow_fall = 0.      snow_fall = 0.
332      solsw = 165.      solsw = 165.
# Line 345  contains Line 334  contains
334      t_ancien = 273.15      t_ancien = 273.15
335      q_ancien = 0.      q_ancien = 0.
336      agesno = 0.      agesno = 0.
     !IM "slab" ocean  
     tslab = tsolsrf(:, is_oce)  
337      seaice = 0.      seaice = 0.
338    
339      frugs(:, is_oce) = rugmer      frugs(:, is_oce) = rugmer
340      frugs(:, is_ter) = MAX(1.e-05, zstd * zsig / 2)      frugs(:, is_ter) = MAX(1e-5, zstd * zsig / 2)
341      frugs(:, is_lic) = MAX(1.e-05, zstd * zsig / 2)      frugs(:, is_lic) = MAX(1e-5, zstd * zsig / 2)
342      frugs(:, is_sic) = 0.001      frugs(:, is_sic) = 0.001
343      fder = 0.      fder = 0.
344      clwcon = 0.      clwcon = 0.
345      rnebcon = 0.      rnebcon = 0.
346      ratqs = 0.      ratqs = 0.
347      run_off_lic_0 = 0.      run_off_lic_0 = 0.
348        sig1 = 0.
349        w01 = 0.
350    
351      call phyredem("startphy.nc", latfi, lonfi, pctsrf, &      call phyredem("startphy.nc", latfi, lonfi, pctsrf, tsoil(:, 1, :), tsoil, &
352           tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, &           tsoil(:, 1, is_oce), seaice, qsolsrf, pack(qsol_2d, dyn_phy), snsrf, &
353           evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &           albe, alblw, evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, &
354           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, &           frugs, agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, t_ancien, &
355           t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0)           q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0, sig1, w01)
356      CALL histclo      CALL histclo
357    
358    END SUBROUTINE etat0    END SUBROUTINE etat0

Legend:
Removed from v.65  
changed lines
  Added in v.99

  ViewVC Help
Powered by ViewVC 1.1.21