/[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 5 by guez, Mon Mar 3 16:32:04 2008 UTC trunk/Sources/dyn3d/etat0.f revision 138 by guez, Fri May 22 23:13:19 2015 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    
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      ! This subroutine creates "masque".      use caldyn0_m, only: caldyn0
21        use comconst, only: cpp, kappa, iniconst
22      USE ioipsl, only: flinget, flinclo, flinopen_nozoom, flininfo, histclo      use comgeom, only: rlatu, rlonv, rlonu, rlatv, aire_2d, apoln, apols, &
23             cu_2d, cv_2d, inigeom
     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  
24      use dimens_m, only: iim, jjm, llm, nqmx      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  
25      use dimphy, only: zmasq      use dimphy, only: zmasq
     use conf_gcm_m, only: day_step, iphysiq, dayref, anneeref  
     use comgeom, only: rlatu, rlonv, rlonu, rlatv, aire_2d, apoln, apols, &  
          cu_2d, cv_2d  
     use serre, only: alphax  
26      use dimsoil, only: nsoilmx      use dimsoil, only: nsoilmx
27      use temps, only: itau_dyn, itau_phy, annee_ref, day_ref, dt      use disvert_m, only: ap, bp, preff, pa, disvert
28      use clesphys, only: ok_orodr, nbapp_rad      use dynetat0_m, only: day_ref, annee_ref
29        use dynredem0_m, only: dynredem0
30        use dynredem1_m, only: dynredem1
31        use exner_hyb_m, only: exner_hyb
32        use geopot_m, only: geopot
33      use grid_atob, only: grille_m      use grid_atob, only: grille_m
34      use grid_change, only: init_dyn_phy, dyn_phy      use grid_change, only: init_dyn_phy, dyn_phy
35        use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra
36        use iniadvtrac_m, only: iniadvtrac
37        use inifilr_m, only: inifilr
38        use massdair_m, only: massdair
39        use netcdf, only: nf90_nowrite
40        use netcdf95, only: nf95_close, nf95_get_var, nf95_gw_var, &
41             nf95_inq_varid, nf95_open
42        use nr_util, only: pi, assert
43        use paramet_m, only: ip1jm, ip1jmp1
44        use phyetat0_m, only: rlat, rlon
45        use phyredem_m, only: phyredem
46      use q_sat_m, only: q_sat      use q_sat_m, only: q_sat
47      use exner_hyb_m, only: exner_hyb      use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz
48      use regr_coefoz_m, only: regr_coefoz      use regr_pr_o3_m, only: regr_pr_o3
49      use advtrac_m, only: iniadvtrac      use startdyn, only: start_init_dyn
50      use netcdf95, only: nf95_open, nf95_close, nf95_inq_varid, nf90_nowrite, &      USE start_init_orog_m, only: start_init_orog, mask
51           nf90_get_var, handle_err      use start_init_phys_m, only: start_init_phys
52      use pressure_m, only: pls, p3d      use start_inter_3d_m, only: start_inter_3d
53        use temps, only: itau_phy
54      ! Variables local to the procedure:      use test_disvert_m, only: test_disvert
55        use unit_nml_m, only: unit_nml
56      REAL latfi(klon), lonfi(klon)  
57      ! (latitude and longitude of a point of the scalar grid identified      REAL, intent(out):: phis(:, :) ! (iim + 1, jjm + 1)
58      ! by a simple index, in °)      ! surface geopotential, in m2 s-2
59    
60        ! Local:
61    
62      REAL, dimension(iim + 1, jjm + 1, llm):: uvent, t3d, tpot      REAL, dimension(iim + 1, jjm + 1, llm):: ucov, t3d, teta
63      REAL vvent(iim + 1, jjm, llm)      REAL vcov(iim + 1, jjm, llm)
64    
65      REAL q3d(iim + 1, jjm + 1, llm, nqmx)      REAL q(iim + 1, jjm + 1, llm, nqmx)
66      ! (mass fractions of trace species      ! (mass fractions of trace species
67      ! "q3d(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)"      ! "q(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)"
68      ! and pressure level "pls(i, j, l)".)      ! and pressure level "pls(i, j, l)".)
69    
70      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
71      REAL tsol(klon), qsol(klon), sn(klon)      REAL sn(klon)
72      REAL tsolsrf(klon, nbsrf), qsolsrf(klon, nbsrf), snsrf(klon, nbsrf)      REAL qsolsrf(klon, nbsrf), snsrf(klon, nbsrf)
73      REAL albe(klon, nbsrf), evap(klon, nbsrf)      REAL albe(klon, nbsrf), evap(klon, nbsrf)
74      REAL alblw(klon, nbsrf)      REAL alblw(klon, nbsrf)
75      REAL tsoil(klon, nsoilmx, nbsrf)      REAL tsoil(klon, nsoilmx, nbsrf)
76      REAL radsol(klon), rain_fall(klon), snow_fall(klon)      REAL radsol(klon), rain_fall(klon), snow_fall(klon)
77      REAL solsw(klon), sollw(klon), fder(klon)      REAL solsw(klon), sollw(klon), fder(klon)
78      !IM "slab" ocean      !IM "slab" ocean
     REAL tslab(klon)  
79      real seaice(klon) ! kg m-2      real seaice(klon) ! kg m-2
80      REAL frugs(klon, nbsrf), agesno(klon, nbsrf)      REAL frugs(klon, nbsrf), agesno(klon, nbsrf)
81      REAL rugmer(klon)      REAL rugmer(klon)
82      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
83      real, dimension(iim + 1, jjm + 1):: zthe_2d, zpic_2d, zval_2d      real, dimension(iim + 1, jjm + 1):: zthe_2d, zpic_2d, zval_2d
84      real, dimension(iim + 1, jjm + 1):: tsol_2d, psol      real, dimension(iim + 1, jjm + 1):: tsol_2d, qsol_2d, ps
85      REAL zmea(klon), zstd(klon)      REAL zmea(klon), zstd(klon)
86      REAL zsig(klon), zgam(klon)      REAL zsig(klon), zgam(klon)
87      REAL zthe(klon)      REAL zthe(klon)
88      REAL zpic(klon), zval(klon)      REAL zpic(klon), zval(klon)
89      REAL rugsrel(klon)      REAL t_ancien(klon, llm), q_ancien(klon, llm)
     REAL t_ancien(klon, llm), q_ancien(klon, llm)      !  
90      REAL run_off_lic_0(klon)      REAL run_off_lic_0(klon)
91      real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm)      real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm)
92      ! déclarations pour lecture glace de mer  
93      INTEGER iml_lic, jml_lic, llm_tmp, ttm_tmp      ! D\'eclarations pour lecture glace de mer :
94      INTEGER itaul(1), fid      INTEGER iml_lic, jml_lic
95      REAL lev(1), date      INTEGER ncid, varid
96      REAL, ALLOCATABLE:: lon_lic(:, :), lat_lic(:, :)      REAL, pointer:: dlon_lic(:), dlat_lic(:)
     REAL, ALLOCATABLE:: dlon_lic(:), dlat_lic(:)  
97      REAL, ALLOCATABLE:: fraclic(:, :) ! fraction land ice      REAL, ALLOCATABLE:: fraclic(:, :) ! fraction land ice
98      REAL flic_tmp(iim + 1, jjm + 1) !fraction land ice temporary      REAL flic_tmp(iim + 1, jjm + 1) ! fraction land ice temporary
99    
100      INTEGER l, ji      INTEGER l, ji
101    
# Line 100  contains Line 103  contains
103      real pks(iim + 1, jjm + 1)      real pks(iim + 1, jjm + 1)
104    
105      REAL masse(iim + 1, jjm + 1, llm)      REAL masse(iim + 1, jjm + 1, llm)
106      REAL phi(ip1jmp1, llm)      REAL phi(iim + 1, jjm + 1, llm)
107      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)      REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm)
108      REAL w(ip1jmp1, llm)      REAL w(iim + 1, jjm + 1, llm)
109      REAL phystep  
110      INTEGER radpas      real sig1(klon, llm) ! section adiabatic updraft
111      integer ncid, varid, ncerr, month      real w01(klon, llm) ! vertical velocity within adiabatic updraft
112    
113        real pls(iim + 1, jjm + 1, llm)
114        ! (pressure at mid-layer of LMDZ grid, in Pa)
115        ! "pls(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)",
116        ! for layer "l")
117    
118        REAL p3d(iim + 1, jjm + 1, llm+1) ! pressure at layer interfaces, in Pa
119        ! ("p3d(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)",
120        ! for interface "l")
121    
122        namelist /etat0_nml/ day_ref, annee_ref
123    
124      !---------------------------------      !---------------------------------
125    
126      print *, "Call sequence information: etat0"      print *, "Call sequence information: etat0"
127    
128      ! Construct a grid:      print *, "Enter namelist 'etat0_nml'."
129        read(unit=*, nml=etat0_nml)
130        write(unit_nml, nml=etat0_nml)
131    
132      dtvr = daysec / real(day_step)      CALL iniconst
133      print *, 'dtvr = ', dtvr  
134        ! Construct a grid:
135    
136      pa = 5e4      pa = 5e4
137      CALL iniconst      CALL disvert
138        call test_disvert
139      CALL inigeom      CALL inigeom
140      CALL inifilr      CALL inifilr
141    
142      latfi(1) = 90.      rlat(1) = 90.
143      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
144      ! (with conversion to degrees)      ! (with conversion to degrees)
145      latfi(klon) = - 90.      rlat(klon) = - 90.
146    
147      lonfi(1) = 0.      rlon(1) = 0.
148      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
149      ! (with conversion to degrees)      ! (with conversion to degrees)
150      lonfi(klon) = 0.      rlon(klon) = 0.
151    
152      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, &
153           zval_2d) ! also compute "masque" and "phis"           zpic_2d, zval_2d) ! also compute "mask"
154      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
155      zmasq = pack(masque, dyn_phy)      zmasq = pack(mask, dyn_phy)
156      PRINT *, 'Masque construit'      PRINT *, 'Masque construit'
157    
158      CALL start_init_dyn(tsol_2d, psol) ! also compute "qsol_2d"      call start_init_phys(tsol_2d, qsol_2d)
159        CALL start_init_dyn(tsol_2d, phis, ps)
160    
161      ! Compute pressure on intermediate levels:      ! Compute pressure on intermediate levels:
162      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * psol(:, :)      forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * ps
163      CALL exner_hyb(psol, p3d, pks, pk)      CALL exner_hyb(ps, p3d, pks, pk)
164      IF (MINVAL(pk) == MAXVAL(pk)) stop '"pk" should not be constant'      call assert(MINVAL(pk) /= MAXVAL(pk), '"pk" should not be constant')
165    
166      pls(:, :, :) = preff * (pk(:, :, :) / cpp)**(1. / kappa)      pls = preff * (pk / cpp)**(1. / kappa)
167      PRINT *, "minval(pls(:, :, :)) = ", minval(pls(:, :, :))      PRINT *, "minval(pls) = ", minval(pls)
168      print *, "maxval(pls(:, :, :)) = ", maxval(pls(:, :, :))      print *, "maxval(pls) = ", maxval(pls)
169    
170      uvent(:, :, :) = start_inter_3d('U', rlonv, rlatv, pls)      call start_inter_3d('U', rlonv, rlatv, pls, ucov)
171      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, :)
172      uvent(iim+1, :, :) = uvent(1, :, :)      ucov(iim+1, :, :) = ucov(1, :, :)
173    
174      vvent(:, :, :) = start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :))      call start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :), vcov)
175      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, :)
176      vvent(iim + 1, :, :) = vvent(1, :, :)      vcov(iim + 1, :, :) = vcov(1, :, :)
177    
178      t3d(:, :, :) = start_inter_3d('TEMP', rlonu, rlatv, pls)      call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d)
179      PRINT *,  'minval(t3d(:, :, :)) = ', minval(t3d(:, :, :))      PRINT *, 'minval(t3d) = ', minval(t3d)
180      print *, "maxval(t3d(:, :, :)) = ", maxval(t3d(:, :, :))      print *, "maxval(t3d) = ", maxval(t3d)
181    
182      tpot(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :)      teta(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :)
183      tpot(iim + 1, :, :) = tpot(1, :, :)      teta(iim + 1, :, :) = teta(1, :, :)
184      DO l=1, llm      DO l = 1, llm
185         tpot(:, 1, l) = SUM(aire_2d(:, 1) * tpot(:, 1, l)) / apoln         teta(:, 1, l) = SUM(aire_2d(:, 1) * teta(:, 1, l)) / apoln
186         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)) &
187              / apols              / apols
188      ENDDO      ENDDO
189    
190      ! Calcul de l'humidité à saturation :      ! Calcul de l'humidit\'e \`a saturation :
191      qsat(:, :, :) = q_sat(t3d, pls)      qsat = q_sat(t3d, pls)
192      PRINT *, "minval(qsat(:, :, :)) = ", minval(qsat(:, :, :))      PRINT *, "minval(qsat) = ", minval(qsat)
193      print *, "maxval(qsat(:, :, :)) = ", maxval(qsat(:, :, :))      print *, "maxval(qsat) = ", maxval(qsat)
194      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'      IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant'
195    
196      ! Water vapor:      ! Water vapor:
197      q3d(:, :, :, 1) = 0.01 * start_inter_3d('R', rlonu, rlatv, pls) * qsat      call start_inter_3d('R', rlonu, rlatv, pls, q(:, :, :, 1))
198      WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10      q(:, :, :, 1) = 0.01 * q(:, :, :, 1) * qsat
199        WHERE (q(:, :, :, 1) < 0.) q(:, :, :, 1) = 1E-10
200      DO l = 1, llm      DO l = 1, llm
201         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
202         q3d(:, jjm + 1, l, 1) &         q(:, jjm + 1, l, 1) &
203              = SUM(aire_2d(:, jjm + 1) * q3d(:, jjm + 1, l, 1)) / apols              = SUM(aire_2d(:, jjm + 1) * q(:, jjm + 1, l, 1)) / apols
204      ENDDO      ENDDO
205    
206      q3d(:, :, :, 2:4) = 0. ! liquid water, radon and lead      q(:, :, :, 2:4) = 0. ! liquid water, radon and lead
207    
208      if (nqmx >= 5) then      if (nqmx >= 5) then
209         ! Ozone:         ! Ozone:
210           call regr_lat_time_coefoz
211           call regr_pr_o3(p3d, q(:, :, :, 5))
212           ! Convert from mole fraction to mass fraction:
213           q(:, :, :, 5) = q(:, :, :, 5) * 48. / 29.
214        end if
215    
216         ! Compute ozone parameters on the LMDZ grid:      sn = 0. ! snow
217         call regr_coefoz      radsol = 0.
218        seaice = 0.
219        rugmer = 0.001
220        zmea = pack(zmea_2d, dyn_phy)
221        zstd = pack(zstd_2d, dyn_phy)
222        zsig = pack(zsig_2d, dyn_phy)
223        zgam = pack(zgam_2d, dyn_phy)
224        zthe = pack(zthe_2d, dyn_phy)
225        zpic = pack(zpic_2d, dyn_phy)
226        zval = pack(zval_2d, dyn_phy)
227    
228         ! Find the month containing the day number "dayref":      ! On initialise les sous-surfaces.
229         month = (dayref - 1) / 30 + 1      ! Lecture du fichier glace de terre pour fixer la fraction de terre
230         print *, "month = ", month      ! et de glace de terre :
   
        call nf95_open("coefoz_LMDZ.nc", nf90_nowrite, ncid)  
   
        ! Get data at the right month from the input file:  
        call nf95_inq_varid(ncid, "r_Mob", varid)  
        ncerr = nf90_get_var(ncid, varid, q3d(:, :, :, 5), &  
             start=(/1, 1, 1, month/))  
        call handle_err("nf90_get_var r_Mob", ncerr)  
   
        call nf95_close(ncid)  
        ! Latitudes are in increasing order in the input file while  
        ! "rlatu" is in decreasing order so we need to invert order. Also, we  
        ! compute mass fraction from mole fraction:  
        q3d(:, :, :, 5) = q3d(:, jjm+1:1:-1, :, 5)  * 48. / 29.  
     end if  
231    
232      tsol(:) = pack(tsol_2d, dyn_phy)      call nf95_open("landiceref.nc", nf90_nowrite, ncid)
     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)  
233    
234      rugsrel(:) = 0.      call nf95_inq_varid(ncid, 'longitude', varid)
235      IF (ok_orodr) rugsrel(:) = MAX(1.e-05, zstd(:) * zsig(:) / 2)      call nf95_gw_var(ncid, varid, dlon_lic)
236        iml_lic = size(dlon_lic)
237    
238      ! On initialise les sous-surfaces:      call nf95_inq_varid(ncid, 'latitude', varid)
239      ! Lecture du fichier glace de terre pour fixer la fraction de terre      call nf95_gw_var(ncid, varid, dlat_lic)
240      ! et de glace de terre:      jml_lic = size(dlat_lic)
241      CALL flininfo("landiceref.nc", iml_lic, jml_lic, llm_tmp, &  
242           ttm_tmp, fid)      call nf95_inq_varid(ncid, 'landice', varid)
     ALLOCATE(lat_lic(iml_lic, jml_lic))  
     ALLOCATE(lon_lic(iml_lic, jml_lic))  
     ALLOCATE(dlon_lic(iml_lic))  
     ALLOCATE(dlat_lic(jml_lic))  
243      ALLOCATE(fraclic(iml_lic, jml_lic))      ALLOCATE(fraclic(iml_lic, jml_lic))
244      CALL flinopen_nozoom("landiceref.nc", iml_lic, jml_lic, &      call nf95_get_var(ncid, varid, fraclic)
245           llm_tmp, lon_lic, lat_lic, lev, ttm_tmp, itaul, date, dt,  &  
246           fid)      call nf95_close(ncid)
     CALL flinget(fid, 'landice', iml_lic, jml_lic, llm_tmp, ttm_tmp &  
          , 1, 1, fraclic)  
     CALL flinclo(fid)  
247    
248      ! Interpolation sur la grille T du modèle :      ! Interpolation sur la grille T du mod\`ele :
249      PRINT *, 'Dimensions de "landice"'      PRINT *, 'Dimensions de "landiceref.nc"'
250      print *, "iml_lic = ", iml_lic      print *, "iml_lic = ", iml_lic
251      print *, "jml_lic = ", jml_lic      print *, "jml_lic = ", jml_lic
252    
253      ! Si les coordonnées sont en degrés, on les transforme :      ! Si les coordonn\'ees sont en degr\'es, on les transforme :
254      IF (MAXVAL( lon_lic(:, :) ) > pi)  THEN      IF (MAXVAL(dlon_lic) > pi) THEN
255         lon_lic(:, :) = lon_lic(:, :) * pi / 180.         dlon_lic = dlon_lic * pi / 180.
256      ENDIF      ENDIF
257      IF (maxval( lat_lic(:, :) ) > pi) THEN      IF (maxval(dlat_lic) > pi) THEN
258         lat_lic(:, :) = lat_lic(:, :) * pi/ 180.         dlat_lic = dlat_lic * pi/ 180.
259      ENDIF      ENDIF
260    
     dlon_lic(:) = lon_lic(:, 1)  
     dlat_lic(:) = lat_lic(1, :)  
   
261      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &      flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), &
262           rlatu)           rlatu)
263      flic_tmp(iim + 1, :) = flic_tmp(1, :)      flic_tmp(iim + 1, :) = flic_tmp(1, :)
264    
265        deallocate(dlon_lic, dlat_lic) ! pointers
266    
267      ! Passage sur la grille physique      ! Passage sur la grille physique
268      pctsrf(:, :)=0.      pctsrf = 0.
269      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)      pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy)
270      ! Adéquation avec le maque terre/mer      ! Ad\'equation avec le maque terre/mer
271      WHERE (pctsrf(:, is_lic) < EPSFRA ) pctsrf(:, is_lic) = 0.      WHERE (pctsrf(:, is_lic) < EPSFRA) pctsrf(:, is_lic) = 0.
272      WHERE (zmasq(:) < EPSFRA) pctsrf(:, is_lic) = 0.      WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0.
273      pctsrf(:, is_ter) = zmasq(:)      pctsrf(:, is_ter) = zmasq
274      where (zmasq(:) > EPSFRA)      where (zmasq > EPSFRA)
275         where (pctsrf(:, is_lic) >= zmasq(:))         where (pctsrf(:, is_lic) >= zmasq)
276            pctsrf(:, is_lic) = zmasq(:)            pctsrf(:, is_lic) = zmasq
277            pctsrf(:, is_ter) = 0.            pctsrf(:, is_ter) = 0.
278         elsewhere         elsewhere
279            pctsrf(:, is_ter) = zmasq(:) - pctsrf(:, is_lic)            pctsrf(:, is_ter) = zmasq - pctsrf(:, is_lic)
280            where (pctsrf(:, is_ter) < EPSFRA)            where (pctsrf(:, is_ter) < EPSFRA)
281               pctsrf(:, is_ter) = 0.               pctsrf(:, is_ter) = 0.
282               pctsrf(:, is_lic) = zmasq(:)               pctsrf(:, is_lic) = zmasq
283            end where            end where
284         end where         end where
285      end where      end where
286    
287      ! 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
288      ! de mer à 0) :      ! de mer \`a 0) :
289      pctsrf(:, is_oce) = 1. - zmasq(:)      pctsrf(:, is_oce) = 1. - zmasq
290      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.      WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0.
291    
292      ! Vérification que somme des sous-surfaces vaut 1:      ! V\'erification que somme des sous-surfaces vaut 1 :
293      ji = count(abs(sum(pctsrf(:, :), dim = 2) - 1. ) > EPSFRA)      ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA)
294      IF (ji /= 0) PRINT *, 'Problème répartition sous maille pour', ji, 'points'      IF (ji /= 0) then
295           PRINT *, 'Bad surface percentages for ', ji, 'points'
296        end IF
297    
298      ! Calcul intermédiaire:      ! Calcul interm\'ediaire :
299      CALL massdair(p3d, masse)      CALL massdair(p3d, masse)
300    
301      print *, 'ALPHAX = ', alphax      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 307  contains Line 306  contains
306    
307      ! Initialisation pour traceurs:      ! Initialisation pour traceurs:
308      call iniadvtrac      call iniadvtrac
     ! Ecriture:  
     CALL inidissip(lstardis, nitergdiv, nitergrot, niterh, tetagdiv, &  
          tetagrot, tetatemp)  
     itau_dyn = 0  
309      itau_phy = 0      itau_phy = 0
     day_ref = dayref  
     annee_ref = anneeref  
310    
311      CALL geopot(ip1jmp1, tpot, pk , pks,  phis  , phi)      CALL geopot(teta, pk , pks, phis, phi)
312      CALL caldyn0(0, uvent, vvent, tpot, psol, masse, pk, phis, phi, w, &      CALL caldyn0(ucov, vcov, teta, ps, masse, pk, phis, phi, w, pbaru, &
313           pbaru, pbarv, 0)           pbarv)
314      CALL dynredem0("start.nc", dayref, phis)      CALL dynredem0("start.nc", day_ref, phis)
315      CALL dynredem1("start.nc", 0., vvent, uvent, tpot, q3d, masse, psol)      CALL dynredem1("start.nc", vcov, ucov, teta, q, masse, ps, itau=0)
   
     ! Ecriture état initial physique:  
     print *, 'dtvr = ', dtvr  
     print *, "iphysiq = ", iphysiq  
     print *, "nbapp_rad = ", nbapp_rad  
     phystep   = dtvr * REAL(iphysiq)  
     radpas    = NINT (86400./phystep/ nbapp_rad)  
     print *, 'phystep = ', phystep  
     print *, "radpas = ", radpas  
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 344  contains Line 324  contains
324      albe(:, is_oce) = 0.5      albe(:, is_oce) = 0.5
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 357  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", phystep, radpas, latfi, lonfi, pctsrf, &      call phyredem("startphy.nc", 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, rugsrel, &           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)
     CALL histclo  
356    
357    END SUBROUTINE etat0    END SUBROUTINE etat0
358    

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

  ViewVC Help
Powered by ViewVC 1.1.21