/[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 66 by guez, Thu Sep 20 13:00:41 2012 UTC trunk/Sources/dyn3d/etat0.f revision 156 by guez, Thu Jul 16 17:39:10 2015 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
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: aire_2d, apoln, apols, cu_2d, cv_2d, inigeom
          cu_2d, cv_2d  
     use disvert_m, only: ap, bp, preff, pa  
     use conf_gcm_m, only: day_step, iphysiq, dayref, anneeref  
23      use dimens_m, only: iim, jjm, llm, nqmx      use dimens_m, only: iim, jjm, llm, nqmx
24      use dimphy, only: zmasq      use dimphy, only: zmasq
25      use dimsoil, only: nsoilmx      use dimsoil, only: nsoilmx
26        use disvert_m, only: ap, bp, preff, pa, disvert
27        use dynetat0_m, only: day_ref, annee_ref, xprimp025, xprimm025, rlatu1, &
28             rlatu2, rlatu, rlatv, yprimu1, yprimu2, rlonu, rlonv, xprimu, xprimv
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
32      USE flincom, only: flinclo, flinopen_nozoom, flininfo      use fxhyp_m, only: fxhyp
33        use fyhyp_m, only: fyhyp
34      use geopot_m, only: geopot      use geopot_m, only: geopot
35      use grid_atob, only: grille_m      use grid_atob, only: grille_m
36      use grid_change, only: init_dyn_phy, dyn_phy      use grid_change, only: init_dyn_phy, dyn_phy
     use histclo_m, only: histclo  
37      use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra      use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra
38      use iniadvtrac_m, only: iniadvtrac      use iniadvtrac_m, only: iniadvtrac
     use inidissip_m, only: inidissip  
39      use inifilr_m, only: inifilr      use inifilr_m, only: inifilr
40      use inigeom_m, only: inigeom      use massdair_m, only: massdair
41      use netcdf, only: nf90_nowrite      use netcdf, only: nf90_nowrite
42      use netcdf95, only: nf95_open, nf95_close, nf95_get_var, nf95_inq_varid      use netcdf95, only: nf95_close, nf95_get_var, nf95_gw_var, &
43      use nr_util, only: pi           nf95_inq_varid, nf95_open
44        use nr_util, only: pi, assert
45      use paramet_m, only: ip1jm, ip1jmp1      use paramet_m, only: ip1jm, ip1jmp1
46        use phyetat0_m, only: rlat, rlon
47      use phyredem_m, only: phyredem      use phyredem_m, only: phyredem
     use pressure_var, only: pls, p3d  
48      use q_sat_m, only: q_sat      use q_sat_m, only: q_sat
49      use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz      use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz
50      use regr_pr_o3_m, only: regr_pr_o3      use regr_pr_o3_m, only: regr_pr_o3
     use serre, only: alphax  
     USE start_init_orog_m, only: start_init_orog, mask, phis  
     use start_init_phys_m, only: start_init_phys  
51      use startdyn, only: start_init_dyn      use startdyn, only: start_init_dyn
52        USE start_init_orog_m, only: start_init_orog, mask
53        use start_init_phys_m, only: start_init_phys
54      use start_inter_3d_m, only: start_inter_3d      use start_inter_3d_m, only: start_inter_3d
55      use temps, only: itau_phy, annee_ref, day_ref      use temps, only: itau_phy
56        use test_disvert_m, only: test_disvert
57        use unit_nml_m, only: unit_nml
58    
59      ! Variables local to the procedure:      REAL, intent(out):: phis(:, :) ! (iim + 1, jjm + 1)
60        ! surface geopotential, in m2 s-2
61    
62      REAL latfi(klon), lonfi(klon)      ! Local:
     ! (latitude and longitude of a point of the scalar grid identified  
     ! by a simple index, in °)  
63    
64      REAL, dimension(iim + 1, jjm + 1, llm):: ucov, t3d, tpot      REAL, dimension(iim + 1, jjm + 1, llm):: ucov, t3d, teta
65      REAL vcov(iim + 1, jjm, llm)      REAL vcov(iim + 1, jjm, llm)
66    
67      REAL q3d(iim + 1, jjm + 1, llm, nqmx)      REAL q(iim + 1, jjm + 1, llm, nqmx)
68      ! (mass fractions of trace species      ! (mass fractions of trace species
69      ! "q3d(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)"      ! "q(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)"
70      ! and pressure level "pls(i, j, l)".)      ! and pressure level "pls(i, j, l)".)
71    
72      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
73      REAL tsol(klon), qsol(klon), sn(klon)      REAL sn(klon)
74      REAL tsolsrf(klon, nbsrf), qsolsrf(klon, nbsrf), snsrf(klon, nbsrf)      REAL qsolsrf(klon, nbsrf), snsrf(klon, nbsrf)
75      REAL albe(klon, nbsrf), evap(klon, nbsrf)      REAL albe(klon, nbsrf), evap(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, dimension(iim + 1, jjm + 1):: zmea_2d, zstd_2d, zsig_2d, zgam_2d
84      real, dimension(iim + 1, jjm + 1):: zthe_2d, zpic_2d, zval_2d      real, dimension(iim + 1, jjm + 1):: zthe_2d, zpic_2d, zval_2d
85      real, dimension(iim + 1, jjm + 1):: tsol_2d, qsol_2d, psol      real, dimension(iim + 1, jjm + 1):: tsol_2d, qsol_2d, ps
86      REAL zmea(klon), zstd(klon)      REAL zmea(klon), zstd(klon)
87      REAL zsig(klon), zgam(klon)      REAL zsig(klon), zgam(klon)
88      REAL zthe(klon)      REAL zthe(klon)
89      REAL zpic(klon), zval(klon)      REAL zpic(klon), zval(klon)
90      REAL t_ancien(klon, llm), q_ancien(klon, llm)      !      REAL t_ancien(klon, llm), q_ancien(klon, llm)
91      REAL run_off_lic_0(klon)      REAL run_off_lic_0(klon)
92      real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm)      real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm)
93      ! déclarations pour lecture glace de mer  
94      INTEGER iml_lic, jml_lic, llm_tmp, ttm_tmp      ! D\'eclarations pour lecture glace de mer :
95      INTEGER itaul(1), fid, ncid, varid      INTEGER iml_lic, jml_lic
96      REAL lev(1), date      INTEGER ncid, varid
97      REAL, ALLOCATABLE:: lon_lic(:, :), lat_lic(:, :)      REAL, pointer:: dlon_lic(:), dlat_lic(:)
     REAL, ALLOCATABLE:: dlon_lic(:), dlat_lic(:)  
98      REAL, ALLOCATABLE:: fraclic(:, :) ! fraction land ice      REAL, ALLOCATABLE:: fraclic(:, :) ! fraction land ice
99      REAL flic_tmp(iim + 1, jjm + 1) !fraction land ice temporary      REAL flic_tmp(iim + 1, jjm + 1) ! fraction land ice temporary
100    
101      INTEGER l, ji      INTEGER l, ji
102    
# Line 107  contains Line 104  contains
104      real pks(iim + 1, jjm + 1)      real pks(iim + 1, jjm + 1)
105    
106      REAL masse(iim + 1, jjm + 1, llm)      REAL masse(iim + 1, jjm + 1, llm)
107      REAL phi(ip1jmp1, llm)      REAL phi(iim + 1, jjm + 1, llm)
108      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)
109      REAL w(ip1jmp1, llm)      REAL w(iim + 1, jjm + 1, llm)
110      REAL phystep  
111      real trash      real sig1(klon, llm) ! section adiabatic updraft
112        real w01(klon, llm) ! vertical velocity within adiabatic updraft
113    
114        real pls(iim + 1, jjm + 1, llm)
115        ! (pressure at mid-layer of LMDZ grid, in Pa)
116        ! "pls(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)",
117        ! for layer "l")
118    
119        REAL p3d(iim + 1, jjm + 1, llm+1) ! pressure at layer interfaces, in Pa
120        ! ("p3d(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)",
121        ! for interface "l")
122    
123        namelist /etat0_nml/ day_ref, annee_ref
124    
125      !---------------------------------      !---------------------------------
126    
127      print *, "Call sequence information: etat0"      print *, "Call sequence information: etat0"
128    
129      dtvr = daysec / real(day_step)      print *, "Enter namelist 'etat0_nml'."
130      print *, 'dtvr = ', dtvr      read(unit=*, nml=etat0_nml)
131        write(unit_nml, nml=etat0_nml)
132    
133        CALL iniconst
134    
135      ! Construct a grid:      ! Construct a grid:
136    
137      pa = 5e4      pa = 5e4
138      CALL iniconst      CALL disvert
139        call test_disvert
140    
141        CALL fyhyp(rlatu, rlatv, rlatu2, yprimu2, rlatu1, yprimu1)
142        CALL fxhyp(xprimm025, rlonv, xprimv, rlonu, xprimu, xprimp025)
143    
144        rlatu(1) = pi / 2.
145        rlatu(jjm + 1) = -rlatu(1)
146    
147      CALL inigeom      CALL inigeom
148      CALL inifilr      CALL inifilr
149    
150      latfi(1) = 90.      rlat(1) = 90.
151      latfi(2:klon-1) = pack(spread(rlatu(2:jjm), 1, iim), .true.) * 180. / pi      rlat(2:klon-1) = pack(spread(rlatu(2:jjm), 1, iim), .true.) * 180. / pi
152      ! (with conversion to degrees)      ! (with conversion to degrees)
153      latfi(klon) = - 90.      rlat(klon) = - 90.
154    
155      lonfi(1) = 0.      rlon(1) = 0.
156      lonfi(2:klon-1) = pack(spread(rlonv(:iim), 2, jjm - 1), .true.) * 180. / pi      rlon(2:klon-1) = pack(spread(rlonv(:iim), 2, jjm - 1), .true.) * 180. / pi
157      ! (with conversion to degrees)      ! (with conversion to degrees)
158      lonfi(klon) = 0.      rlon(klon) = 0.
159    
160      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, &
161           zval_2d) ! also compute "mask" and "phis"           zpic_2d, zval_2d) ! also compute "mask"
162      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
163      zmasq = pack(mask, dyn_phy)      zmasq = pack(mask, dyn_phy)
164      PRINT *, 'Masque construit'      PRINT *, 'Masque construit'
165    
166      call start_init_phys(tsol_2d, qsol_2d)      call start_init_phys(tsol_2d, qsol_2d)
167      CALL start_init_dyn(tsol_2d, psol)      CALL start_init_dyn(tsol_2d, phis, ps)
168    
169      ! Compute pressure on intermediate levels:      ! Compute pressure on intermediate levels:
170      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * psol      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * ps
171      CALL exner_hyb(psol, p3d, pks, pk)      CALL exner_hyb(ps, p3d, pks, pk)
172      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  
173    
174      pls = preff * (pk / cpp)**(1. / kappa)      pls = preff * (pk / cpp)**(1. / kappa)
175      PRINT *, "minval(pls) = ", minval(pls)      PRINT *, "minval(pls) = ", minval(pls)
# Line 167  contains Line 184  contains
184      vcov(iim + 1, :, :) = vcov(1, :, :)      vcov(iim + 1, :, :) = vcov(1, :, :)
185    
186      call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d)      call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d)
187      PRINT *,  'minval(t3d) = ', minval(t3d)      PRINT *, 'minval(t3d) = ', minval(t3d)
188      print *, "maxval(t3d) = ", maxval(t3d)      print *, "maxval(t3d) = ", maxval(t3d)
189    
190      tpot(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :)      teta(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :)
191      tpot(iim + 1, :, :) = tpot(1, :, :)      teta(iim + 1, :, :) = teta(1, :, :)
192      DO l=1, llm      DO l = 1, llm
193         tpot(:, 1, l) = SUM(aire_2d(:, 1) * tpot(:, 1, l)) / apoln         teta(:, 1, l) = SUM(aire_2d(:, 1) * teta(:, 1, l)) / apoln
194         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)) &
195              / apols              / apols
196      ENDDO      ENDDO
197    
198      ! Calcul de l'humidité à saturation :      ! Calcul de l'humidit\'e \`a saturation :
199      qsat = q_sat(t3d, pls)      qsat = q_sat(t3d, pls)
200      PRINT *, "minval(qsat) = ", minval(qsat)      PRINT *, "minval(qsat) = ", minval(qsat)
201      print *, "maxval(qsat) = ", maxval(qsat)      print *, "maxval(qsat) = ", maxval(qsat)
202      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'
203    
204      ! Water vapor:      ! Water vapor:
205      call start_inter_3d('R', rlonu, rlatv, pls, q3d(:, :, :, 1))      call start_inter_3d('R', rlonu, rlatv, pls, q(:, :, :, 1))
206      q3d(:, :, :, 1) = 0.01 * q3d(:, :, :, 1) * qsat      q(:, :, :, 1) = 0.01 * q(:, :, :, 1) * qsat
207      WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10      WHERE (q(:, :, :, 1) < 0.) q(:, :, :, 1) = 1E-10
208      DO l = 1, llm      DO l = 1, llm
209         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
210         q3d(:, jjm + 1, l, 1) &         q(:, jjm + 1, l, 1) &
211              = SUM(aire_2d(:, jjm + 1) * q3d(:, jjm + 1, l, 1)) / apols              = SUM(aire_2d(:, jjm + 1) * q(:, jjm + 1, l, 1)) / apols
212      ENDDO      ENDDO
213    
214      q3d(:, :, :, 2:4) = 0. ! liquid water, radon and lead      q(:, :, :, 2:4) = 0. ! liquid water, radon and lead
215    
216      if (nqmx >= 5) then      if (nqmx >= 5) then
217         ! Ozone:         ! Ozone:
218         call regr_lat_time_coefoz         call regr_lat_time_coefoz
219         call regr_pr_o3(q3d(:, :, :, 5))         call regr_pr_o3(p3d, q(:, :, :, 5))
220         ! Convert from mole fraction to mass fraction:         ! Convert from mole fraction to mass fraction:
221         q3d(:, :, :, 5) = q3d(:, :, :, 5)  * 48. / 29.         q(:, :, :, 5) = q(:, :, :, 5) * 48. / 29.
222      end if      end if
223    
     tsol = pack(tsol_2d, dyn_phy)  
     qsol = pack(qsol_2d, dyn_phy)  
224      sn = 0. ! snow      sn = 0. ! snow
225      radsol = 0.      radsol = 0.
     tslab = 0. ! IM "slab" ocean  
226      seaice = 0.      seaice = 0.
227      rugmer = 0.001      rugmer = 0.001
228      zmea = pack(relief, dyn_phy)      zmea = pack(zmea_2d, dyn_phy)
229      zstd = pack(zstd_2d, dyn_phy)      zstd = pack(zstd_2d, dyn_phy)
230      zsig = pack(zsig_2d, dyn_phy)      zsig = pack(zsig_2d, dyn_phy)
231      zgam = pack(zgam_2d, dyn_phy)      zgam = pack(zgam_2d, dyn_phy)
# Line 222  contains Line 236  contains
236      ! On initialise les sous-surfaces.      ! On initialise les sous-surfaces.
237      ! Lecture du fichier glace de terre pour fixer la fraction de terre      ! Lecture du fichier glace de terre pour fixer la fraction de terre
238      ! et de glace de terre :      ! et de glace de terre :
239      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)  
240      call nf95_open("landiceref.nc", nf90_nowrite, ncid)      call nf95_open("landiceref.nc", nf90_nowrite, ncid)
241    
242        call nf95_inq_varid(ncid, 'longitude', varid)
243        call nf95_gw_var(ncid, varid, dlon_lic)
244        iml_lic = size(dlon_lic)
245    
246        call nf95_inq_varid(ncid, 'latitude', varid)
247        call nf95_gw_var(ncid, varid, dlat_lic)
248        jml_lic = size(dlat_lic)
249    
250      call nf95_inq_varid(ncid, 'landice', varid)      call nf95_inq_varid(ncid, 'landice', varid)
251        ALLOCATE(fraclic(iml_lic, jml_lic))
252      call nf95_get_var(ncid, varid, fraclic)      call nf95_get_var(ncid, varid, fraclic)
253    
254      call nf95_close(ncid)      call nf95_close(ncid)
255    
256      ! Interpolation sur la grille T du modèle :      ! Interpolation sur la grille T du mod\`ele :
257      PRINT *, 'Dimensions de "landice"'      PRINT *, 'Dimensions de "landiceref.nc"'
258      print *, "iml_lic = ", iml_lic      print *, "iml_lic = ", iml_lic
259      print *, "jml_lic = ", jml_lic      print *, "jml_lic = ", jml_lic
260    
261      ! Si les coordonnées sont en degrés, on les transforme :      ! Si les coordonn\'ees sont en degr\'es, on les transforme :
262      IF (MAXVAL( lon_lic ) > pi)  THEN      IF (MAXVAL(dlon_lic) > pi) THEN
263         lon_lic = lon_lic * pi / 180.         dlon_lic = dlon_lic * pi / 180.
264      ENDIF      ENDIF
265      IF (maxval( lat_lic ) > pi) THEN      IF (maxval(dlat_lic) > pi) THEN
266         lat_lic = lat_lic * pi/ 180.         dlat_lic = dlat_lic * pi/ 180.
267      ENDIF      ENDIF
268    
     dlon_lic = lon_lic(:, 1)  
     dlat_lic = lat_lic(1, :)  
   
269      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &
270           rlatu)           rlatu)
271      flic_tmp(iim + 1, :) = flic_tmp(1, :)      flic_tmp(iim + 1, :) = flic_tmp(1, :)
272    
273        deallocate(dlon_lic, dlat_lic) ! pointers
274    
275      ! Passage sur la grille physique      ! Passage sur la grille physique
276      pctsrf = 0.      pctsrf = 0.
277      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)
278      ! Adéquation avec le maque terre/mer      ! Ad\'equation avec le maque terre/mer
279      WHERE (pctsrf(:, is_lic) < EPSFRA ) pctsrf(:, is_lic) = 0.      WHERE (pctsrf(:, is_lic) < EPSFRA) pctsrf(:, is_lic) = 0.
280      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.
281      pctsrf(:, is_ter) = zmasq      pctsrf(:, is_ter) = zmasq
282      where (zmasq > EPSFRA)      where (zmasq > EPSFRA)
# Line 278  contains Line 292  contains
292         end where         end where
293      end where      end where
294    
295      ! 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
296      ! de mer à 0) :      ! de mer \`a 0) :
297      pctsrf(:, is_oce) = 1. - zmasq      pctsrf(:, is_oce) = 1. - zmasq
298      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.
299    
300      ! Vérification que somme des sous-surfaces vaut 1:      ! V\'erification que somme des sous-surfaces vaut 1 :
301      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)
302      IF (ji /= 0) then      IF (ji /= 0) then
303         PRINT *, 'Problème répartition sous maille pour ', ji, 'points'         PRINT *, 'Bad surface percentages for ', ji, 'points'
304      end IF      end IF
305    
306      ! Calcul intermédiaire:      ! Calcul interm\'ediaire :
307      CALL massdair(p3d, masse)      CALL massdair(p3d, masse)
308    
309      print *, 'ALPHAX = ', alphax      forall (l = 1:llm)
   
     forall  (l = 1:llm)  
310         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
311         masse(:, jjm + 1, l) = &         masse(:, jjm + 1, l) = &
312              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 314  contains
314    
315      ! Initialisation pour traceurs:      ! Initialisation pour traceurs:
316      call iniadvtrac      call iniadvtrac
     CALL inidissip  
317      itau_phy = 0      itau_phy = 0
     day_ref = dayref  
     annee_ref = anneeref  
318    
319      CALL geopot(ip1jmp1, tpot, pk , pks,  phis, phi)      CALL geopot(teta, pk , pks, phis, phi)
320      CALL caldyn0(ucov, vcov, tpot, psol, masse, pk, phis, phi, w, pbaru, &      CALL caldyn0(ucov, vcov, teta, ps, masse, pk, phis, phi, w, pbaru, &
321           pbarv)           pbarv)
322      CALL dynredem0("start.nc", dayref, phis)      CALL dynredem0("start.nc", day_ref, phis)
323      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  
324    
325      ! Initialisations :      ! Initialisations :
     tsolsrf(:, is_ter) = tsol  
     tsolsrf(:, is_lic) = tsol  
     tsolsrf(:, is_oce) = tsol  
     tsolsrf(:, is_sic) = tsol  
326      snsrf(:, is_ter) = sn      snsrf(:, is_ter) = sn
327      snsrf(:, is_lic) = sn      snsrf(:, is_lic) = sn
328      snsrf(:, is_oce) = sn      snsrf(:, is_oce) = sn
# Line 331  contains Line 331  contains
331      albe(:, is_lic) = 0.6      albe(:, is_lic) = 0.6
332      albe(:, is_oce) = 0.5      albe(:, is_oce) = 0.5
333      albe(:, is_sic) = 0.6      albe(:, is_sic) = 0.6
     alblw = albe  
334      evap = 0.      evap = 0.
335      qsolsrf(:, is_ter) = 150.      qsolsrf = 150.
336      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)  
337      rain_fall = 0.      rain_fall = 0.
338      snow_fall = 0.      snow_fall = 0.
339      solsw = 165.      solsw = 165.
# Line 345  contains Line 341  contains
341      t_ancien = 273.15      t_ancien = 273.15
342      q_ancien = 0.      q_ancien = 0.
343      agesno = 0.      agesno = 0.
     !IM "slab" ocean  
     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(1e-5, zstd * zsig / 2)
348      frugs(:, is_lic) = MAX(1.e-05, zstd * zsig / 2)      frugs(:, is_lic) = MAX(1e-5, zstd * zsig / 2)
349      frugs(:, is_sic) = 0.001      frugs(:, is_sic) = 0.001
350      fder = 0.      fder = 0.
351      clwcon = 0.      clwcon = 0.
352      rnebcon = 0.      rnebcon = 0.
353      ratqs = 0.      ratqs = 0.
354      run_off_lic_0 = 0.      run_off_lic_0 = 0.
355        sig1 = 0.
356        w01 = 0.
357    
358      call phyredem("startphy.nc", latfi, lonfi, pctsrf, &      call phyredem("startphy.nc", pctsrf, tsoil(:, 1, :), tsoil, &
359           tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, &           tsoil(:, 1, is_oce), seaice, qsolsrf, pack(qsol_2d, dyn_phy), snsrf, &
360           evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &           albe, evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, &
361           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, &           agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, t_ancien, &
362           t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0)           q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0, sig1, w01)
     CALL histclo  
363    
364    END SUBROUTINE etat0    END SUBROUTINE etat0
365    

Legend:
Removed from v.66  
changed lines
  Added in v.156

  ViewVC Help
Powered by ViewVC 1.1.21