--- trunk/libf/dyn3d/etat0.f90 2008/07/21 16:05:07 12 +++ trunk/libf/dyn3d/etat0.f90 2011/07/19 12:54:20 48 @@ -6,6 +6,8 @@ IMPLICIT NONE REAL pctsrf(klon, nbsrf) + ! ("pctsrf(i, :)" is the composition of the surface at horizontal + ! position "i") private nbsrf, klon @@ -15,37 +17,43 @@ ! From "etat0_netcdf.F", version 1.3 2005/05/25 13:10:09 - ! This subroutine creates "masque". + ! This subroutine creates "mask". - USE ioipsl, only: flinget, flinclo, flinopen_nozoom, flininfo, histclo - - 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 - 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 - use dimphy, only: zmasq - use conf_gcm_m, only: day_step, iphysiq, dayref, anneeref + use caldyn0_m, only: caldyn0 + use comconst, only: dtvr, daysec, cpp, kappa use comgeom, only: rlatu, rlonv, rlonu, rlatv, aire_2d, apoln, apols, & cu_2d, cv_2d - use serre, only: alphax + use comvert, only: ap, bp, preff, pa + use conf_gcm_m, only: day_step, iphysiq, dayref, anneeref + use dimens_m, only: iim, jjm, llm, nqmx + use dimphy, only: zmasq use dimsoil, only: nsoilmx - use temps, only: itau_dyn, itau_phy, annee_ref, day_ref, dt - use clesphys2, only: ok_orodr, nbapp_rad + use dynredem0_m, only: dynredem0 + use dynredem1_m, only: dynredem1 + use exner_hyb_m, only: exner_hyb + USE flincom, only: flinclo, flinopen_nozoom, flininfo + use geopot_m, only: geopot use grid_atob, only: grille_m use grid_change, only: init_dyn_phy, dyn_phy - use q_sat_m, only: q_sat - use exner_hyb_m, only: exner_hyb - use advtrac_m, only: iniadvtrac + use histcom, 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 inigeom_m, only: inigeom + use netcdf, only: nf90_nowrite + use netcdf95, only: nf95_open, nf95_close, nf95_get_var, nf95_inq_varid + use nr_util, only: pi + use paramet_m, only: ip1jm, ip1jmp1 + use phyredem_m, only: phyredem use pressure_var, only: pls, p3d - use dynredem0_m, only: dynredem0 + 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 start_init_orog_m, only: start_init_orog, mask, phis + use start_init_phys_m, only: start_init_phys + use startdyn, only: start_inter_3d, start_init_dyn + use temps, only: itau_phy, annee_ref, day_ref ! Variables local to the procedure: @@ -76,18 +84,17 @@ REAL rugmer(klon) real, dimension(iim + 1, jjm + 1):: relief, 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, psol + real, dimension(iim + 1, jjm + 1):: tsol_2d, qsol_2d, psol REAL zmea(klon), zstd(klon) REAL zsig(klon), zgam(klon) REAL zthe(klon) REAL zpic(klon), zval(klon) - REAL rugsrel(klon) 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 INTEGER iml_lic, jml_lic, llm_tmp, ttm_tmp - INTEGER itaul(1), fid + INTEGER itaul(1), fid, ncid, varid REAL lev(1), date REAL, ALLOCATABLE:: lon_lic(:, :), lat_lic(:, :) REAL, ALLOCATABLE:: dlon_lic(:), dlat_lic(:) @@ -104,17 +111,17 @@ REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm) REAL w(ip1jmp1, llm) REAL phystep - INTEGER radpas + real trash !--------------------------------- print *, "Call sequence information: etat0" - ! Construct a grid: - dtvr = daysec / real(day_step) print *, 'dtvr = ', dtvr + ! Construct a grid: + pa = 5e4 CALL iniconst CALL inigeom @@ -131,33 +138,34 @@ 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" + zval_2d) ! also compute "mask" and "phis" call init_dyn_phy ! define the mask "dyn_phy" for distinct grid points - zmasq = pack(masque, dyn_phy) + zmasq = pack(mask, dyn_phy) PRINT *, 'Masque construit' - CALL start_init_dyn(tsol_2d, psol) ! also compute "qsol_2d" + call start_init_phys(tsol_2d, qsol_2d) + CALL start_init_dyn(tsol_2d, psol) ! Compute pressure on intermediate levels: - forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * psol(:, :) + forall(l = 1: llm + 1) p3d(:, :, l) = ap(l) + bp(l) * psol CALL exner_hyb(psol, p3d, pks, pk) IF (MINVAL(pk) == MAXVAL(pk)) stop '"pk" should not be constant' - pls(:, :, :) = preff * (pk(:, :, :) / cpp)**(1. / kappa) - PRINT *, "minval(pls(:, :, :)) = ", minval(pls(:, :, :)) - print *, "maxval(pls(:, :, :)) = ", maxval(pls(:, :, :)) + pls = preff * (pk / cpp)**(1. / kappa) + PRINT *, "minval(pls) = ", minval(pls) + print *, "maxval(pls) = ", maxval(pls) - uvent(:, :, :) = start_inter_3d('U', rlonv, rlatv, pls) + call start_inter_3d('U', rlonv, rlatv, pls, uvent) forall (l = 1: llm) uvent(:iim, :, l) = uvent(:iim, :, l) * cu_2d(:iim, :) uvent(iim+1, :, :) = uvent(1, :, :) - vvent(:, :, :) = start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :)) + call start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :), vvent) forall (l = 1: llm) vvent(:iim, :, l) = vvent(:iim, :, l) * cv_2d(:iim, :) vvent(iim + 1, :, :) = vvent(1, :, :) - t3d(:, :, :) = start_inter_3d('TEMP', rlonu, rlatv, pls) - PRINT *, 'minval(t3d(:, :, :)) = ', minval(t3d(:, :, :)) - print *, "maxval(t3d(:, :, :)) = ", maxval(t3d(:, :, :)) + call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d) + PRINT *, 'minval(t3d) = ', minval(t3d) + print *, "maxval(t3d) = ", maxval(t3d) tpot(:iim, :, :) = t3d(:iim, :, :) * cpp / pk(:iim, :, :) tpot(iim + 1, :, :) = tpot(1, :, :) @@ -168,13 +176,14 @@ ENDDO ! Calcul de l'humidité à saturation : - qsat(:, :, :) = q_sat(t3d, pls) - PRINT *, "minval(qsat(:, :, :)) = ", minval(qsat(:, :, :)) - print *, "maxval(qsat(:, :, :)) = ", maxval(qsat(:, :, :)) + qsat = q_sat(t3d, pls) + PRINT *, "minval(qsat) = ", minval(qsat) + print *, "maxval(qsat) = ", maxval(qsat) IF (MINVAL(qsat) == MAXVAL(qsat)) stop '"qsat" should not be constant' ! Water vapor: - q3d(:, :, :, 1) = 0.01 * start_inter_3d('R', rlonu, rlatv, pls) * qsat + call start_inter_3d('R', rlonu, rlatv, pls, q3d(:, :, :, 1)) + q3d(:, :, :, 1) = 0.01 * q3d(:, :, :, 1) * qsat WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10 DO l = 1, llm q3d(:, 1, l, 1) = SUM(aire_2d(:, 1) * q3d(:, 1, l, 1)) / apoln @@ -192,23 +201,20 @@ q3d(:, :, :, 5) = q3d(:, :, :, 5) * 48. / 29. end if - 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) - - rugsrel(:) = 0. - IF (ok_orodr) rugsrel(:) = MAX(1.e-05, zstd(:) * zsig(:) / 2) + 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) ! On initialise les sous-surfaces: ! Lecture du fichier glace de terre pour fixer la fraction de terre @@ -220,11 +226,13 @@ ALLOCATE(dlon_lic(iml_lic)) ALLOCATE(dlat_lic(jml_lic)) ALLOCATE(fraclic(iml_lic, jml_lic)) - CALL flinopen_nozoom("landiceref.nc", iml_lic, jml_lic, & - llm_tmp, lon_lic, lat_lic, lev, ttm_tmp, itaul, date, dt, & + CALL flinopen_nozoom(iml_lic, jml_lic, & + llm_tmp, lon_lic, lat_lic, lev, ttm_tmp, itaul, date, trash, & fid) - CALL flinget(fid, 'landice', iml_lic, jml_lic, llm_tmp, ttm_tmp & - , 1, 1, fraclic) + call nf95_open("landiceref.nc", nf90_nowrite, ncid) + call nf95_inq_varid(ncid, 'landice', varid) + call nf95_get_var(ncid, varid, fraclic) + call nf95_close(ncid) CALL flinclo(fid) ! Interpolation sur la grille T du modèle : @@ -233,48 +241,50 @@ print *, "jml_lic = ", jml_lic ! Si les coordonnées sont en degrés, on les transforme : - IF (MAXVAL( lon_lic(:, :) ) > pi) THEN - lon_lic(:, :) = lon_lic(:, :) * pi / 180. + IF (MAXVAL( lon_lic ) > pi) THEN + lon_lic = lon_lic * pi / 180. ENDIF - IF (maxval( lat_lic(:, :) ) > pi) THEN - lat_lic(:, :) = lat_lic(:, :) * pi/ 180. + IF (maxval( lat_lic ) > pi) THEN + lat_lic = lat_lic * pi/ 180. ENDIF - dlon_lic(:) = lon_lic(:, 1) - dlat_lic(:) = lat_lic(1, :) + dlon_lic = lon_lic(:, 1) + dlat_lic = lat_lic(1, :) flic_tmp(:iim, :) = grille_m(dlon_lic, dlat_lic, fraclic, rlonv(:iim), & rlatu) flic_tmp(iim + 1, :) = flic_tmp(1, :) ! Passage sur la grille physique - pctsrf(:, :)=0. + 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. - WHERE (zmasq(:) < EPSFRA) pctsrf(:, is_lic) = 0. - pctsrf(:, is_ter) = zmasq(:) - where (zmasq(:) > EPSFRA) - where (pctsrf(:, is_lic) >= zmasq(:)) - pctsrf(:, is_lic) = zmasq(:) + WHERE (zmasq < EPSFRA) pctsrf(:, is_lic) = 0. + pctsrf(:, is_ter) = zmasq + where (zmasq > EPSFRA) + where (pctsrf(:, is_lic) >= zmasq) + pctsrf(:, is_lic) = zmasq pctsrf(:, is_ter) = 0. elsewhere - pctsrf(:, is_ter) = zmasq(:) - pctsrf(:, is_lic) + pctsrf(:, is_ter) = zmasq - pctsrf(:, is_lic) where (pctsrf(:, is_ter) < EPSFRA) pctsrf(:, is_ter) = 0. - pctsrf(:, is_lic) = zmasq(:) + pctsrf(:, is_lic) = zmasq end where end where end where ! Sous-surface océan et glace de mer (pour démarrer on met glace ! de mer à 0) : - pctsrf(:, is_oce) = 1. - zmasq(:) + pctsrf(:, is_oce) = 1. - zmasq WHERE (pctsrf(:, is_oce) < EPSFRA) pctsrf(:, is_oce) = 0. ! Vérification que somme des sous-surfaces vaut 1: - ji = count(abs(sum(pctsrf(:, :), dim = 2) - 1. ) > EPSFRA) - IF (ji /= 0) PRINT *, 'Problème répartition sous maille pour', ji, 'points' + ji = count(abs(sum(pctsrf, dim = 2) - 1.) > EPSFRA) + IF (ji /= 0) then + PRINT *, 'Problème répartition sous maille pour ', ji, 'points' + end IF ! Calcul intermédiaire: CALL massdair(p3d, masse) @@ -289,28 +299,21 @@ ! Initialisation pour traceurs: call iniadvtrac - ! Ecriture: - CALL inidissip(lstardis, nitergdiv, nitergrot, niterh, tetagdiv, & - tetagrot, tetatemp) - itau_dyn = 0 + CALL inidissip 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 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", 0., vvent, uvent, tpot, q3d, masse, psol) + CALL dynredem1("start.nc", vvent, uvent, tpot, q3d, masse, psol, itau=0) ! 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 ! Initialisations : tsolsrf(:, is_ter) = tsol @@ -326,7 +329,7 @@ albe(:, is_oce) = 0.5 albe(:, is_sic) = 0.6 alblw = albe - evap(:, :) = 0. + evap = 0. qsolsrf(:, is_ter) = 150. qsolsrf(:, is_lic) = 150. qsolsrf(:, is_oce) = 150. @@ -340,12 +343,12 @@ q_ancien = 0. agesno = 0. !IM "slab" ocean - tslab(:) = tsolsrf(:, is_oce) + tslab = tsolsrf(:, is_oce) 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_oce) = rugmer + frugs(:, is_ter) = MAX(1.e-05, zstd * zsig / 2) + frugs(:, is_lic) = MAX(1.e-05, zstd * zsig / 2) frugs(:, is_sic) = 0.001 fder = 0. clwcon = 0. @@ -353,10 +356,10 @@ ratqs = 0. run_off_lic_0 = 0. - call phyredem("startphy.nc", radpas, latfi, lonfi, pctsrf, & + 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, rugsrel, & + agesno, zmea, zstd, zsig, zgam, zthe, zpic, zval, & t_ancien, q_ancien, rnebcon, ratqs, clwcon, run_off_lic_0) CALL histclo