--- trunk/libf/dyn3d/etat0.f90 2008/08/01 15:24:12 15 +++ trunk/Sources/dyn3d/etat0.f 2017/01/12 12:31:31 212 @@ -7,199 +7,216 @@ REAL pctsrf(klon, nbsrf) ! ("pctsrf(i, :)" is the composition of the surface at horizontal - ! position "i") + ! position "i") private nbsrf, klon contains - SUBROUTINE etat0 + SUBROUTINE etat0(phis) - ! 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 - ! This subroutine creates "mask". - - USE ioipsl, only: flinget, flinclo, flinopen_nozoom, flininfo, histclo - - USE start_init_orog_m, only: start_init_orog, mask, phis - use start_init_phys_m, only: qsol_2d - use startdyn, only: start_inter_3d, start_init_dyn + use caldyn0_m, only: caldyn0 + use comconst, only: cpp, kappa, iniconst + use comgeom, only: aire_2d, apoln, apols, cu_2d, cv_2d, inigeom + use conf_gcm_m, only: nday 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 comgeom, only: rlatu, rlonv, rlonu, rlatv, aire_2d, apoln, apols, & - cu_2d, cv_2d - use serre, only: alphax use dimsoil, only: nsoilmx - use temps, only: itau_dyn, itau_phy, annee_ref, day_ref, dt - use grid_atob, only: grille_m + use disvert_m, only: ap, bp, preff, pa, disvert + use dynetat0_m, only: day_ref, annee_ref, xprimp025, xprimm025, rlatu1, & + rlatu2, rlatu, rlatv, yprimu1, yprimu2, rlonu, rlonv, xprimu, xprimv + use dynredem0_m, only: dynredem0 + use dynredem1_m, only: dynredem1 + use exner_hyb_m, only: exner_hyb + use fxhyp_m, only: fxhyp + use fyhyp_m, only: fyhyp + use geopot_m, only: geopot + use grille_m_m, only: grille_m use grid_change, only: init_dyn_phy, dyn_phy + use indicesol, only: is_oce, is_sic, is_ter, is_lic, epsfra + use iniadvtrac_m, only: iniadvtrac + use inifilr_m, only: inifilr + use massdair_m, only: massdair + use netcdf, only: nf90_nowrite + use netcdf95, only: nf95_close, nf95_get_var, nf95_gw_var, nf95_put_var, & + nf95_inq_varid, nf95_open + use nr_util, only: pi, assert + use phyetat0_m, only: rlat, rlon, itau_phy + use phyredem0_m, only: phyredem0, ncid_restartphy + use phyredem_m, only: phyredem use q_sat_m, only: q_sat - use exner_hyb_m, only: exner_hyb - use advtrac_m, only: iniadvtrac - use pressure_var, only: pls, p3d - use dynredem0_m, only: dynredem0 use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz use regr_pr_o3_m, only: regr_pr_o3 - use phyredem_m, only: phyredem - - ! Variables local to the procedure: + use startdyn, only: start_init_dyn + 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 test_disvert_m, only: test_disvert + use unit_nml_m, only: unit_nml + + REAL, intent(out):: phis(:, :) ! (iim + 1, jjm + 1) + ! surface geopotential, in m2 s-2 - REAL latfi(klon), lonfi(klon) - ! (latitude and longitude of a point of the scalar grid identified - ! by a simple index, in °) + ! Local: - REAL, dimension(iim + 1, jjm + 1, llm):: uvent, t3d, tpot - REAL vvent(iim + 1, jjm, llm) + REAL, dimension(iim + 1, jjm + 1, llm):: ucov, t3d, teta + REAL vcov(iim + 1, jjm, llm) - REAL q3d(iim + 1, jjm + 1, llm, nqmx) + REAL q(iim + 1, jjm + 1, llm, nqmx) ! (mass fractions of trace species - ! "q3d(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)" + ! "q(i, j, l)" is at longitude "rlonv(i)", latitude "rlatu(j)" ! and pressure level "pls(i, j, l)".) real qsat(iim + 1, jjm + 1, llm) ! mass fraction of saturating water vapor - REAL tsol(klon), qsol(klon), sn(klon) - REAL tsolsrf(klon, nbsrf), qsolsrf(klon, nbsrf), snsrf(klon, nbsrf) + REAL qsolsrf(klon, nbsrf), snsrf(klon, nbsrf) REAL albe(klon, nbsrf), evap(klon, nbsrf) - REAL alblw(klon, nbsrf) REAL tsoil(klon, nsoilmx, nbsrf) - REAL radsol(klon), rain_fall(klon), snow_fall(klon) - REAL solsw(klon), sollw(klon), fder(klon) + REAL null_array(klon) + REAL solsw(klon), sollw(klon) !IM "slab" ocean - REAL tslab(klon) - 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, 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, 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 run_off_lic_0(klon) + REAL t_ancien(klon, llm), q_ancien(klon, llm) 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 - REAL lev(1), date - REAL, ALLOCATABLE:: lon_lic(:, :), lat_lic(:, :) - REAL, ALLOCATABLE:: dlon_lic(:), dlat_lic(:) + + ! D\'eclarations pour lecture glace de mer : + INTEGER iml_lic, jml_lic + INTEGER ncid, varid + REAL, pointer:: dlon_lic(:), dlat_lic(:) REAL, ALLOCATABLE:: fraclic(:, :) ! fraction land ice - REAL flic_tmp(iim + 1, jjm + 1) !fraction land ice temporary + REAL flic_tmp(iim + 1, jjm + 1) ! fraction land ice temporary INTEGER l, ji REAL pk(iim + 1, jjm + 1, llm) ! fonction d'Exner aux milieux des couches real pks(iim + 1, jjm + 1) - REAL masse(iim + 1, jjm + 1, llm) - REAL phi(ip1jmp1, llm) - REAL pbaru(ip1jmp1, llm), pbarv(ip1jm, llm) - REAL w(ip1jmp1, llm) - REAL phystep + REAL phi(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") + + namelist /etat0_nml/ day_ref, annee_ref !--------------------------------- print *, "Call sequence information: etat0" - ! Construct a grid: + print *, "Enter namelist 'etat0_nml'." + read(unit=*, nml=etat0_nml) + write(unit_nml, nml=etat0_nml) - dtvr = daysec / real(day_step) - print *, 'dtvr = ', dtvr + CALL iniconst + + ! Construct a grid: pa = 5e4 - CALL iniconst + CALL disvert + call test_disvert + + CALL fyhyp(rlatu, rlatv, rlatu2, yprimu2, rlatu1, yprimu1) + CALL fxhyp(xprimm025, rlonv, xprimv, rlonu, xprimu, xprimp025) + + rlatu(1) = pi / 2. + rlatu(jjm + 1) = -rlatu(1) + CALL inigeom CALL inifilr - latfi(1) = 90. - latfi(2:klon-1) = pack(spread(rlatu(2:jjm), 1, iim), .true.) * 180. / pi + rlat(1) = 90. + rlat(2:klon-1) = pack(spread(rlatu(2:jjm), 1, iim), .true.) * 180. / pi ! (with conversion to degrees) - latfi(klon) = - 90. + rlat(klon) = - 90. - lonfi(1) = 0. - lonfi(2:klon-1) = pack(spread(rlonv(:iim), 2, jjm - 1), .true.) * 180. / pi + rlon(1) = 0. + rlon(2:klon-1) = pack(spread(rlonv(:iim), 2, jjm - 1), .true.) * 180. / pi ! (with conversion to degrees) - lonfi(klon) = 0. + rlon(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_dyn(tsol_2d, psol) ! also compute "qsol_2d" + call start_init_phys(tsol_2d, qsol_2d) + 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)) stop '"pk" should not be constant' - - pls(:, :, :) = preff * (pk(:, :, :) / cpp)**(1. / kappa) - PRINT *, "minval(pls(:, :, :)) = ", minval(pls(:, :, :)) - print *, "maxval(pls(:, :, :)) = ", maxval(pls(:, :, :)) - - uvent(:, :, :) = start_inter_3d('U', rlonv, rlatv, pls) - 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, :)) - 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(:, :, :)) - - 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)) & + 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) + print *, "maxval(pls) = ", maxval(pls) + + call start_inter_3d('U', rlonv, rlatv, pls, ucov) + forall (l = 1: llm) ucov(:iim, :, l) = ucov(:iim, :, l) * cu_2d(:iim, :) + ucov(iim+1, :, :) = ucov(1, :, :) + + call start_inter_3d('V', rlonu, rlatu(:jjm), pls(:, :jjm, :), vcov) + forall (l = 1: llm) vcov(:iim, :, l) = vcov(:iim, :, l) * cv_2d(:iim, :) + vcov(iim + 1, :, :) = vcov(1, :, :) + + call start_inter_3d('TEMP', rlonu, rlatv, pls, t3d) + PRINT *, 'minval(t3d) = ', minval(t3d) + print *, "maxval(t3d) = ", maxval(t3d) + + 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 : - qsat(:, :, :) = q_sat(t3d, pls) - PRINT *, "minval(qsat(:, :, :)) = ", minval(qsat(:, :, :)) - print *, "maxval(qsat(:, :, :)) = ", maxval(qsat(:, :, :)) + ! Calcul de l'humidit\'e \`a saturation : + 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 - WHERE (q3d(:, :, :, 1) < 0.) q3d(:, :, :, 1) = 1E-10 + call start_inter_3d('R', rlonu, rlatv, pls, q(:, :, :, 1)) + q(:, :, :, 1) = 0.01 * q(:, :, :, 1) * qsat + WHERE (q(:, :, :, 1) < 0.) q(:, :, :, 1) = 1E-10 DO l = 1, llm - q3d(:, 1, l, 1) = SUM(aire_2d(:, 1) * q3d(:, 1, l, 1)) / apoln - q3d(:, jjm + 1, l, 1) & - = SUM(aire_2d(:, jjm + 1) * q3d(:, jjm + 1, l, 1)) / apols + q(:, 1, l, 1) = SUM(aire_2d(:, 1) * q(:, 1, l, 1)) / apoln + q(:, jjm + 1, l, 1) & + = SUM(aire_2d(:, jjm + 1) * q(:, jjm + 1, l, 1)) / apols ENDDO - q3d(:, :, :, 2:4) = 0. ! liquid water, radon and lead + q(:, :, :, 2:4) = 0. ! liquid water, radon and lead if (nqmx >= 5) then ! Ozone: call regr_lat_time_coefoz - call regr_pr_o3(q3d(:, :, :, 5)) + call regr_pr_o3(p3d, q(:, :, :, 5)) ! Convert from mole fraction to mass fraction: - q3d(:, :, :, 5) = q3d(:, :, :, 5) * 48. / 29. + q(:, :, :, 5) = q(:, :, :, 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. + null_array = 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) @@ -207,48 +224,50 @@ zpic = pack(zpic_2d, dyn_phy) zval = pack(zval_2d, dyn_phy) - ! On initialise les sous-surfaces: + ! On initialise les sous-surfaces. ! 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)) + ! et de glace de terre : + + call nf95_open("landiceref.nc", nf90_nowrite, ncid) + + call nf95_inq_varid(ncid, 'longitude', varid) + call nf95_gw_var(ncid, varid, dlon_lic) + iml_lic = size(dlon_lic) + + call nf95_inq_varid(ncid, 'latitude', varid) + call nf95_gw_var(ncid, varid, dlat_lic) + jml_lic = size(dlat_lic) + + call nf95_inq_varid(ncid, 'landice', varid) 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, & - fid) - CALL flinget(fid, 'landice', iml_lic, jml_lic, llm_tmp, ttm_tmp & - , 1, 1, fraclic) - CALL flinclo(fid) + call nf95_get_var(ncid, varid, fraclic) + + call nf95_close(ncid) - ! Interpolation sur la grille T du modèle : - PRINT *, 'Dimensions de "landice"' + ! 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( lon_lic ) > pi) THEN - lon_lic = lon_lic * pi / 180. + ! 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( lat_lic ) > pi) THEN - lat_lic = lat_lic * pi/ 180. + IF (maxval(dlat_lic) > pi) THEN + dlat_lic = dlat_lic * pi/ 180. ENDIF - 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, :) + deallocate(dlon_lic, dlat_lic) ! pointers + ! 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) @@ -264,97 +283,69 @@ 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 la 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 END forall - ! Initialisation pour traceurs: call iniadvtrac - ! Ecriture: - CALL inidissip(lstardis, nitergdiv, nitergrot, niterh, tetagdiv, & - tetagrot, tetatemp) - 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) - CALL dynredem1("start.nc", 0., vvent, uvent, tpot, q3d, masse, psol) - - ! Ecriture état initial physique: - print *, 'dtvr = ', dtvr - print *, "iphysiq = ", iphysiq - phystep = dtvr * REAL(iphysiq) - print *, 'phystep = ', phystep + CALL geopot(teta, pk , pks, phis, phi) + CALL caldyn0(ucov, vcov, teta, ps, pk, phis, phi) + CALL dynredem0(day_ref, phis) + CALL dynredem1(vcov, ucov, teta, q, masse, ps, itau = 0) ! Initialisations : - tsolsrf(:, is_ter) = tsol - 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 + snsrf = 0. 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. + qsolsrf = 150. + tsoil = spread(spread(pack(tsol_2d, dyn_phy), 2, nsoilmx), 3, nbsrf) solsw = 165. sollw = -53. t_ancien = 273.15 q_ancien = 0. agesno = 0. - !IM "slab" ocean - 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_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) - CALL histclo + nday = 0 + itau_phy = 0 ! side effect + call phyredem0 + + call nf95_inq_varid(ncid_restartphy, "trs", varid) + call nf95_put_var(ncid_restartphy, varid, null_array) + + call phyredem(pctsrf, tsoil(:, 1, :), tsoil, qsolsrf, & + pack(qsol_2d, dyn_phy), snsrf, albe, evap, null_array, null_array, & + solsw, sollw, null_array, null_array, frugs, agesno, zmea, zstd, & + zsig, zgam, zthe, zpic, zval, t_ancien, q_ancien, rnebcon, ratqs, & + clwcon, null_array, sig1, w01) END SUBROUTINE etat0