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

Diff of /trunk/dyn3d/etat0.f

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

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

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

  ViewVC Help
Powered by ViewVC 1.1.21