--- trunk/libf/dyn3d/etat0.f90 2013/06/24 15:39:52 70 +++ trunk/dyn3d/etat0.f 2014/04/25 14:58:31 97 @@ -7,7 +7,7 @@ REAL pctsrf(klon, nbsrf) ! ("pctsrf(i, :)" is the composition of the surface at horizontal - ! position "i") + ! position "i") private nbsrf, klon @@ -15,17 +15,17 @@ SUBROUTINE etat0 - ! 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 use caldyn0_m, only: caldyn0 - use comconst, only: dtvr, daysec, cpp, kappa + use comconst, only: cpp, kappa, iniconst use comgeom, only: rlatu, rlonv, rlonu, rlatv, aire_2d, apoln, apols, & - cu_2d, cv_2d - use conf_gcm_m, only: day_step, iphysiq, dayref, anneeref + cu_2d, cv_2d, inigeom + use conf_gcm_m, only: dayref, anneeref use dimens_m, only: iim, jjm, llm, nqmx use dimphy, only: zmasq use dimsoil, only: nsoilmx - use disvert_m, only: ap, bp, preff, pa + use disvert_m, only: ap, bp, preff, pa, disvert use dynredem0_m, only: dynredem0 use dynredem1_m, only: dynredem1 use exner_hyb_m, only: exner_hyb @@ -35,23 +35,20 @@ use histclo_m, only: histclo use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra use iniadvtrac_m, only: iniadvtrac - use inidissip_m, only: inidissip use inifilr_m, only: inifilr - use inigeom_m, only: inigeom use massdair_m, only: massdair use netcdf, only: nf90_nowrite use netcdf95, only: nf95_close, nf95_get_var, nf95_gw_var, & nf95_inq_varid, nf95_open - use nr_util, only: pi + use nr_util, only: pi, assert use paramet_m, only: ip1jm, ip1jmp1 use phyredem_m, only: phyredem - use pressure_var, only: pls, p3d use q_sat_m, only: q_sat use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz use regr_pr_o3_m, only: regr_pr_o3 use serre, only: alphax use startdyn, only: start_init_dyn - USE start_init_orog_m, only: start_init_orog, mask, phis + USE start_init_orog_m, only: start_init_orog, mask use start_init_phys_m, only: start_init_phys use start_inter_3d_m, only: start_inter_3d use temps, only: itau_phy, annee_ref, day_ref @@ -60,9 +57,9 @@ REAL latfi(klon), lonfi(klon) ! (latitude and longitude of a point of the scalar grid identified - ! by a simple index, in °) + ! by a simple index, in degrees) - REAL, dimension(iim + 1, jjm + 1, llm):: ucov, t3d, tpot + REAL, dimension(iim + 1, jjm + 1, llm):: ucov, t3d, teta REAL vcov(iim + 1, jjm, llm) REAL q(iim + 1, jjm + 1, llm, nqmx) @@ -83,18 +80,19 @@ real seaice(klon) ! kg m-2 REAL frugs(klon, nbsrf), agesno(klon, nbsrf) REAL rugmer(klon) - real, dimension(iim + 1, jjm + 1):: relief, zstd_2d, zsig_2d, zgam_2d + REAL phis(iim + 1, jjm + 1) ! surface geopotential, in m2 s-2 + real, dimension(iim + 1, jjm + 1):: zmea_2d, zstd_2d, zsig_2d, zgam_2d real, dimension(iim + 1, jjm + 1):: zthe_2d, zpic_2d, zval_2d - real, dimension(iim + 1, jjm + 1):: tsol_2d, qsol_2d, psol + real, dimension(iim + 1, jjm + 1):: tsol_2d, qsol_2d, ps REAL zmea(klon), zstd(klon) REAL zsig(klon), zgam(klon) REAL zthe(klon) REAL zpic(klon), zval(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) real clwcon(klon, llm), rnebcon(klon, llm), ratqs(klon, llm) - ! Déclarations pour lecture glace de mer : + ! D\'eclarations pour lecture glace de mer : INTEGER iml_lic, jml_lic INTEGER ncid, varid REAL, pointer:: dlon_lic(:), dlat_lic(:) @@ -109,20 +107,30 @@ REAL masse(iim + 1, jjm + 1, llm) REAL phi(iim + 1, jjm + 1, llm) REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm) - REAL w(ip1jmp1, llm) - REAL phystep + REAL w(iim + 1, jjm + 1, llm) + + real sig1(klon, llm) ! section adiabatic updraft + real w01(klon, llm) ! vertical velocity within adiabatic updraft + + real pls(iim + 1, jjm + 1, llm) + ! (pressure at mid-layer of LMDZ grid, in Pa) + ! "pls(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)", + ! for layer "l") + + REAL p3d(iim + 1, jjm + 1, llm+1) ! pressure at layer interfaces, in Pa + ! ("p3d(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)", + ! for interface "l") !--------------------------------- print *, "Call sequence information: etat0" - dtvr = daysec / real(day_step) - print *, 'dtvr = ', dtvr + CALL iniconst ! Construct a grid: pa = 5e4 - CALL iniconst + CALL disvert CALL inigeom CALL inifilr @@ -136,22 +144,19 @@ ! (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" + call start_init_orog(phis, zmea_2d, zstd_2d, zsig_2d, zgam_2d, zthe_2d, & + zpic_2d, zval_2d) ! also compute "mask" call init_dyn_phy ! define the mask "dyn_phy" for distinct grid points zmasq = pack(mask, dyn_phy) PRINT *, 'Masque construit' call start_init_phys(tsol_2d, qsol_2d) - CALL start_init_dyn(tsol_2d, psol) + CALL start_init_dyn(tsol_2d, phis, ps) ! Compute pressure on intermediate levels: - forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * psol - CALL exner_hyb(psol, p3d, pks, pk) - IF (MINVAL(pk) == MAXVAL(pk)) then - print *, '"pk" should not be constant' - stop 1 - end IF + forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * ps + CALL exner_hyb(ps, p3d, pks, pk) + call assert(MINVAL(pk) /= MAXVAL(pk), '"pk" should not be constant') pls = preff * (pk / cpp)**(1. / kappa) PRINT *, "minval(pls) = ", minval(pls) @@ -166,18 +171,18 @@ vcov(iim + 1, :, :) = vcov(1, :, :) call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d) - PRINT *, 'minval(t3d) = ', minval(t3d) + PRINT *, 'minval(t3d) = ', minval(t3d) print *, "maxval(t3d) = ", maxval(t3d) - tpot(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :) - tpot(iim + 1, :, :) = tpot(1, :, :) - DO l=1, llm - tpot(:, 1, l) = SUM(aire_2d(:, 1) * tpot(:, 1, l)) / apoln - tpot(:, jjm + 1, l) = SUM(aire_2d(:, jjm + 1) * tpot(:, jjm + 1, l)) & + teta(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :) + teta(iim + 1, :, :) = teta(1, :, :) + DO l = 1, llm + teta(:, 1, l) = SUM(aire_2d(:, 1) * teta(:, 1, l)) / apoln + teta(:, jjm + 1, l) = SUM(aire_2d(:, jjm + 1) * teta(:, jjm + 1, l)) & / apols ENDDO - ! Calcul de l'humidité à saturation : + ! Calcul de l'humidit\'e \`a saturation : qsat = q_sat(t3d, pls) PRINT *, "minval(qsat) = ", minval(qsat) print *, "maxval(qsat) = ", maxval(qsat) @@ -198,9 +203,9 @@ if (nqmx >= 5) then ! Ozone: call regr_lat_time_coefoz - call regr_pr_o3(q(:, :, :, 5)) + call regr_pr_o3(p3d, q(:, :, :, 5)) ! Convert from mole fraction to mass fraction: - q(:, :, :, 5) = q(:, :, :, 5) * 48. / 29. + q(:, :, :, 5) = q(:, :, :, 5) * 48. / 29. end if tsol = pack(tsol_2d, dyn_phy) @@ -210,7 +215,7 @@ tslab = 0. ! IM "slab" ocean seaice = 0. rugmer = 0.001 - zmea = pack(relief, dyn_phy) + zmea = pack(zmea_2d, dyn_phy) zstd = pack(zstd_2d, dyn_phy) zsig = pack(zsig_2d, dyn_phy) zgam = pack(zgam_2d, dyn_phy) @@ -238,16 +243,16 @@ call nf95_close(ncid) - ! Interpolation sur la grille T du modèle : + ! Interpolation sur la grille T du mod\`ele : PRINT *, 'Dimensions de "landiceref.nc"' print *, "iml_lic = ", iml_lic print *, "jml_lic = ", jml_lic - ! Si les coordonnées sont en degrés, on les transforme : - IF (MAXVAL( dlon_lic ) > pi) THEN + ! Si les coordonn\'ees sont en degr\'es, on les transforme : + IF (MAXVAL(dlon_lic) > pi) THEN dlon_lic = dlon_lic * pi / 180. ENDIF - IF (maxval( dlat_lic ) > pi) THEN + IF (maxval(dlat_lic) > pi) THEN dlat_lic = dlat_lic * pi/ 180. ENDIF @@ -260,8 +265,8 @@ ! Passage sur la grille physique pctsrf = 0. pctsrf(:, is_lic) = pack(flic_tmp, dyn_phy) - ! Adéquation avec le maque terre/mer - WHERE (pctsrf(:, is_lic) < EPSFRA ) pctsrf(:, is_lic) = 0. + ! Ad\'equation avec le maque terre/mer + WHERE (pctsrf(:, is_lic) < EPSFRA) pctsrf(:, is_lic) = 0. WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0. pctsrf(:, is_ter) = zmasq where (zmasq > EPSFRA) @@ -277,23 +282,23 @@ end where end where - ! Sous-surface océan et glace de mer (pour démarrer on met glace - ! de mer à 0) : + ! Sous-surface oc\'ean et glace de mer (pour d\'emarrer on met glace + ! de mer \`a 0) : pctsrf(:, is_oce) = 1. - zmasq WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0. - ! Vérification que somme des sous-surfaces vaut 1: + ! V\'erification que somme des sous-surfaces vaut 1 : ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA) IF (ji /= 0) then - PRINT *, 'Problème répartition sous maille pour ', ji, 'points' + PRINT *, 'Bad surface percentages for ', ji, 'points' end IF - ! Calcul intermédiaire: + ! Calcul interm\'ediaire : CALL massdair(p3d, masse) print *, 'ALPHAX = ', alphax - forall (l = 1:llm) + forall (l = 1:llm) masse(:, 1, l) = SUM(aire_2d(:iim, 1) * masse(:iim, 1, l)) / apoln masse(:, jjm + 1, l) = & SUM(aire_2d(:iim, jjm + 1) * masse(:iim, jjm + 1, l)) / apols @@ -301,21 +306,15 @@ ! Initialisation pour traceurs: call iniadvtrac - CALL inidissip itau_phy = 0 day_ref = dayref annee_ref = anneeref - CALL geopot(tpot, pk , pks, phis, phi) - CALL caldyn0(ucov, vcov, tpot, psol, masse, pk, phis, phi, w, pbaru, & + CALL geopot(teta, pk , pks, phis, phi) + CALL caldyn0(ucov, vcov, teta, ps, masse, pk, phis, phi, w, pbaru, & pbarv) CALL dynredem0("start.nc", dayref, phis) - CALL dynredem1("start.nc", vcov, ucov, tpot, q, masse, psol, itau=0) - - ! Ecriture état initial physique: - print *, "iphysiq = ", iphysiq - phystep = dtvr * REAL(iphysiq) - print *, 'phystep = ', phystep + CALL dynredem1("start.nc", vcov, ucov, teta, q, masse, ps, itau=0) ! Initialisations : tsolsrf(:, is_ter) = tsol @@ -349,20 +348,22 @@ seaice = 0. frugs(:, is_oce) = rugmer - frugs(:, is_ter) = MAX(1.e-05, zstd * zsig / 2) - frugs(:, is_lic) = MAX(1.e-05, zstd * zsig / 2) + frugs(:, is_ter) = MAX(1e-5, zstd * zsig / 2) + frugs(:, is_lic) = MAX(1e-5, zstd * zsig / 2) frugs(:, is_sic) = 0.001 fder = 0. clwcon = 0. rnebcon = 0. ratqs = 0. run_off_lic_0 = 0. + sig1 = 0. + w01 = 0. call phyredem("startphy.nc", latfi, lonfi, pctsrf, & tsolsrf, tsoil, tslab, seaice, qsolsrf, qsol, snsrf, albe, alblw, & evap, rain_fall, snow_fall, solsw, sollw, fder, radsol, frugs, & agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, & - t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0) + t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0, sig1, w01) CALL histclo END SUBROUTINE etat0