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

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

  ViewVC Help
Powered by ViewVC 1.1.21