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

Diff of /trunk/dyn3d/etat0.f90

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

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

Legend:
Removed from v.3  
changed lines
  Added in v.313

  ViewVC Help
Powered by ViewVC 1.1.21