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

Diff of /trunk/Sources/dyn3d/etat0.f

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

trunk/libf/dyn3d/etat0.f90 revision 48 by guez, Tue Jul 19 12:54:20 2011 UTC trunk/dyn3d/etat0.f revision 107 by guez, Thu Sep 11 15:09: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    
14  contains  contains
15    
16    SUBROUTINE etat0    SUBROUTINE etat0(phis)
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
   
     ! This subroutine creates "mask".  
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 histcom, 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
38      use inidissip_m, only: inidissip      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
50      USE start_init_orog_m, only: start_init_orog, mask, phis      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      use start_init_phys_m, only: start_init_phys
53      use startdyn, only: start_inter_3d, start_init_dyn      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        REAL, intent(out):: phis(:, :) ! (iim + 1, jjm + 1)
58        ! surface geopotential, in m2 s-2
59    
60      ! Variables local to the procedure:      ! Local:
61    
62      REAL latfi(klon), lonfi(klon)      REAL latfi(klon), lonfi(klon)
63      ! (latitude and longitude of a point of the scalar grid identified      ! (latitude and longitude of a point of the scalar grid identified
64      ! by a simple index, in °)      ! by a simple index, in degrees)
65    
66      REAL, dimension(iim + 1, jjm + 1, llm):: uvent, t3d, tpot      REAL, dimension(iim + 1, jjm + 1, llm):: ucov, t3d, teta
67      REAL vvent(iim + 1, jjm, llm)      REAL vcov(iim + 1, jjm, llm)
68    
69      REAL q3d(iim + 1, jjm + 1, llm, nqmx)      REAL q(iim + 1, jjm + 1, llm, nqmx)
70      ! (mass fractions of trace species      ! (mass fractions of trace species
71      ! "q3d(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)"      ! "q(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)"
72      ! and pressure level "pls(i, j, l)".)      ! and pressure level "pls(i, j, l)".)
73    
74      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
75      REAL tsol(klon), qsol(klon), sn(klon)      REAL sn(klon)
76      REAL tsolsrf(klon, nbsrf), qsolsrf(klon, nbsrf), snsrf(klon, nbsrf)      REAL qsolsrf(klon, nbsrf), snsrf(klon, nbsrf)
77      REAL albe(klon, nbsrf), evap(klon, nbsrf)      REAL albe(klon, nbsrf), evap(klon, nbsrf)
78      REAL alblw(klon, nbsrf)      REAL alblw(klon, nbsrf)
79      REAL tsoil(klon, nsoilmx, nbsrf)      REAL tsoil(klon, nsoilmx, nbsrf)
80      REAL radsol(klon), rain_fall(klon), snow_fall(klon)      REAL radsol(klon), rain_fall(klon), snow_fall(klon)
81      REAL solsw(klon), sollw(klon), fder(klon)      REAL solsw(klon), sollw(klon), fder(klon)
82      !IM "slab" ocean      !IM "slab" ocean
     REAL tslab(klon)  
83      real seaice(klon) ! kg m-2      real seaice(klon) ! kg m-2
84      REAL frugs(klon, nbsrf), agesno(klon, nbsrf)      REAL frugs(klon, nbsrf), agesno(klon, nbsrf)
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):: zmea_2d, 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, qsol_2d, psol      real, dimension(iim + 1, jjm + 1):: tsol_2d, qsol_2d, ps
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)
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\'eclarations pour lecture glace de mer :
98      INTEGER itaul(1), fid, ncid, varid      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 107  contains Line 107  contains
107      real pks(iim + 1, jjm + 1)      real pks(iim + 1, jjm + 1)
108    
109      REAL masse(iim + 1, jjm + 1, llm)      REAL masse(iim + 1, jjm + 1, llm)
110      REAL phi(ip1jmp1, llm)      REAL phi(iim + 1, jjm + 1, llm)
111      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)
112      REAL w(ip1jmp1, llm)      REAL w(iim + 1, jjm + 1, llm)
113      REAL phystep  
114      real trash      real sig1(klon, llm) ! section adiabatic updraft
115        real w01(klon, llm) ! vertical velocity within adiabatic updraft
116    
117        real pls(iim + 1, jjm + 1, llm)
118        ! (pressure at mid-layer of LMDZ grid, in Pa)
119        ! "pls(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)",
120        ! for layer "l")
121    
122        REAL p3d(iim + 1, jjm + 1, llm+1) ! pressure at layer interfaces, in Pa
123        ! ("p3d(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)",
124        ! for interface "l")
125    
126      !---------------------------------      !---------------------------------
127    
128      print *, "Call sequence information: etat0"      print *, "Call sequence information: etat0"
129    
130      dtvr = daysec / real(day_step)      CALL iniconst
     print *, 'dtvr = ', dtvr  
131    
132      ! Construct a grid:      ! Construct a grid:
133    
134      pa = 5e4      pa = 5e4
135      CALL iniconst      CALL disvert
136        call test_disvert
137      CALL inigeom      CALL inigeom
138      CALL inifilr      CALL inifilr
139    
# Line 137  contains Line 147  contains
147      ! (with conversion to degrees)      ! (with conversion to degrees)
148      lonfi(klon) = 0.      lonfi(klon) = 0.
149    
150      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, &
151           zval_2d) ! also compute "mask" and "phis"           zpic_2d, zval_2d) ! also compute "mask"
152      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
153      zmasq = pack(mask, dyn_phy)      zmasq = pack(mask, dyn_phy)
154      PRINT *, 'Masque construit'      PRINT *, 'Masque construit'
155    
156      call start_init_phys(tsol_2d, qsol_2d)      call start_init_phys(tsol_2d, qsol_2d)
157      CALL start_init_dyn(tsol_2d, psol)      CALL start_init_dyn(tsol_2d, phis, ps)
158    
159      ! Compute pressure on intermediate levels:      ! Compute pressure on intermediate levels:
160      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * psol      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * ps
161      CALL exner_hyb(psol, p3d, pks, pk)      CALL exner_hyb(ps, p3d, pks, pk)
162      IF (MINVAL(pk) == MAXVAL(pk)) stop '"pk" should not be constant'      call assert(MINVAL(pk) /= MAXVAL(pk), '"pk" should not be constant')
163    
164      pls = preff * (pk / cpp)**(1. / kappa)      pls = preff * (pk / cpp)**(1. / kappa)
165      PRINT *, "minval(pls) = ", minval(pls)      PRINT *, "minval(pls) = ", minval(pls)
166      print *, "maxval(pls) = ", maxval(pls)      print *, "maxval(pls) = ", maxval(pls)
167    
168      call start_inter_3d('U', rlonv, rlatv, pls, uvent)      call start_inter_3d('U', rlonv, rlatv, pls, ucov)
169      forall (l = 1: llm) uvent(:iim, :, l) = uvent(:iim, :, l) * cu_2d(:iim, :)      forall (l = 1: llm) ucov(:iim, :, l) = ucov(:iim, :, l) * cu_2d(:iim, :)
170      uvent(iim+1, :, :) = uvent(1, :, :)      ucov(iim+1, :, :) = ucov(1, :, :)
171    
172      call start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :), vvent)      call start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :), vcov)
173      forall (l = 1: llm) vvent(:iim, :, l) = vvent(:iim, :, l) * cv_2d(:iim, :)      forall (l = 1: llm) vcov(:iim, :, l) = vcov(:iim, :, l) * cv_2d(:iim, :)
174      vvent(iim + 1, :, :) = vvent(1, :, :)      vcov(iim + 1, :, :) = vcov(1, :, :)
175    
176      call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d)      call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d)
177      PRINT *,  'minval(t3d) = ', minval(t3d)      PRINT *, 'minval(t3d) = ', minval(t3d)
178      print *, "maxval(t3d) = ", maxval(t3d)      print *, "maxval(t3d) = ", maxval(t3d)
179    
180      tpot(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :)      teta(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :)
181      tpot(iim + 1, :, :) = tpot(1, :, :)      teta(iim + 1, :, :) = teta(1, :, :)
182      DO l=1, llm      DO l = 1, llm
183         tpot(:, 1, l) = SUM(aire_2d(:, 1) * tpot(:, 1, l)) / apoln         teta(:, 1, l) = SUM(aire_2d(:, 1) * teta(:, 1, l)) / apoln
184         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)) &
185              / apols              / apols
186      ENDDO      ENDDO
187    
188      ! Calcul de l'humidité à saturation :      ! Calcul de l'humidit\'e \`a saturation :
189      qsat = q_sat(t3d, pls)      qsat = q_sat(t3d, pls)
190      PRINT *, "minval(qsat) = ", minval(qsat)      PRINT *, "minval(qsat) = ", minval(qsat)
191      print *, "maxval(qsat) = ", maxval(qsat)      print *, "maxval(qsat) = ", maxval(qsat)
192      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'
193    
194      ! Water vapor:      ! Water vapor:
195      call start_inter_3d('R', rlonu, rlatv, pls, q3d(:, :, :, 1))      call start_inter_3d('R', rlonu, rlatv, pls, q(:, :, :, 1))
196      q3d(:, :, :, 1) = 0.01 * q3d(:, :, :, 1) * qsat      q(:, :, :, 1) = 0.01 * q(:, :, :, 1) * qsat
197      WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10      WHERE (q(:, :, :, 1) < 0.) q(:, :, :, 1) = 1E-10
198      DO l = 1, llm      DO l = 1, llm
199         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
200         q3d(:, jjm + 1, l, 1) &         q(:, jjm + 1, l, 1) &
201              = SUM(aire_2d(:, jjm + 1) * q3d(:, jjm + 1, l, 1)) / apols              = SUM(aire_2d(:, jjm + 1) * q(:, jjm + 1, l, 1)) / apols
202      ENDDO      ENDDO
203    
204      q3d(:, :, :, 2:4) = 0. ! liquid water, radon and lead      q(:, :, :, 2:4) = 0. ! liquid water, radon and lead
205    
206      if (nqmx >= 5) then      if (nqmx >= 5) then
207         ! Ozone:         ! Ozone:
208         call regr_lat_time_coefoz         call regr_lat_time_coefoz
209         call regr_pr_o3(q3d(:, :, :, 5))         call regr_pr_o3(p3d, q(:, :, :, 5))
210         ! Convert from mole fraction to mass fraction:         ! Convert from mole fraction to mass fraction:
211         q3d(:, :, :, 5) = q3d(:, :, :, 5)  * 48. / 29.         q(:, :, :, 5) = q(:, :, :, 5) * 48. / 29.
212      end if      end if
213    
     tsol = pack(tsol_2d, dyn_phy)  
     qsol = pack(qsol_2d, dyn_phy)  
214      sn = 0. ! snow      sn = 0. ! snow
215      radsol = 0.      radsol = 0.
     tslab = 0. ! IM "slab" ocean  
216      seaice = 0.      seaice = 0.
217      rugmer = 0.001      rugmer = 0.001
218      zmea = pack(relief, dyn_phy)      zmea = pack(zmea_2d, dyn_phy)
219      zstd = pack(zstd_2d, dyn_phy)      zstd = pack(zstd_2d, dyn_phy)
220      zsig = pack(zsig_2d, dyn_phy)      zsig = pack(zsig_2d, dyn_phy)
221      zgam = pack(zgam_2d, dyn_phy)      zgam = pack(zgam_2d, dyn_phy)
# Line 216  contains Line 223  contains
223      zpic = pack(zpic_2d, dyn_phy)      zpic = pack(zpic_2d, dyn_phy)
224      zval = pack(zval_2d, dyn_phy)      zval = pack(zval_2d, dyn_phy)
225    
226      ! On initialise les sous-surfaces:      ! On initialise les sous-surfaces.
227      ! Lecture du fichier glace de terre pour fixer la fraction de terre      ! Lecture du fichier glace de terre pour fixer la fraction de terre
228      ! et de glace de terre:      ! et de glace de terre :
229      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)  
230      call nf95_open("landiceref.nc", nf90_nowrite, ncid)      call nf95_open("landiceref.nc", nf90_nowrite, ncid)
231    
232        call nf95_inq_varid(ncid, 'longitude', varid)
233        call nf95_gw_var(ncid, varid, dlon_lic)
234        iml_lic = size(dlon_lic)
235    
236        call nf95_inq_varid(ncid, 'latitude', varid)
237        call nf95_gw_var(ncid, varid, dlat_lic)
238        jml_lic = size(dlat_lic)
239    
240      call nf95_inq_varid(ncid, 'landice', varid)      call nf95_inq_varid(ncid, 'landice', varid)
241        ALLOCATE(fraclic(iml_lic, jml_lic))
242      call nf95_get_var(ncid, varid, fraclic)      call nf95_get_var(ncid, varid, fraclic)
243    
244      call nf95_close(ncid)      call nf95_close(ncid)
     CALL flinclo(fid)  
245    
246      ! Interpolation sur la grille T du modèle :      ! Interpolation sur la grille T du mod\`ele :
247      PRINT *, 'Dimensions de "landice"'      PRINT *, 'Dimensions de "landiceref.nc"'
248      print *, "iml_lic = ", iml_lic      print *, "iml_lic = ", iml_lic
249      print *, "jml_lic = ", jml_lic      print *, "jml_lic = ", jml_lic
250    
251      ! Si les coordonnées sont en degrés, on les transforme :      ! Si les coordonn\'ees sont en degr\'es, on les transforme :
252      IF (MAXVAL( lon_lic ) > pi)  THEN      IF (MAXVAL(dlon_lic) > pi) THEN
253         lon_lic = lon_lic * pi / 180.         dlon_lic = dlon_lic * pi / 180.
254      ENDIF      ENDIF
255      IF (maxval( lat_lic ) > pi) THEN      IF (maxval(dlat_lic) > pi) THEN
256         lat_lic = lat_lic * pi/ 180.         dlat_lic = dlat_lic * pi/ 180.
257      ENDIF      ENDIF
258    
     dlon_lic = lon_lic(:, 1)  
     dlat_lic = lat_lic(1, :)  
   
259      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &
260           rlatu)           rlatu)
261      flic_tmp(iim + 1, :) = flic_tmp(1, :)      flic_tmp(iim + 1, :) = flic_tmp(1, :)
262    
263        deallocate(dlon_lic, dlat_lic) ! pointers
264    
265      ! Passage sur la grille physique      ! Passage sur la grille physique
266      pctsrf = 0.      pctsrf = 0.
267      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)
268      ! Adéquation avec le maque terre/mer      ! Ad\'equation avec le maque terre/mer
269      WHERE (pctsrf(:, is_lic) < EPSFRA ) pctsrf(:, is_lic) = 0.      WHERE (pctsrf(:, is_lic) < EPSFRA) pctsrf(:, is_lic) = 0.
270      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.
271      pctsrf(:, is_ter) = zmasq      pctsrf(:, is_ter) = zmasq
272      where (zmasq > EPSFRA)      where (zmasq > EPSFRA)
# Line 275  contains Line 282  contains
282         end where         end where
283      end where      end where
284    
285      ! 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
286      ! de mer à 0) :      ! de mer \`a 0) :
287      pctsrf(:, is_oce) = 1. - zmasq      pctsrf(:, is_oce) = 1. - zmasq
288      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.
289    
290      ! Vérification que somme des sous-surfaces vaut 1:      ! V\'erification que somme des sous-surfaces vaut 1 :
291      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)
292      IF (ji /= 0) then      IF (ji /= 0) then
293         PRINT *, 'Problème répartition sous maille pour ', ji, 'points'         PRINT *, 'Bad surface percentages for ', ji, 'points'
294      end IF      end IF
295    
296      ! Calcul intermédiaire:      ! Calcul interm\'ediaire :
297      CALL massdair(p3d, masse)      CALL massdair(p3d, masse)
298    
299      print *, 'ALPHAX = ', alphax      print *, 'ALPHAX = ', alphax
300    
301      forall  (l = 1:llm)      forall (l = 1:llm)
302         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
303         masse(:, jjm + 1, l) = &         masse(:, jjm + 1, l) = &
304              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 299  contains Line 306  contains
306    
307      ! Initialisation pour traceurs:      ! Initialisation pour traceurs:
308      call iniadvtrac      call iniadvtrac
     CALL inidissip  
309      itau_phy = 0      itau_phy = 0
310      day_ref = dayref      day_ref = dayref
311      annee_ref = anneeref      annee_ref = anneeref
312    
313      CALL geopot(ip1jmp1, tpot, pk , pks,  phis, phi)      CALL geopot(teta, pk , pks, phis, phi)
314      CALL caldyn0(uvent, vvent, tpot, psol, masse, pk, phis, phi, w, pbaru, &      CALL caldyn0(ucov, vcov, teta, ps, masse, pk, phis, phi, w, pbaru, &
315           pbarv)           pbarv)
316      CALL dynredem0("start.nc", dayref, phis)      CALL dynredem0("start.nc", dayref, phis)
317      CALL dynredem1("start.nc", vvent, uvent, 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  
318    
319      ! Initialisations :      ! Initialisations :
     tsolsrf(:, is_ter) = tsol  
     tsolsrf(:, is_lic) = tsol  
     tsolsrf(:, is_oce) = tsol  
     tsolsrf(:, is_sic) = tsol  
320      snsrf(:, is_ter) = sn      snsrf(:, is_ter) = sn
321      snsrf(:, is_lic) = sn      snsrf(:, is_lic) = sn
322      snsrf(:, is_oce) = sn      snsrf(:, is_oce) = sn
# Line 330  contains Line 327  contains
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 = 150.
331      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)  
332      rain_fall = 0.      rain_fall = 0.
333      snow_fall = 0.      snow_fall = 0.
334      solsw = 165.      solsw = 165.
# Line 342  contains Line 336  contains
336      t_ancien = 273.15      t_ancien = 273.15
337      q_ancien = 0.      q_ancien = 0.
338      agesno = 0.      agesno = 0.
     !IM "slab" ocean  
     tslab = tsolsrf(:, is_oce)  
339      seaice = 0.      seaice = 0.
340    
341      frugs(:, is_oce) = rugmer      frugs(:, is_oce) = rugmer
342      frugs(:, is_ter) = MAX(1.e-05, zstd * zsig / 2)      frugs(:, is_ter) = MAX(1e-5, zstd * zsig / 2)
343      frugs(:, is_lic) = MAX(1.e-05, zstd * zsig / 2)      frugs(:, is_lic) = MAX(1e-5, zstd * zsig / 2)
344      frugs(:, is_sic) = 0.001      frugs(:, is_sic) = 0.001
345      fder = 0.      fder = 0.
346      clwcon = 0.      clwcon = 0.
347      rnebcon = 0.      rnebcon = 0.
348      ratqs = 0.      ratqs = 0.
349      run_off_lic_0 = 0.      run_off_lic_0 = 0.
350        sig1 = 0.
351        w01 = 0.
352    
353      call phyredem("startphy.nc", latfi, lonfi, pctsrf, &      call phyredem("startphy.nc", latfi, lonfi, pctsrf, tsoil(:, 1, :), tsoil, &
354           tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, &           tsoil(:, 1, is_oce), seaice, qsolsrf, pack(qsol_2d, dyn_phy), snsrf, &
355           evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &           albe, alblw, evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, &
356           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, &           frugs, agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, t_ancien, &
357           t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0)           q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0, sig1, w01)
358      CALL histclo      CALL histclo
359    
360    END SUBROUTINE etat0    END SUBROUTINE etat0

Legend:
Removed from v.48  
changed lines
  Added in v.107

  ViewVC Help
Powered by ViewVC 1.1.21