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

Legend:
Removed from v.54  
changed lines
  Added in v.350

  ViewVC Help
Powered by ViewVC 1.1.21