MODULE limmp !!====================================================================== !! *** MODULE limmp *** !! Melt ponds !!====================================================================== !! history : ! Original code by Daniela Flocco and Adrian Turner !! 1.0 ! 2012 (O. Lecomte) Adaptation for scientific tests (NEMO3.1) !! 2.0 ! 2016 (O. Lecomte, C. Rousset, M. Vancoppenolle) Implementation in NEMO3.6 !!---------------------------------------------------------------------- #if defined key_lim3 !!---------------------------------------------------------------------- !! 'key_lim3' : LIM3 sea-ice model !!---------------------------------------------------------------------- !! lim_mp_init : some initialization and namelist read !! lim_mp : main calling routine !! lim_mp_topo : main melt pond routine for the "topographic" formulation (FloccoFeltham) !! lim_mp_area : ??? compute melt pond fraction per category !! lim_mp_perm : computes permeability (should be a FUNCTION!) !! calc_hpond : computes melt pond depth !! permeability_phy : computes permeability !!---------------------------------------------------------------------- USE phycst ! physical constants USE dom_oce ! ocean space and time domain ! USE sbc_ice ! Surface boundary condition: ice fields USE ice ! LIM-3 variables USE lbclnk ! lateral boundary conditions - MPP exchanges USE lib_mpp ! MPP library USE wrk_nemo ! work arrays USE in_out_manager ! I/O manager USE lib_fortran ! glob_sum USE timing ! Timing ! USE limcons ! conservation tests ! USE limctl ! control prints ! USE limvar !OLI_CODE USE ice_oce, ONLY: rdt_ice, tatm_ice !OLI_CODE USE phycst !OLI_CODE USE dom_ice !OLI_CODE USE dom_oce !OLI_CODE USE sbc_oce !OLI_CODE USE sbc_ice !OLI_CODE USE par_ice !OLI_CODE USE par_oce !OLI_CODE USE ice !OLI_CODE USE thd_ice !OLI_CODE USE in_out_manager !OLI_CODE USE lbclnk !OLI_CODE USE lib_mpp !OLI_CODE !OLI_CODE IMPLICIT NONE !OLI_CODE PRIVATE !OLI_CODE !OLI_CODE PUBLIC lim_mp_init !OLI_CODE PUBLIC lim_mp IMPLICIT NONE PRIVATE PUBLIC lim_mp_init ! routine called by sbcice_lim.F90 PUBLIC lim_mp ! routine called by sbcice_lim.F90 !! * Substitutions # include "vectopt_loop_substitute.h90" !!---------------------------------------------------------------------- !! NEMO/LIM3 4.0 , UCL - NEMO Consortium (2011) !! $Id: limdyn.F90 6994 2016-10-05 13:07:10Z clem $ !! Software governed by the CeCILL licence (NEMOGCM/NEMO_CeCILL.txt) !!---------------------------------------------------------------------- CONTAINS SUBROUTINE lim_mp_init !!------------------------------------------------------------------- !! *** ROUTINE lim_mp_init *** !! !! ** Purpose : Physical constants and parameters linked to melt ponds !! over sea ice !! !! ** Method : Read the namicemp namelist and check the melt pond !! parameter values called at the first timestep (nit000) !! !! ** input : Namelist namicemp !!------------------------------------------------------------------- INTEGER :: ios ! Local integer output status for namelist read NAMELIST/namicemp/ ln_limMP, nn_limMP !!------------------------------------------------------------------- REWIND( numnam_ice_ref ) ! Namelist namicemp in reference namelist : Melt Ponds READ ( numnam_ice_ref, namicemp, IOSTAT = ios, ERR = 901) 901 IF( ios /= 0 ) CALL ctl_nam ( ios , 'namicemp in reference namelist', lwp ) REWIND( numnam_ice_cfg ) ! Namelist namicemp in configuration namelist : Melt Ponds READ ( numnam_ice_cfg, namicemp, IOSTAT = ios, ERR = 902 ) 902 IF( ios /= 0 ) CALL ctl_nam ( ios , 'namicemp in configuration namelist', lwp ) IF(lwm) WRITE ( numoni, namicemp ) IF(lwp) THEN ! control print WRITE(numout,*) WRITE(numout,*) 'lim_mp_init : ice parameters for melt ponds' WRITE(numout,*) '~~~~~~~~~~~~' WRITE(numout,*)' Activate melt ponds ln_limMP = ', ln_limMP WRITE(numout,*)' Type of melt pond implementation (1=all,2=rad, 3=fw, 4=no) nn_limMP = ', nn_limMP ENDIF ! END SUBROUTINE lim_mp_init SUBROUTINE lim_mp( kt ) !!------------------------------------------------------------------- !! *** ROUTINE lim_mp *** !! !! ** Purpose : change melt pond fraction !! !! ** Method : brutal force !! !! ** Action : - !! - !!------------------------------------------------------------------------------------ INTEGER, INTENT(in) :: kt ! number of iteration INTEGER :: ji, jj, jl ! dummy loop indices ! REAL(wp), POINTER, DIMENSION(:,:) :: zfsurf ! surface heat flux(obsolete, should be droped) ! !!------------------------------------------------------------------- IF( nn_timing == 1 ) CALL timing_start('limthd') IF( nn_timing == 1 ) CALL timing_start('lim_mp') CALL lim_mp_topo (at_i, a_i, & & vt_i, v_i, v_s, t_i, s_i, a_ip_frac, & & h_ip, t_su) ! we should probably not aggregate here since we do it in lim_var_agg ! before output, unless we need the total volume and faction else where ! we should also make sure a_ip and v_ip are properly updated at the end ! of the routine END SUBROUTINE lim_mp SUBROUTINE lim_mp_topo (aice, aicen, & vice, vicen, & vsnon, & ticen, salin, & a_ip_frac, h_ip, & Tsfc ) !!------------------------------------------------------------------- !! *** ROUTINE lim_mp_topo *** !! !! ** Purpose : Compute melt pond evolution based on the ice !! topography as inferred from the ice thickness !! distribution. !! !! ** Method : This code is initially based on Flocco and Feltham !! (2007) and Flocco et al. (2010). More to come... !! !! ** Tunable parameters : !! !! ** Note : !! !! ** References !! Flocco, D. and D. L. Feltham, 2007. A continuum model of melt pond !! evolution on Arctic sea ice. J. Geophys. Res. 112, C08016, doi: !! 10.1029/2006JC003836. !! Flocco, D., D. L. Feltham and A. K. Turner, 2010. Incorporation of !! a physically based melt pond scheme into the sea ice component of a !! climate model. J. Geophys. Res. 115, C08012, !! doi: 10.1029/2009JC005568. !! !!------------------------------------------------------------------- REAL (wp), DIMENSION (jpi,jpj), & INTENT(IN) :: & aice, & ! total ice area fraction vice ! total ice volume (m) REAL (wp), DIMENSION (jpi,jpj,jpl), & INTENT(IN) :: & aicen, & ! ice area fraction, per category vsnon, & ! snow volume, per category (m) vicen ! ice volume, per category (m) REAL (wp), DIMENSION (jpi,jpj,nlay_i,jpl), & INTENT(IN) :: & ticen, & ! ice enthalpy, per category salin REAL (wp), DIMENSION (jpi,jpj,jpl), & INTENT(INOUT) :: & a_ip_frac , & ! pond area fraction of ice, per ice category h_ip ! pond depth, per ice category (m) REAL (wp), DIMENSION (jpi,jpj,jpl), & INTENT(IN) :: & Tsfc ! snow/sea ice surface temperature ! local variables REAL (wp), DIMENSION (jpi,jpj,jpl) :: & zTsfcn, & ! ice/snow surface temperature (C) zvolpn, & ! pond volume per unit area, per category (m) zvuin ! water-equivalent volume of ice lid on melt pond ('upper ice', m) REAL (wp), DIMENSION (jpi,jpj,jpl) :: & zapondn,& ! pond area fraction, per category zhpondn ! pond depth, per category (m) REAL (wp), DIMENSION (jpi,jpj) :: & zvolp ! total volume of pond, per unit area of pond (m) REAL (wp) :: & zhi, & ! ice thickness (m) zdHui, & ! change in thickness of ice lid (m) zomega, & ! conduction zdTice, & ! temperature difference across ice lid (C) zdvice, & ! change in ice volume (m) zTavg, & ! mean surface temperature across categories (C) zTp, & ! pond freezing temperature (C) zdvn ! change in melt pond volume for fresh water budget INTEGER, DIMENSION (jpi*jpj) :: & indxi, indxj ! compressed indices for cells with ice melting INTEGER :: n,k,i,j,ij,icells,indxij ! loop indices INTEGER, DIMENSION (jpl) :: & kcells ! cells where ice lid combines with vice INTEGER, DIMENSION (jpi*jpj,jpl) :: & indxii, indxjj ! i,j indices for kcells loop REAL (wp), parameter :: & zhicemin = 0.1_wp , & ! minimum ice thickness with ponds (m) zTd = 0.15_wp, & ! temperature difference for freeze-up (C) zr1_rlfus = 1._wp / 0.334e+6 / 917._wp , & ! (J/m^3) zmin_volp = 1.e-4_wp, & ! minimum pond volume (m) z0 = 0._wp, & zTimelt = 0._wp, & z01 = 0.01_wp, & z25 = 0.25_wp, & z5 = 0.5_wp !--------------------------------------------------------------- ! Initialization !--------------------------------------------------------------- zhpondn(:,:,:) = 0._wp zapondn(:,:,:) = 0._wp indxii(:,:) = 0 indxjj(:,:) = 0 kcells(:) = 0 zvolp(:,:) = wfx_sum(:,:) + wfx_snw(:,:) + vt_ip(:,:) ! Total available melt water, to be distributed as melt ponds zTsfcn(:,:,:) = zTsfcn(:,:,:) - rt0 ! Convert in Celsius ! The freezing temperature for meltponds is assumed slightly below 0C, ! as if meltponds had a little salt in them. The salt budget is not ! altered for meltponds, but if it were then an actual pond freezing ! temperature could be computed. ! zTp = zTimelt - zTd ---> for lids !----------------------------------------------------------------- ! Identify grid cells with ponds !----------------------------------------------------------------- icells = 0 DO j = 1, jpj DO i = 1, jpi zhi = z0 IF (aice(i,j) > epsi10 ) zhi = vice(i,j)/aice(i,j) IF ( aice(i,j) > z01 .and. zhi > zhicemin .and. & zvolp(i,j) > zmin_volp*aice(i,j)) THEN icells = icells + 1 indxi(icells) = i indxj(icells) = j ELSE ! remove ponds on thin ice !fpond(i,j) = fpond(i,j) - zvolp(i,j) zvolpn(i,j,:) = z0 zvuin (i,j,:) = z0 zvolp (i,j) = z0 END IF END DO ! i END DO ! j DO ij = 1, icells i = indxi(ij) j = indxj(ij) !-------------------------------------------------------------- ! calculate pond area and depth !-------------------------------------------------------------- CALL lim_mp_area(aice(i,j),vice(i,j), & aicen(i,j,:), vicen(i,j,:), vsnon(i,j,:), & ticen(i,j,:,:), salin(i,j,:,:), & zvolpn(i,j,:), zvolp(i,j), & zapondn(i,j,:),zhpondn(i,j,:), zdvn) ! outputs are ! - zdvn ! - zvolpn ! - zvolp ! - zapondn ! - zhpondn wfx_pnd(i,j) = wfx_pnd(i,j) + zdvn ! update flux from ponds to ocean ! mean surface temperature zTavg = z0 DO n = 1, jpl zTavg = zTavg + zTsfcn(i,j,n)*aicen(i,j,n) END DO zTavg = zTavg / aice(i,j) END DO ! ij !--------------------------------------------------------------- ! Update pond volume and fraction !--------------------------------------------------------------- a_ip(:,:,:) = zapondn(:,:,:) v_ip(:,:,:) = zapondn(:,:,:) * zhpondn(:,:,:) a_ip_frac(:,:,:) = 0._wp h_ip (:,:,:) = 0._wp END SUBROUTINE lim_mp_topo SUBROUTINE lim_mp_area(aice,vice, & aicen, vicen, vsnon, ticen, & salin, zvolpn, zvolp, & zapondn,zhpondn,dvolp) !!------------------------------------------------------------------- !! *** ROUTINE lim_mp_area *** !! !! ** Purpose : Given the total volume of meltwater, update !! pond fraction (a_ip) and depth (should be volume) !! !! ** !! !!------------------------------------------------------------------ REAL (wp), INTENT(IN) :: & aice,vice REAL (wp), DIMENSION(jpl), INTENT(IN) :: & aicen, vicen, vsnon REAL (wp), DIMENSION(nlay_i,jpl), INTENT(IN) :: & ticen, salin REAL (wp), DIMENSION(jpl), INTENT(INOUT) :: & zvolpn REAL (wp), INTENT(INOUT) :: & zvolp, dvolp REAL (wp), DIMENSION(jpl), INTENT(OUT) :: & zapondn, zhpondn INTEGER :: & n, ns, & m_index, & permflag REAL (wp), DIMENSION(jpl) :: & hicen, & hsnon, & asnon, & alfan, & betan, & cum_max_vol, & reduced_aicen REAL (wp), DIMENSION(0:jpl) :: & cum_max_vol_tmp REAL (wp) :: & hpond, & drain, & floe_weight, & pressure_head, & hsl_rel, & deltah, & perm, & msno REAL (wp), parameter :: & viscosity = 1.79e-3_wp, & ! kinematic water viscosity in kg/m/s z0 = 0.0_wp , & c1 = 1.0_wp , & p4 = 0.4_wp , & p6 = 0.6_wp , & epsi10 = 1.0e-11_wp !-----------| ! | ! |-----------| !___________|___________|______________________________________sea-level ! | | ! | |---^--------| ! | | | | ! | | | |-----------| |------- ! | | |alfan(n)| | | ! | | | | |--------------| ! | | | | | | !---------------------------v------------------------------------------- ! | | ^ | | | ! | | | | |--------------| ! | | |betan(n)| | | ! | | | |-----------| |------- ! | | | | ! | |---v------- | ! | | ! |-----------| ! | !-----------| !------------------------------------------------------------------- ! initialize !------------------------------------------------------------------- DO n = 1, jpl zapondn(n) = z0 zhpondn(n) = z0 !---------------------------------------- ! X) compute the effective snow fraction !---------------------------------------- IF (aicen(n) < epsi10) THEN hicen(n) = z0 hsnon(n) = z0 reduced_aicen(n) = z0 ELSE hicen(n) = vicen(n) / aicen(n) hsnon(n) = vsnon(n) / aicen(n) reduced_aicen(n) = c1 ! n=jpl IF (n < jpl) reduced_aicen(n) = aicen(n) & * (-0.024_wp*hicen(n) + 0.832_wp) asnon(n) = reduced_aicen(n) ! effective snow fraction (empirical) END IF ! This choice for alfa and beta ignores hydrostatic equilibium of categories. ! Hydrostatic equilibium of the entire ITD is accounted for below, assuming ! a surface topography implied by alfa=0.6 and beta=0.4, and rigidity across all ! categories. alfa and beta partition the ITD - they are areas not thicknesses! ! Multiplying by hicen, alfan and betan (below) are thus volumes per unit area. ! Here, alfa = 60% of the ice area (and since hice is constant in a category, ! alfan = 60% of the ice volume) in each category lies above the reference line, ! and 40% below. Note: p6 is an arbitrary choice, but alfa+beta=1 is required. alfan(n) = p6 * hicen(n) betan(n) = p4 * hicen(n) cum_max_vol(n) = z0 cum_max_vol_tmp(n) = z0 END DO ! jpl cum_max_vol_tmp(0) = z0 drain = z0 dvolp = z0 !---------------------------------------------------------- ! x) Drain overflow water, update pond fraction and volume !---------------------------------------------------------- !-------------------------------------------------------------------------- ! the maximum amount of water that can be contained up to each ice category !-------------------------------------------------------------------------- ! MV ! If melt ponds are too deep to be sustainable given the ITD (OVERFLOW) ! Then the excess volume cum_max_vol(jl) drains out of the system ! It should be added to wfx_pnd ! END MV DO n = 1, jpl-1 ! last category can not hold any volume IF (alfan(n+1) >= alfan(n) .and. alfan(n+1) > z0) THEN ! total volume in level including snow cum_max_vol_tmp(n) = cum_max_vol_tmp(n-1) + & (alfan(n+1) - alfan(n)) * sum(reduced_aicen(1:n)) ! subtract snow solid volumes from lower categories in current level DO ns = 1, n cum_max_vol_tmp(n) = cum_max_vol_tmp(n) & - rhosn/rhofw * & ! free air fraction that can be filled by water asnon(ns) * & ! effective areal fraction of snow in that category max(min(hsnon(ns)+alfan(ns)-alfan(n), alfan(n+1)- & alfan(n)), z0) END DO ELSE ! assume higher categories unoccupied cum_max_vol_tmp(n) = cum_max_vol_tmp(n-1) END IF !IF (cum_max_vol_tmp(n) < z0) THEN ! call abort_ice('negative melt pond volume') !END IF END DO cum_max_vol_tmp(jpl) = cum_max_vol_tmp(jpl-1) ! last category holds no volume cum_max_vol (1:jpl) = cum_max_vol_tmp(1:jpl) !---------------------------------------------------------------- ! is there more meltwater than can be held in the floe? !---------------------------------------------------------------- IF (zvolp >= cum_max_vol(jpl)) THEN drain = zvolp - cum_max_vol(jpl) + epsi10 zvolp = zvolp - drain ! update meltwater volume available dvolp = drain ! this is the drained water IF (zvolp < epsi10) THEN dvolp = dvolp + zvolp zvolp = z0 END IF END IF ! height and area corresponding to the remaining volume ! call calc_hpond(reduced_aicen, asnon, hsnon, rhos, alfan, & ! zvolp, cum_max_vol, hpond, m_index) DO n=1, m_index zhpondn(n) = hpond - alfan(n) + alfan(1) ! here oui choulde update ! volume instead, no ? zapondn(n) = reduced_aicen(n) ! in practise, pond fraction depends on the empirical snow fraction ! so in turn on ice thickness END DO !------------------------------------------------------------------------ ! Drainage through brine network (permeability) !------------------------------------------------------------------------ !!! drainage due to ice permeability - Darcy's law ! sea water level msno = z0 DO n=1,jpl msno = msno + vsnon(n) * rhosn END DO floe_weight = (msno + rhoic*vice + rau0*zvolp) / aice hsl_rel = floe_weight / rau0 & - ((sum(betan(:)*aicen(:))/aice) + alfan(1)) deltah = hpond - hsl_rel pressure_head = grav * rau0 * max(deltah, z0) ! drain IF ice is permeable permflag = 0 IF (pressure_head > z0) THEN DO n = 1, jpl-1 IF (hicen(n) /= z0) THEN perm = 0. ! MV ugly dummy patch CALL lim_mp_perm(ticen(:,n), salin(:,n), vicen(n), perm) IF (perm > z0) permflag = 1 drain = perm*zapondn(n)*pressure_head*rdt_ice / & (viscosity*hicen(n)) dvolp = dvolp + min(drain, zvolp) zvolp = max(zvolp - drain, z0) IF (zvolp < epsi10) THEN dvolp = dvolp + zvolp zvolp = z0 END IF END IF END DO ! adjust melt pond DIMENSIONs IF (permflag > 0) THEN ! recompute pond depth ! CALL calc_hpond(reduced_aicen, asnon, hsnon, rhos, alfan, & ! zvolp, cum_max_vol, hpond, m_index) DO n=1, m_index zhpondn(n) = hpond - alfan(n) + alfan(1) zapondn(n) = reduced_aicen(n) END DO END IF END IF ! pressure_head !------------------------------- ! X) remove water from the snow !------------------------------- !------------------------------------------------------------------------ ! total melt pond volume in category DOes not include snow volume ! snow in melt ponds is not melted !------------------------------------------------------------------------ ! Calculate pond volume for lower categories DO n=1,m_index-1 zvolpn(n) = zapondn(n) * zhpondn(n) & ! what is not in the snow - (rhosn/rhofw) * asnon(n) * min(hsnon(n), zhpondn(n)) END DO ! Calculate pond volume for highest category = remaining pond volume ! The following is completely unclear to Martin at least ! Could we redefine properly and recode in a more readable way ? ! m_index = last category with melt pond IF (m_index == 1) zvolpn(m_index) = zvolp ! volume of mw in 1st category is the total volume of melt water IF (m_index > 1) THEN IF (zvolp > sum(zvolpn(1:m_index-1))) THEN zvolpn(m_index) = zvolp - sum(zvolpn(1:m_index-1)) ! ELSE zvolpn(m_index) = z0 zhpondn(m_index) = z0 zapondn(m_index) = z0 ! If remaining pond volume is negative reduce pond volume of ! lower category IF (zvolp+epsi10 < sum(zvolpn(1:m_index-1))) & zvolpn(m_index-1) = zvolpn(m_index-1)-sum(zvolpn(1:m_index-1))& + zvolp END IF END IF DO n=1,m_index IF (zapondn(n) > epsi10) THEN zhpondn(n) = zvolpn(n) / zapondn(n) ELSE dvolp = dvolp + zvolpn(n) zhpondn(n) = z0 zvolpn(n) = z0 zapondn(n) = z0 end IF END DO DO n = m_index+1, jpl zhpondn(n) = z0 zapondn(n) = z0 zvolpn (n) = z0 END DO END SUBROUTINE lim_mp_area !OLI_CODE !OLI_CODE !OLI_CODE SUBROUTINE calc_hpond(aicen, asnon, hsnon, rhos, alfan, & !OLI_CODE zvolp, cum_max_vol, & !OLI_CODE hpond, m_index) !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE !! *** ROUTINE calc_hpond *** !OLI_CODE !! !OLI_CODE !! ** Purpose : Compute melt pond depth !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE !OLI_CODE REAL (wp), DIMENSION(jpl), INTENT(IN) :: & !OLI_CODE aicen, & !OLI_CODE asnon, & !OLI_CODE hsnon, & !OLI_CODE rhos, & !OLI_CODE alfan, & !OLI_CODE cum_max_vol !OLI_CODE !OLI_CODE REAL (wp), INTENT(IN) :: & !OLI_CODE zvolp !OLI_CODE !OLI_CODE REAL (wp), INTENT(OUT) :: & !OLI_CODE hpond !OLI_CODE !OLI_CODE INTEGER, INTENT(OUT) :: & !OLI_CODE m_index !OLI_CODE !OLI_CODE INTEGER :: n, ns !OLI_CODE !OLI_CODE REAL (wp), DIMENSION(0:jpl+1) :: & !OLI_CODE hitl, & !OLI_CODE aicetl !OLI_CODE !OLI_CODE REAL (wp) :: & !OLI_CODE rem_vol, & !OLI_CODE area, & !OLI_CODE vol, & !OLI_CODE tmp, & !OLI_CODE z0 = 0.0_wp, & !OLI_CODE epsi10 = 1.0e-11_wp !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! hpond is zero if zvolp is zero - have we fully drained? !OLI_CODE !---------------------------------------------------------------- !OLI_CODE !OLI_CODE IF (zvolp < epsi10) THEN !OLI_CODE hpond = z0 !OLI_CODE m_index = 0 !OLI_CODE ELSE !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! Calculate the category where water fills up to !OLI_CODE !---------------------------------------------------------------- !OLI_CODE !OLI_CODE !----------| !OLI_CODE ! | !OLI_CODE ! | !OLI_CODE ! |----------| -- -- !OLI_CODE !__________|__________|_________________________________________ ^ !OLI_CODE ! | | rem_vol ^ | Semi-filled !OLI_CODE ! | |----------|-- -- -- - ---|-- ---- -- -- --v layer !OLI_CODE ! | | | | !OLI_CODE ! | | | |hpond !OLI_CODE ! | | |----------| | |------- !OLI_CODE ! | | | | | | !OLI_CODE ! | | | |---v-----| !OLI_CODE ! | | m_index | | | !OLI_CODE !------------------------------------------------------------- !OLI_CODE !OLI_CODE m_index = 0 ! 1:m_index categories have water in them !OLI_CODE DO n = 1, jpl !OLI_CODE IF (zvolp <= cum_max_vol(n)) THEN !OLI_CODE m_index = n !OLI_CODE IF (n == 1) THEN !OLI_CODE rem_vol = zvolp !OLI_CODE ELSE !OLI_CODE rem_vol = zvolp - cum_max_vol(n-1) !OLI_CODE END IF !OLI_CODE exit ! to break out of the loop !OLI_CODE END IF !OLI_CODE END DO !OLI_CODE m_index = min(jpl-1, m_index) !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! semi-filled layer may have m_index different snow in it !OLI_CODE !---------------------------------------------------------------- !OLI_CODE !OLI_CODE !----------------------------------------------------------- ^ !OLI_CODE ! | alfan(m_index+1) !OLI_CODE ! | !OLI_CODE !hitl(3)--> |----------| | !OLI_CODE !hitl(2)--> |------------| * * * * *| | !OLI_CODE !hitl(1)--> |----------|* * * * * * |* * * * * | | !OLI_CODE !hitl(0)-->------------------------------------------------- | ^ !OLI_CODE ! various snow from lower categories | |alfa(m_index) !OLI_CODE !OLI_CODE ! hitl - heights of the snow layers from thinner and current categories !OLI_CODE ! aicetl - area of each snow depth in this layer !OLI_CODE !OLI_CODE hitl(:) = z0 !OLI_CODE aicetl(:) = z0 !OLI_CODE DO n = 1, m_index !OLI_CODE hitl(n) = max(min(hsnon(n) + alfan(n) - alfan(m_index), & !OLI_CODE alfan(m_index+1) - alfan(m_index)), z0) !OLI_CODE aicetl(n) = asnon(n) !OLI_CODE !OLI_CODE aicetl(0) = aicetl(0) + (aicen(n) - asnon(n)) !OLI_CODE END DO !OLI_CODE hitl(m_index+1) = alfan(m_index+1) - alfan(m_index) !OLI_CODE aicetl(m_index+1) = z0 !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! reorder array according to hitl !OLI_CODE ! snow heights not necessarily in height order !OLI_CODE !---------------------------------------------------------------- !OLI_CODE !OLI_CODE DO ns = 1, m_index+1 !OLI_CODE DO n = 0, m_index - ns + 1 !OLI_CODE IF (hitl(n) > hitl(n+1)) THEN ! swap order !OLI_CODE tmp = hitl(n) !OLI_CODE hitl(n) = hitl(n+1) !OLI_CODE hitl(n+1) = tmp !OLI_CODE tmp = aicetl(n) !OLI_CODE aicetl(n) = aicetl(n+1) !OLI_CODE aicetl(n+1) = tmp !OLI_CODE END IF !OLI_CODE END DO !OLI_CODE END DO !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! divide semi-filled layer into set of sublayers each vertically homogenous !OLI_CODE !---------------------------------------------------------------- !OLI_CODE !OLI_CODE !hitl(3)---------------------------------------------------------------- !OLI_CODE ! | * * * * * * * * !OLI_CODE ! |* * * * * * * * * !OLI_CODE !hitl(2)---------------------------------------------------------------- !OLI_CODE ! | * * * * * * * * | * * * * * * * * !OLI_CODE ! |* * * * * * * * * |* * * * * * * * * !OLI_CODE !hitl(1)---------------------------------------------------------------- !OLI_CODE ! | * * * * * * * * | * * * * * * * * | * * * * * * * * !OLI_CODE ! |* * * * * * * * * |* * * * * * * * * |* * * * * * * * * !OLI_CODE !hitl(0)---------------------------------------------------------------- !OLI_CODE ! aicetl(0) aicetl(1) aicetl(2) aicetl(3) !OLI_CODE !OLI_CODE ! move up over layers incrementing volume !OLI_CODE DO n = 1, m_index+1 !OLI_CODE !OLI_CODE area = sum(aicetl(:)) - & ! total area of sub-layer !OLI_CODE (rhos(n)/rau0) * sum(aicetl(n:jpl+1)) ! area of sub-layer occupied by snow !OLI_CODE !OLI_CODE vol = (hitl(n) - hitl(n-1)) * area ! thickness of sub-layer times area !OLI_CODE !OLI_CODE IF (vol >= rem_vol) THEN ! have reached the sub-layer with the depth within !OLI_CODE hpond = rem_vol / area + hitl(n-1) + alfan(m_index) - & !OLI_CODE alfan(1) !OLI_CODE exit !OLI_CODE ELSE ! still in sub-layer below the sub-layer with the depth !OLI_CODE rem_vol = rem_vol - vol !OLI_CODE END IF !OLI_CODE !OLI_CODE END DO !OLI_CODE !OLI_CODE END IF !OLI_CODE !OLI_CODE END SUBROUTINE calc_hpond !OLI_CODE !OLI_CODE SUBROUTINE lim_mp_perm(ticen, salin, vicen, perm) !!------------------------------------------------------------------- !! *** ROUTINE lim_mp_perm *** !! !! ** Purpose : Determine the liquid fraction of brine in the ice !! and its permeability !!------------------------------------------------------------------- REAL (wp), DIMENSION(nlay_i), INTENT(IN) :: & ticen, & ! energy of melting for each ice layer (J/m2) salin REAL (wp), INTENT(IN) :: & vicen ! ice volume REAL (wp), INTENT(OUT) :: & perm ! permeability REAL (wp) :: & Sbr ! brine salinity REAL (wp), DIMENSION(nlay_i) :: & Tin, & ! ice temperature phi ! liquid fraction INTEGER :: k REAL (wp) :: & c2 = 2.0_wp !----------------------------------------------------------------- ! Compute ice temperatures from enthalpies using quadratic formula !----------------------------------------------------------------- DO k = 1,nlay_i Tin(k) = ticen(k) END DO !----------------------------------------------------------------- ! brine salinity and liquid fraction !----------------------------------------------------------------- IF (maxval(Tin-rtt) <= -c2) THEN DO k = 1,nlay_i Sbr = - 1.2_wp & -21.8_wp * (Tin(k)-rtt) & - 0.919_wp * (Tin(k)-rtt)**2 & - 0.01878_wp * (Tin(k)-rtt)**3 phi(k) = salin(k)/Sbr ! liquid fraction END DO ! k ELSE DO k = 1,nlay_i Sbr = -17.6_wp * (Tin(k)-rtt) & - 0.389_wp * (Tin(k)-rtt)**2 & - 0.00362_wp* (Tin(k)-rtt)**3 phi(k) = salin(k)/Sbr ! liquid fraction END DO END IF !----------------------------------------------------------------- ! permeability !----------------------------------------------------------------- perm = 3.0e-08_wp * (minval(phi))**3 ! REFERENCE PLEASE (this fucking ! bastard of Golden) END SUBROUTINE lim_mp_perm !OLI_CODE !OLI_CODE #else !OLI_CODE !!---------------------------------------------------------------------- !OLI_CODE !! Default option Dummy Module No LIM-3 sea-ice model !OLI_CODE !!---------------------------------------------------------------------- !OLI_CODE CONTAINS !OLI_CODE SUBROUTINE lim_mp_init ! Empty routine !OLI_CODE END SUBROUTINE lim_mp_init !OLI_CODE SUBROUTINE lim_mp ! Empty routine !OLI_CODE END SUBROUTINE lim_mp !OLI_CODE SUBROUTINE compute_mp_topo ! Empty routine !OLI_CODE END SUBROUTINE compute_mp_topo !OLI_CODE SUBROUTINE pond_area ! Empty routine !OLI_CODE END SUBROUTINE pond_area !OLI_CODE SUBROUTINE calc_hpond ! Empty routine !OLI_CODE END SUBROUTINE calc_hpond !OLI_CODE SUBROUTINE permeability_phy ! Empty routine !OLI_CODE END SUBROUTINE permeability_phy !OLI_CODE #endif !OLI_CODE !!====================================================================== !OLI_CODE END MODULE limmp_topo !OLI_CODE MODULE limmp_topo !OLI_CODE !!====================================================================== !OLI_CODE !! *** MODULE limmp_topo *** !OLI_CODE !! LIM-3 sea-ice : computation of melt ponds' properties !OLI_CODE !!====================================================================== !OLI_CODE !! History : Original code by Daniela Flocco and Adrian Turner !OLI_CODE !! ! 2012-09 (O. Lecomte) Adaptation for routine inclusion in !OLI_CODE !! NEMO-LIM3.1 !OLI_CODE !! ! 2016-11 (O. Lecomte, C. Rousset, M. Vancoppenolle) !OLI_CODE !! Adaptation for merge with NEMO-LIM3.6 !OLI_CODE !!---------------------------------------------------------------------- !OLI_CODE #if defined key_lim3 !OLI_CODE !!---------------------------------------------------------------------- !OLI_CODE !! 'key_lim3' LIM-3 sea-ice model !OLI_CODE !!---------------------------------------------------------------------- !OLI_CODE !! lim_mp_init : melt pond properties initialization !OLI_CODE !! lim_mp : melt pond routine caller !OLI_CODE !! compute_mp_topo : Actual melt pond routine !OLI_CODE !!---------------------------------------------------------------------- !OLI_CODE USE ice_oce, ONLY: rdt_ice, tatm_ice !OLI_CODE USE phycst !OLI_CODE USE dom_ice !OLI_CODE USE dom_oce !OLI_CODE USE sbc_oce !OLI_CODE USE sbc_ice !OLI_CODE USE par_ice !OLI_CODE USE par_oce !OLI_CODE USE ice !OLI_CODE USE thd_ice !OLI_CODE USE in_out_manager !OLI_CODE USE lbclnk !OLI_CODE USE lib_mpp !OLI_CODE !OLI_CODE IMPLICIT NONE !OLI_CODE PRIVATE !OLI_CODE !OLI_CODE PUBLIC lim_mp_init !OLI_CODE PUBLIC lim_mp !OLI_CODE !OLI_CODE CONTAINS !OLI_CODE !OLI_CODE SUBROUTINE lim_mp_init !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE !! *** ROUTINE lim_mp_init *** !OLI_CODE !! !OLI_CODE !! ** Purpose : Initialize melt ponds !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE a_ip_frac(:,:,:) = 0._wp !OLI_CODE a_ip(:,:,:) = 0._wp !OLI_CODE h_ip(:,:,:) = 0._wp !OLI_CODE v_ip(:,:,:) = 0._wp !OLI_CODE h_il(:,:,:) = 0._wp !OLI_CODE v_il(:,:,:) = 0._wp !OLI_CODE !OLI_CODE END SUBROUTINE lim_mp_init !OLI_CODE !OLI_CODE !OLI_CODE SUBROUTINE lim_mp !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE !! *** ROUTINE lim_mp *** !OLI_CODE !! !OLI_CODE !! ** Purpose : Compute surface heat flux and call main melt pond !OLI_CODE !! routine !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE !OLI_CODE INTEGER :: ji, jj, jl ! dummy loop indices !OLI_CODE !OLI_CODE fsurf(:,:) = 0.e0 !OLI_CODE DO jl = 1, jpl !OLI_CODE DO jj = 1, jpj !OLI_CODE DO ji = 1, jpi !OLI_CODE fsurf(ji,jj) = fsurf(ji,jj) + a_i(ji,jj,jl) * & !OLI_CODE (qns_ice(ji,jj,jl) + (1.0 - izero(ji,jj,jl)) & !OLI_CODE * qsr_ice(ji,jj,jl)) !OLI_CODE END DO !OLI_CODE END DO !OLI_CODE END DO !OLI_CODE !OLI_CODE CALL compute_mp_topo(at_i, a_i, & !OLI_CODE vt_i, v_i, v_s, rhosn_glo, t_i, s_i, a_ip_frac, & !OLI_CODE h_ip, h_il, t_su, tatm_ice, diag_sur_me*rdt_ice, & !OLI_CODE fsurf, fwoc) !OLI_CODE !OLI_CODE at_ip(:,:) = 0.0 !OLI_CODE vt_ip(:,:) = 0.0 !OLI_CODE vt_il(:,:) = 0.0 !OLI_CODE DO jl = 1, jpl !OLI_CODE DO jj = 1, jpj !OLI_CODE DO ji = 1, jpi !OLI_CODE a_ip(ji,jj,jl) = MAX(0.0_wp, a_ip_frac(ji,jj,jl) * & !OLI_CODE a_i(ji,jj,jl)) !OLI_CODE v_ip(ji,jj,jl) = MAX(0.0_wp, a_ip_frac(ji,jj,jl) * & !OLI_CODE a_i(ji,jj,jl) * h_ip(ji,jj,jl)) !OLI_CODE v_il(ji,jj,jl) = MAX(0.0_wp, a_ip_frac(ji,jj,jl) * & !OLI_CODE a_i(ji,jj,jl) * h_il(ji,jj,jl)) !OLI_CODE at_ip(ji,jj) = at_ip(ji,jj) + a_ip(ji,jj,jl) !OLI_CODE vt_ip(ji,jj) = vt_ip(ji,jj) + v_ip(ji,jj,jl) !OLI_CODE vt_il(ji,jj) = vt_il(ji,jj) + v_il(ji,jj,jl) !OLI_CODE END DO !OLI_CODE END DO !OLI_CODE END DO !OLI_CODE !OLI_CODE END SUBROUTINE lim_mp !OLI_CODE !OLI_CODE !OLI_CODE SUBROUTINE compute_mp_topo(aice, aicen, & !OLI_CODE vice, vicen, & !OLI_CODE vsnon, rhos, & !OLI_CODE ticen, salin, & !OLI_CODE a_ip_frac, h_ip, & !OLI_CODE h_il, Tsfc, & !OLI_CODE potT, meltt, & !OLI_CODE fsurf, fwoc) !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE !! *** ROUTINE compute_mp_topo *** !OLI_CODE !! !OLI_CODE !! ** Purpose : Compute melt pond evolution based on the ice !OLI_CODE !! topography as inferred from the ice thickness !OLI_CODE !! distribution. !OLI_CODE !! !OLI_CODE !! ** Method : This code is initially based on Flocco and Feltham !OLI_CODE !! (2007) and Flocco et al. (2010). More to come... !OLI_CODE !! !OLI_CODE !! ** Tunable parameters : !OLI_CODE !! !OLI_CODE !! ** Note : !OLI_CODE !! !OLI_CODE !! ** References !OLI_CODE !! Flocco, D. and D. L. Feltham, 2007. A continuum model of melt pond !OLI_CODE !! evolution on Arctic sea ice. J. Geophys. Res. 112, C08016, doi: !OLI_CODE !! 10.1029/2006JC003836. !OLI_CODE !! Flocco, D., D. L. Feltham and A. K. Turner, 2010. Incorporation of !OLI_CODE !! a physically based melt pond scheme into the sea ice component of a !OLI_CODE !! climate model. J. Geophys. Res. 115, C08012, !OLI_CODE !! doi: 10.1029/2009JC005568. !OLI_CODE !! !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE !OLI_CODE REAL (wp), DIMENSION (jpi,jpj), & !OLI_CODE INTENT(IN) :: & !OLI_CODE aice, & ! total ice area fraction !OLI_CODE vice ! total ice volume (m) !OLI_CODE !OLI_CODE REAL (wp), DIMENSION (jpi,jpj,jpl), & !OLI_CODE INTENT(IN) :: & !OLI_CODE aicen, & ! ice area fraction, per category !OLI_CODE vsnon, & ! snow volume, per category (m) !OLI_CODE rhos, & ! equivalent snow density, per category (kg/m^3) !OLI_CODE vicen ! ice volume, per category (m) !OLI_CODE !OLI_CODE REAL (wp), DIMENSION (jpi,jpj,nlay_i,jpl), & !OLI_CODE INTENT(IN) :: & !OLI_CODE ticen, & ! ice enthalpy, per category !OLI_CODE salin !OLI_CODE !OLI_CODE REAL (wp), DIMENSION (jpi,jpj,jpl), & !OLI_CODE INTENT(INOUT) :: & !OLI_CODE a_ip_frac , & ! pond area fraction of ice, per ice category !OLI_CODE h_ip , & ! pond depth, per ice category (m) !OLI_CODE h_il ! Refrozen ice lid thickness, per ice category (m) !OLI_CODE !OLI_CODE REAL (wp), DIMENSION (jpi,jpj), & !OLI_CODE INTENT(IN) :: & !OLI_CODE potT, & ! air potential temperature !OLI_CODE meltt, & ! total surface meltwater flux !OLI_CODE fsurf ! thermodynamic heat flux at ice/snow surface (W/m^2) !OLI_CODE !OLI_CODE REAL (wp), DIMENSION (jpi,jpj), & !OLI_CODE INTENT(INOUT) :: & !OLI_CODE fwoc ! fresh water flux to the ocean (from draining and other pond volume adjustments) !OLI_CODE ! (m) !OLI_CODE !OLI_CODE REAL (wp), DIMENSION (jpi,jpj,jpl), & !OLI_CODE INTENT(IN) :: & !OLI_CODE Tsfc ! snow/sea ice surface temperature !OLI_CODE !OLI_CODE ! local variables !OLI_CODE REAL (wp), DIMENSION (jpi,jpj,jpl) :: & !OLI_CODE zTsfcn, & ! ice/snow surface temperature (C) !OLI_CODE zvolpn, & ! pond volume per unit area, per category (m) !OLI_CODE zvuin ! water-equivalent volume of ice lid on melt pond ('upper ice', m) !OLI_CODE !OLI_CODE REAL (wp), DIMENSION (jpi,jpj,jpl) :: & !OLI_CODE zapondn,& ! pond area fraction, per category !OLI_CODE zhpondn ! pond depth, per category (m) !OLI_CODE !OLI_CODE REAL (wp), DIMENSION (jpi,jpj) :: & !OLI_CODE zvolp ! total volume of pond, per unit area of pond (m) !OLI_CODE !OLI_CODE REAL (wp) :: & !OLI_CODE zhi, & ! ice thickness (m) !OLI_CODE zdHui, & ! change in thickness of ice lid (m) !OLI_CODE zomega, & ! conduction !OLI_CODE zdTice, & ! temperature difference across ice lid (C) !OLI_CODE zdvice, & ! change in ice volume (m) !OLI_CODE zTavg, & ! mean surface temperature across categories (C) !OLI_CODE zTp, & ! pond freezing temperature (C) !OLI_CODE zdvn ! change in melt pond volume for fresh water budget !OLI_CODE INTEGER, DIMENSION (jpi*jpj) :: & !OLI_CODE indxi, indxj ! compressed indices for cells with ice melting !OLI_CODE !OLI_CODE INTEGER :: n,k,i,j,ij,icells,indxij ! loop indices !OLI_CODE !OLI_CODE INTEGER, DIMENSION (jpl) :: & !OLI_CODE kcells ! cells where ice lid combines with vice !OLI_CODE !OLI_CODE INTEGER, DIMENSION (jpi*jpj,jpl) :: & !OLI_CODE indxii, indxjj ! i,j indices for kcells loop !OLI_CODE !OLI_CODE REAL (wp), parameter :: & !OLI_CODE zhicemin = 0.1_wp , & ! minimum ice thickness with ponds (m) !OLI_CODE zTd = 0.15_wp, & ! temperature difference for freeze-up (C) !OLI_CODE zr1_rlfus = 1._wp / 0.334e+6 / 917._wp , & ! (J/m^3) !OLI_CODE zmin_volp = 1.e-4_wp, & ! minimum pond volume (m) !OLI_CODE z0 = 0._wp, & !OLI_CODE zTimelt = 0._wp, & !OLI_CODE z01 = 0.01_wp, & !OLI_CODE z25 = 0.25_wp, & !OLI_CODE z5 = 0.5_wp, & !OLI_CODE epsi10 = 1.0e-11_wp !OLI_CODE !--------------------------------------------------------------- !OLI_CODE ! initialize !OLI_CODE !--------------------------------------------------------------- !OLI_CODE !OLI_CODE DO j = 1, jpj !OLI_CODE DO i = 1, jpi !OLI_CODE zvolp(i,j) = z0 !OLI_CODE END DO !OLI_CODE END DO !OLI_CODE DO n = 1, jpl !OLI_CODE DO j = 1, jpj !OLI_CODE DO i = 1, jpi !OLI_CODE ! load tracers !OLI_CODE zvolp(i,j) = zvolp(i,j) + h_ip(i,j,n) & !OLI_CODE * a_ip_frac(i,j,n) * aicen(i,j,n) !OLI_CODE zTsfcn(i,j,n) = Tsfc(i,j,n) - rtt ! convert in Celsius - Oli !OLI_CODE zvuin (i,j,n) = h_il(i,j,n) & !OLI_CODE * a_ip_frac(i,j,n) * aicen(i,j,n) !OLI_CODE !OLI_CODE zhpondn(i,j,n) = z0 ! pond depth, per category !OLI_CODE zapondn(i,j,n) = z0 ! pond area, per category !OLI_CODE END DO !OLI_CODE END DO !OLI_CODE indxii(:,n) = 0 !OLI_CODE indxjj(:,n) = 0 !OLI_CODE kcells (n) = 0 !OLI_CODE END DO !OLI_CODE !OLI_CODE ! The freezing temperature for meltponds is assumed slightly below 0C, !OLI_CODE ! as if meltponds had a little salt in them. The salt budget is not !OLI_CODE ! altered for meltponds, but if it were then an actual pond freezing !OLI_CODE ! temperature could be computed. !OLI_CODE !OLI_CODE zTp = zTimelt - zTd !OLI_CODE !OLI_CODE !----------------------------------------------------------------- !OLI_CODE ! Identify grid cells with ponds !OLI_CODE !----------------------------------------------------------------- !OLI_CODE !OLI_CODE icells = 0 !OLI_CODE DO j = 1, jpj !OLI_CODE DO i = 1, jpi !OLI_CODE zhi = z0 !OLI_CODE IF (aice(i,j) > epsi10) zhi = vice(i,j)/aice(i,j) !OLI_CODE IF ( aice(i,j) > z01 .and. zhi > zhicemin .and. & !OLI_CODE zvolp(i,j) > zmin_volp*aice(i,j)) THEN !OLI_CODE icells = icells + 1 !OLI_CODE indxi(icells) = i !OLI_CODE indxj(icells) = j !OLI_CODE ELSE ! remove ponds on thin ice !OLI_CODE !fpond(i,j) = fpond(i,j) - zvolp(i,j) !OLI_CODE zvolpn(i,j,:) = z0 !OLI_CODE zvuin (i,j,:) = z0 !OLI_CODE zvolp (i,j) = z0 !OLI_CODE END IF !OLI_CODE END DO ! i !OLI_CODE END DO ! j !OLI_CODE !OLI_CODE DO ij = 1, icells !OLI_CODE i = indxi(ij) !OLI_CODE j = indxj(ij) !OLI_CODE !OLI_CODE !-------------------------------------------------------------- !OLI_CODE ! calculate pond area and depth !OLI_CODE !-------------------------------------------------------------- !OLI_CODE CALL pond_area(aice(i,j),vice(i,j),rhos(i,j,:), & !OLI_CODE aicen(i,j,:), vicen(i,j,:), vsnon(i,j,:), & !OLI_CODE ticen(i,j,:,:), salin(i,j,:,:), & !OLI_CODE zvolpn(i,j,:), zvolp(i,j), & !OLI_CODE zapondn(i,j,:),zhpondn(i,j,:), zdvn) !OLI_CODE !OLI_CODE fwoc(i,j) = fwoc(i,j) + zdvn ! -> Goes to fresh water budget !OLI_CODE !OLI_CODE ! mean surface temperature !OLI_CODE zTavg = z0 !OLI_CODE DO n = 1, jpl !OLI_CODE zTavg = zTavg + zTsfcn(i,j,n)*aicen(i,j,n) !OLI_CODE END DO !OLI_CODE zTavg = zTavg / aice(i,j) !OLI_CODE !OLI_CODE DO n = 1, jpl-1 !OLI_CODE !OLI_CODE IF (zvuin(i,j,n) > epsi10) THEN !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! melting: floating upper ice layer melts in whole or part !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! IF (zTsfcn(i,j,n) > zTp) THEN !OLI_CODE IF (zTavg > zTp) THEN !OLI_CODE !OLI_CODE zdvice = min(meltt(i,j)*zapondn(i,j,n), zvuin(i,j,n)) !OLI_CODE IF (zdvice > epsi10) THEN !OLI_CODE zvuin (i,j,n) = zvuin (i,j,n) - zdvice !OLI_CODE zvolpn(i,j,n) = zvolpn(i,j,n) + zdvice !OLI_CODE zvolp (i,j) = zvolp (i,j) + zdvice !OLI_CODE !fwoc(i,j) = fwoc(i,j) + zdvice !OLI_CODE !OLI_CODE IF (zvuin(i,j,n) < epsi10 .and. zvolpn(i,j,n) > puny) THEN !OLI_CODE ! ice lid melted and category is pond covered !OLI_CODE zvolpn(i,j,n) = zvolpn(i,j,n) + zvuin(i,j,n) !OLI_CODE !fwoc(i,j) = fwoc(i,j) + zvuin(i,j,n) !OLI_CODE zvuin(i,j,n) = z0 !OLI_CODE END IF !OLI_CODE zhpondn(i,j,n) = zvolpn(i,j,n) / zapondn(i,j,n) !OLI_CODE END IF !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! freezing: existing upper ice layer grows !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ELSE IF (zvolpn(i,j,n) > epsi10) THEN ! zTavg <= zTp !OLI_CODE !OLI_CODE ! dIFferential growth of base of surface floating ice layer !OLI_CODE zdTice = max(-zTavg, z0) ! > 0 !OLI_CODE zomega = rcdic*zdTice * zr1_rlfus !OLI_CODE zdHui = sqrt(zomega*rdt_ice + z25*(zvuin(i,j,n)/ & !OLI_CODE aicen(i,j,n))**2)- z5 * zvuin(i,j,n)/aicen(i,j,n) !OLI_CODE !OLI_CODE zdvice = min(zdHui*zapondn(i,j,n), zvolpn(i,j,n)) !OLI_CODE IF (zdvice > epsi10) THEN !OLI_CODE zvuin (i,j,n) = zvuin (i,j,n) + zdvice !OLI_CODE zvolpn(i,j,n) = zvolpn(i,j,n) - zdvice !OLI_CODE zvolp (i,j) = zvolp (i,j) - zdvice !OLI_CODE !fwoc(i,j) = fwoc(i,j) - zdvice !OLI_CODE zhpondn(i,j,n) = zvolpn(i,j,n) / zapondn(i,j,n) !OLI_CODE END IF !OLI_CODE !OLI_CODE END IF ! zTavg !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! freezing: upper ice layer begins to form !OLI_CODE ! note: albedo does not change !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ELSE ! zvuin < epsi10 !OLI_CODE !OLI_CODE ! thickness of newly formed ice !OLI_CODE ! the surface temperature of a meltpond is the same as that !OLI_CODE ! of the ice underneath (0C), and the thermodynamic surface !OLI_CODE ! flux is the same !OLI_CODE zdHui = max(-fsurf(i,j)*rdt_ice*zr1_rlfus, z0) !OLI_CODE zdvice = min(zdHui*zapondn(i,j,n), zvolpn(i,j,n)) !OLI_CODE IF (zdvice > epsi10) THEN !OLI_CODE zvuin (i,j,n) = zdvice !OLI_CODE zvolpn(i,j,n) = zvolpn(i,j,n) - zdvice !OLI_CODE zvolp (i,j) = zvolp (i,j) - zdvice !OLI_CODE !fwoc(i,j) = fwoc(i,j) - zdvice !OLI_CODE zhpondn(i,j,n)= zvolpn(i,j,n) / zapondn(i,j,n) !OLI_CODE END IF !OLI_CODE !OLI_CODE END IF ! zvuin !OLI_CODE !OLI_CODE END DO ! jpl !OLI_CODE !OLI_CODE END DO ! ij !OLI_CODE !OLI_CODE !--------------------------------------------------------------- !OLI_CODE ! remove ice lid if there is no liquid pond !OLI_CODE ! zvuin may be nonzero on category jpl due to dynamics !OLI_CODE !--------------------------------------------------------------- !OLI_CODE !OLI_CODE DO j = 1, jpj !OLI_CODE DO i = 1, jpi !OLI_CODE DO n = 1, jpl !OLI_CODE IF (aicen(i,j,n) > epsi10 .and. zvolpn(i,j,n) < puny & !OLI_CODE .and. zvuin (i,j,n) > epsi10) THEN !OLI_CODE kcells(n) = kcells(n) + 1 !OLI_CODE indxij = kcells(n) !OLI_CODE indxii(indxij,n) = i !OLI_CODE indxjj(indxij,n) = j !OLI_CODE END IF !OLI_CODE END DO !OLI_CODE END DO ! i !OLI_CODE END DO ! j !OLI_CODE !OLI_CODE DO n = 1, jpl !OLI_CODE !OLI_CODE IF (kcells(n) > 0) THEN !OLI_CODE DO ij = 1, kcells(n) !OLI_CODE i = indxii(ij,n) !OLI_CODE j = indxjj(ij,n) !OLI_CODE fwoc(i,j) = fwoc(i,j) + rhoic/rauw * zvuin(i,j,n) ! Completely refrozen lid goes into ocean (to be changed) !OLI_CODE zvuin(i,j,n) = z0 !OLI_CODE END DO ! ij !OLI_CODE END IF !OLI_CODE !OLI_CODE ! reload tracers !OLI_CODE DO j = 1, jpj !OLI_CODE DO i = 1, jpi !OLI_CODE IF (zapondn(i,j,n) > epsi10) THEN !OLI_CODE h_il(i,j,n) = zvuin(i,j,n) / zapondn(i,j,n) !OLI_CODE ELSE !OLI_CODE zvuin(i,j,n) = z0 !OLI_CODE h_il(i,j,n) = z0 !OLI_CODE END IF !OLI_CODE IF (aicen(i,j,n) > epsi10) THEN !OLI_CODE a_ip_frac(i,j,n) = zapondn(i,j,n) / aicen(i,j,n) * & !OLI_CODE (1.0_wp - MAX(z0, SIGN(1.0_wp, -zvolpn(i,j,n)))) !OLI_CODE h_ip(i,j,n) = zhpondn(i,j,n) !OLI_CODE ELSE !OLI_CODE a_ip_frac(i,j,n) = z0 !OLI_CODE h_ip(i,j,n) = z0 !OLI_CODE h_il(i,j,n) = z0 !OLI_CODE END IF !OLI_CODE END DO ! i !OLI_CODE END DO ! j !OLI_CODE !OLI_CODE END DO ! n !OLI_CODE !OLI_CODE END SUBROUTINE compute_mp_topo !OLI_CODE !OLI_CODE !OLI_CODE SUBROUTINE pond_area(aice,vice,rhos, & !OLI_CODE aicen, vicen, vsnon, ticen, & !OLI_CODE salin, zvolpn, zvolp, & !OLI_CODE zapondn,zhpondn,dvolp) !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE !! *** ROUTINE pond_area *** !OLI_CODE !! !OLI_CODE !! ** Purpose : Compute melt pond area, depth and melting rates !OLI_CODE !!------------------------------------------------------------------ !OLI_CODE REAL (wp), INTENT(IN) :: & !OLI_CODE aice,vice !OLI_CODE !OLI_CODE REAL (wp), DIMENSION(jpl), INTENT(IN) :: & !OLI_CODE aicen, vicen, vsnon, rhos !OLI_CODE !OLI_CODE REAL (wp), DIMENSION(nlay_i,jpl), INTENT(IN) :: & !OLI_CODE ticen, salin !OLI_CODE !OLI_CODE REAL (wp), DIMENSION(jpl), INTENT(INOUT) :: & !OLI_CODE zvolpn !OLI_CODE !OLI_CODE REAL (wp), INTENT(INOUT) :: & !OLI_CODE zvolp, dvolp !OLI_CODE !OLI_CODE REAL (wp), DIMENSION(jpl), INTENT(OUT) :: & !OLI_CODE zapondn, zhpondn !OLI_CODE !OLI_CODE INTEGER :: & !OLI_CODE n, ns, & !OLI_CODE m_index, & !OLI_CODE permflag !OLI_CODE !OLI_CODE REAL (wp), DIMENSION(jpl) :: & !OLI_CODE hicen, & !OLI_CODE hsnon, & !OLI_CODE asnon, & !OLI_CODE alfan, & !OLI_CODE betan, & !OLI_CODE cum_max_vol, & !OLI_CODE reduced_aicen !OLI_CODE !OLI_CODE REAL (wp), DIMENSION(0:jpl) :: & !OLI_CODE cum_max_vol_tmp !OLI_CODE !OLI_CODE REAL (wp) :: & !OLI_CODE hpond, & !OLI_CODE drain, & !OLI_CODE floe_weight, & !OLI_CODE pressure_head, & !OLI_CODE hsl_rel, & !OLI_CODE deltah, & !OLI_CODE perm, & !OLI_CODE apond, & !OLI_CODE msno !OLI_CODE !OLI_CODE REAL (wp), parameter :: & !OLI_CODE viscosity = 1.79e-3_wp, & ! kinematic water viscosity in kg/m/s !OLI_CODE z0 = 0.0_wp , & !OLI_CODE c1 = 1.0_wp , & !OLI_CODE p4 = 0.4_wp , & !OLI_CODE p6 = 0.6_wp , & !OLI_CODE epsi10 = 1.0e-11_wp !OLI_CODE !OLI_CODE !-----------| !OLI_CODE ! | !OLI_CODE ! |-----------| !OLI_CODE !___________|___________|______________________________________sea-level !OLI_CODE ! | | !OLI_CODE ! | |---^--------| !OLI_CODE ! | | | | !OLI_CODE ! | | | |-----------| |------- !OLI_CODE ! | | |alfan(n)| | | !OLI_CODE ! | | | | |--------------| !OLI_CODE ! | | | | | | !OLI_CODE !---------------------------v------------------------------------------- !OLI_CODE ! | | ^ | | | !OLI_CODE ! | | | | |--------------| !OLI_CODE ! | | |betan(n)| | | !OLI_CODE ! | | | |-----------| |------- !OLI_CODE ! | | | | !OLI_CODE ! | |---v------- | !OLI_CODE ! | | !OLI_CODE ! |-----------| !OLI_CODE ! | !OLI_CODE !-----------| !OLI_CODE !OLI_CODE !------------------------------------------------------------------- !OLI_CODE ! initialize !OLI_CODE !------------------------------------------------------------------- !OLI_CODE !OLI_CODE DO n = 1, jpl !OLI_CODE !OLI_CODE zapondn(n) = z0 !OLI_CODE zhpondn(n) = z0 !OLI_CODE !OLI_CODE IF (aicen(n) < epsi10) THEN !OLI_CODE hicen(n) = z0 !OLI_CODE hsnon(n) = z0 !OLI_CODE reduced_aicen(n) = z0 !OLI_CODE ELSE !OLI_CODE hicen(n) = vicen(n) / aicen(n) !OLI_CODE hsnon(n) = vsnon(n) / aicen(n) !OLI_CODE reduced_aicen(n) = c1 ! n=jpl !OLI_CODE IF (n < jpl) reduced_aicen(n) = aicen(n) & !OLI_CODE * (-0.024_wp*hicen(n) + 0.832_wp) !OLI_CODE asnon(n) = reduced_aicen(n) !OLI_CODE END IF !OLI_CODE !OLI_CODE ! This choice for alfa and beta ignores hydrostatic equilibium of categories. !OLI_CODE ! Hydrostatic equilibium of the entire ITD is accounted for below, assuming !OLI_CODE ! a surface topography implied by alfa=0.6 and beta=0.4, and rigidity across all !OLI_CODE ! categories. alfa and beta partition the ITD - they are areas not thicknesses! !OLI_CODE ! Multiplying by hicen, alfan and betan (below) are thus volumes per unit area. !OLI_CODE ! Here, alfa = 60% of the ice area (and since hice is constant in a category, !OLI_CODE ! alfan = 60% of the ice volume) in each category lies above the reference line, !OLI_CODE ! and 40% below. Note: p6 is an arbitrary choice, but alfa+beta=1 is required. !OLI_CODE !OLI_CODE alfan(n) = p6 * hicen(n) !OLI_CODE betan(n) = p4 * hicen(n) !OLI_CODE !OLI_CODE cum_max_vol(n) = z0 !OLI_CODE cum_max_vol_tmp(n) = z0 !OLI_CODE !OLI_CODE END DO ! jpl !OLI_CODE !OLI_CODE cum_max_vol_tmp(0) = z0 !OLI_CODE drain = z0 !OLI_CODE dvolp = z0 !OLI_CODE !OLI_CODE !-------------------------------------------------------------------------- !OLI_CODE ! the maximum amount of water that can be contained up to each ice category !OLI_CODE !-------------------------------------------------------------------------- !OLI_CODE !OLI_CODE DO n = 1, jpl-1 ! last category can not hold any volume !OLI_CODE !OLI_CODE IF (alfan(n+1) >= alfan(n) .and. alfan(n+1) > z0) THEN !OLI_CODE !OLI_CODE ! total volume in level including snow !OLI_CODE cum_max_vol_tmp(n) = cum_max_vol_tmp(n-1) + & !OLI_CODE (alfan(n+1) - alfan(n)) * sum(reduced_aicen(1:n)) !OLI_CODE !OLI_CODE !OLI_CODE ! subtract snow solid volumes from lower categories in current level !OLI_CODE DO ns = 1, n !OLI_CODE cum_max_vol_tmp(n) = cum_max_vol_tmp(n) & !OLI_CODE - rhos(ns)/rauw * & ! fraction of snow that is occupied by solid ??rauw !OLI_CODE asnon(ns) * & ! area of snow from that category !OLI_CODE max(min(hsnon(ns)+alfan(ns)-alfan(n), alfan(n+1)- & !OLI_CODE alfan(n)), z0) !OLI_CODE ! thickness of snow from ns layer in n layer !OLI_CODE END DO !OLI_CODE !OLI_CODE ELSE ! assume higher categories unoccupied !OLI_CODE cum_max_vol_tmp(n) = cum_max_vol_tmp(n-1) !OLI_CODE END IF !OLI_CODE !IF (cum_max_vol_tmp(n) < z0) THEN !OLI_CODE ! call abort_ice('negative melt pond volume') !OLI_CODE !END IF !OLI_CODE END DO !OLI_CODE cum_max_vol_tmp(jpl) = cum_max_vol_tmp(jpl-1) ! last category holds no volume !OLI_CODE cum_max_vol (1:jpl) = cum_max_vol_tmp(1:jpl) !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! is there more meltwater than can be held in the floe? !OLI_CODE !---------------------------------------------------------------- !OLI_CODE IF (zvolp >= cum_max_vol(jpl)) THEN !OLI_CODE drain = zvolp - cum_max_vol(jpl) + epsi10 !OLI_CODE zvolp = zvolp - drain !OLI_CODE dvolp = drain !OLI_CODE IF (zvolp < epsi10) THEN !OLI_CODE dvolp = dvolp + zvolp !OLI_CODE zvolp = z0 !OLI_CODE END IF !OLI_CODE END IF !OLI_CODE !OLI_CODE ! height and area corresponding to the remaining volume !OLI_CODE !OLI_CODE call calc_hpond(reduced_aicen, asnon, hsnon, rhos, alfan, & !OLI_CODE zvolp, cum_max_vol, hpond, m_index) !OLI_CODE !OLI_CODE DO n=1, m_index !OLI_CODE zhpondn(n) = hpond - alfan(n) + alfan(1) !OLI_CODE zapondn(n) = reduced_aicen(n) !OLI_CODE END DO !OLI_CODE apond = sum(zapondn(1:m_index)) !OLI_CODE !OLI_CODE !------------------------------------------------------------------------ !OLI_CODE ! drainage due to ice permeability - Darcy's law !OLI_CODE !------------------------------------------------------------------------ !OLI_CODE !OLI_CODE ! sea water level !OLI_CODE msno = z0 !OLI_CODE DO n=1,jpl !OLI_CODE msno = msno + vsnon(n) * rhos(n) !OLI_CODE END DO !OLI_CODE floe_weight = (msno + rhoic*vice + rau0*zvolp) / aice !OLI_CODE hsl_rel = floe_weight / rau0 & !OLI_CODE - ((sum(betan(:)*aicen(:))/aice) + alfan(1)) !OLI_CODE !OLI_CODE deltah = hpond - hsl_rel !OLI_CODE pressure_head = grav * rau0 * max(deltah, z0) !OLI_CODE !OLI_CODE ! drain IF ice is permeable !OLI_CODE permflag = 0 !OLI_CODE IF (pressure_head > z0) THEN !OLI_CODE DO n = 1, jpl-1 !OLI_CODE IF (hicen(n) /= z0) THEN !OLI_CODE CALL permeability_phi(ticen(:,n), salin(:,n), vicen(n), perm) !OLI_CODE IF (perm > z0) permflag = 1 !OLI_CODE drain = perm*zapondn(n)*pressure_head*rdt_ice / & !OLI_CODE (viscosity*hicen(n)) !OLI_CODE dvolp = dvolp + min(drain, zvolp) !OLI_CODE zvolp = max(zvolp - drain, z0) !OLI_CODE IF (zvolp < epsi10) THEN !OLI_CODE dvolp = dvolp + zvolp !OLI_CODE zvolp = z0 !OLI_CODE END IF !OLI_CODE END IF !OLI_CODE END DO !OLI_CODE !OLI_CODE ! adjust melt pond DIMENSIONs !OLI_CODE IF (permflag > 0) THEN !OLI_CODE ! recompute pond depth !OLI_CODE CALL calc_hpond(reduced_aicen, asnon, hsnon, rhos, alfan, & !OLI_CODE zvolp, cum_max_vol, hpond, m_index) !OLI_CODE DO n=1, m_index !OLI_CODE zhpondn(n) = hpond - alfan(n) + alfan(1) !OLI_CODE zapondn(n) = reduced_aicen(n) !OLI_CODE END DO !OLI_CODE apond = sum(zapondn(1:m_index)) !OLI_CODE END IF !OLI_CODE END IF ! pressure_head !OLI_CODE !OLI_CODE !------------------------------------------------------------------------ !OLI_CODE ! total melt pond volume in category DOes not include snow volume !OLI_CODE ! snow in melt ponds is not melted !OLI_CODE !------------------------------------------------------------------------ !OLI_CODE !OLI_CODE ! Calculate pond volume for lower categories !OLI_CODE DO n=1,m_index-1 !OLI_CODE zvolpn(n) = zapondn(n) * zhpondn(n) & !OLI_CODE - (rhos(n)/rauw) * asnon(n) * min(hsnon(n), zhpondn(n))! !OLI_CODE END DO !OLI_CODE !OLI_CODE ! Calculate pond volume for highest category = remaining pond volume !OLI_CODE IF (m_index == 1) zvolpn(m_index) = zvolp !OLI_CODE IF (m_index > 1) THEN !OLI_CODE IF (zvolp > sum(zvolpn(1:m_index-1))) THEN !OLI_CODE zvolpn(m_index) = zvolp - sum(zvolpn(1:m_index-1)) !OLI_CODE ELSE !OLI_CODE zvolpn(m_index) = z0 !OLI_CODE zhpondn(m_index) = z0 !OLI_CODE zapondn(m_index) = z0 !OLI_CODE ! If remaining pond volume is negative reduce pond volume of !OLI_CODE ! lower category !OLI_CODE IF (zvolp+epsi10 < sum(zvolpn(1:m_index-1))) & !OLI_CODE zvolpn(m_index-1) = zvolpn(m_index-1)-sum(zvolpn(1:m_index-1))& !OLI_CODE + zvolp !OLI_CODE END IF !OLI_CODE END IF !OLI_CODE !OLI_CODE DO n=1,m_index !OLI_CODE IF (zapondn(n) > epsi10) THEN !OLI_CODE zhpondn(n) = zvolpn(n) / zapondn(n) !OLI_CODE ELSE !OLI_CODE dvolp = dvolp + zvolpn(n) !OLI_CODE zhpondn(n) = z0 !OLI_CODE zvolpn(n) = z0 !OLI_CODE zapondn(n) = z0 !OLI_CODE end IF !OLI_CODE END DO !OLI_CODE DO n = m_index+1, jpl !OLI_CODE zhpondn(n) = z0 !OLI_CODE zapondn(n) = z0 !OLI_CODE zvolpn (n) = z0 !OLI_CODE END DO !OLI_CODE !OLI_CODE END SUBROUTINE pond_area !OLI_CODE !OLI_CODE !OLI_CODE SUBROUTINE calc_hpond(aicen, asnon, hsnon, rhos, alfan, & !OLI_CODE zvolp, cum_max_vol, & !OLI_CODE hpond, m_index) !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE !! *** ROUTINE calc_hpond *** !OLI_CODE !! !OLI_CODE !! ** Purpose : Compute melt pond depth !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE !OLI_CODE REAL (wp), DIMENSION(jpl), INTENT(IN) :: & !OLI_CODE aicen, & !OLI_CODE asnon, & !OLI_CODE hsnon, & !OLI_CODE rhos, & !OLI_CODE alfan, & !OLI_CODE cum_max_vol !OLI_CODE !OLI_CODE REAL (wp), INTENT(IN) :: & !OLI_CODE zvolp !OLI_CODE !OLI_CODE REAL (wp), INTENT(OUT) :: & !OLI_CODE hpond !OLI_CODE !OLI_CODE INTEGER, INTENT(OUT) :: & !OLI_CODE m_index !OLI_CODE !OLI_CODE INTEGER :: n, ns !OLI_CODE !OLI_CODE REAL (wp), DIMENSION(0:jpl+1) :: & !OLI_CODE hitl, & !OLI_CODE aicetl !OLI_CODE !OLI_CODE REAL (wp) :: & !OLI_CODE rem_vol, & !OLI_CODE area, & !OLI_CODE vol, & !OLI_CODE tmp, & !OLI_CODE z0 = 0.0_wp, & !OLI_CODE epsi10 = 1.0e-11_wp !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! hpond is zero if zvolp is zero - have we fully drained? !OLI_CODE !---------------------------------------------------------------- !OLI_CODE !OLI_CODE IF (zvolp < epsi10) THEN !OLI_CODE hpond = z0 !OLI_CODE m_index = 0 !OLI_CODE ELSE !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! Calculate the category where water fills up to !OLI_CODE !---------------------------------------------------------------- !OLI_CODE !OLI_CODE !----------| !OLI_CODE ! | !OLI_CODE ! | !OLI_CODE ! |----------| -- -- !OLI_CODE !__________|__________|_________________________________________ ^ !OLI_CODE ! | | rem_vol ^ | Semi-filled !OLI_CODE ! | |----------|-- -- -- - ---|-- ---- -- -- --v layer !OLI_CODE ! | | | | !OLI_CODE ! | | | |hpond !OLI_CODE ! | | |----------| | |------- !OLI_CODE ! | | | | | | !OLI_CODE ! | | | |---v-----| !OLI_CODE ! | | m_index | | | !OLI_CODE !------------------------------------------------------------- !OLI_CODE !OLI_CODE m_index = 0 ! 1:m_index categories have water in them !OLI_CODE DO n = 1, jpl !OLI_CODE IF (zvolp <= cum_max_vol(n)) THEN !OLI_CODE m_index = n !OLI_CODE IF (n == 1) THEN !OLI_CODE rem_vol = zvolp !OLI_CODE ELSE !OLI_CODE rem_vol = zvolp - cum_max_vol(n-1) !OLI_CODE END IF !OLI_CODE exit ! to break out of the loop !OLI_CODE END IF !OLI_CODE END DO !OLI_CODE m_index = min(jpl-1, m_index) !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! semi-filled layer may have m_index different snow in it !OLI_CODE !---------------------------------------------------------------- !OLI_CODE !OLI_CODE !----------------------------------------------------------- ^ !OLI_CODE ! | alfan(m_index+1) !OLI_CODE ! | !OLI_CODE !hitl(3)--> |----------| | !OLI_CODE !hitl(2)--> |------------| * * * * *| | !OLI_CODE !hitl(1)--> |----------|* * * * * * |* * * * * | | !OLI_CODE !hitl(0)-->------------------------------------------------- | ^ !OLI_CODE ! various snow from lower categories | |alfa(m_index) !OLI_CODE !OLI_CODE ! hitl - heights of the snow layers from thinner and current categories !OLI_CODE ! aicetl - area of each snow depth in this layer !OLI_CODE !OLI_CODE hitl(:) = z0 !OLI_CODE aicetl(:) = z0 !OLI_CODE DO n = 1, m_index !OLI_CODE hitl(n) = max(min(hsnon(n) + alfan(n) - alfan(m_index), & !OLI_CODE alfan(m_index+1) - alfan(m_index)), z0) !OLI_CODE aicetl(n) = asnon(n) !OLI_CODE !OLI_CODE aicetl(0) = aicetl(0) + (aicen(n) - asnon(n)) !OLI_CODE END DO !OLI_CODE hitl(m_index+1) = alfan(m_index+1) - alfan(m_index) !OLI_CODE aicetl(m_index+1) = z0 !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! reorder array according to hitl !OLI_CODE ! snow heights not necessarily in height order !OLI_CODE !---------------------------------------------------------------- !OLI_CODE !OLI_CODE DO ns = 1, m_index+1 !OLI_CODE DO n = 0, m_index - ns + 1 !OLI_CODE IF (hitl(n) > hitl(n+1)) THEN ! swap order !OLI_CODE tmp = hitl(n) !OLI_CODE hitl(n) = hitl(n+1) !OLI_CODE hitl(n+1) = tmp !OLI_CODE tmp = aicetl(n) !OLI_CODE aicetl(n) = aicetl(n+1) !OLI_CODE aicetl(n+1) = tmp !OLI_CODE END IF !OLI_CODE END DO !OLI_CODE END DO !OLI_CODE !OLI_CODE !---------------------------------------------------------------- !OLI_CODE ! divide semi-filled layer into set of sublayers each vertically homogenous !OLI_CODE !---------------------------------------------------------------- !OLI_CODE !OLI_CODE !hitl(3)---------------------------------------------------------------- !OLI_CODE ! | * * * * * * * * !OLI_CODE ! |* * * * * * * * * !OLI_CODE !hitl(2)---------------------------------------------------------------- !OLI_CODE ! | * * * * * * * * | * * * * * * * * !OLI_CODE ! |* * * * * * * * * |* * * * * * * * * !OLI_CODE !hitl(1)---------------------------------------------------------------- !OLI_CODE ! | * * * * * * * * | * * * * * * * * | * * * * * * * * !OLI_CODE ! |* * * * * * * * * |* * * * * * * * * |* * * * * * * * * !OLI_CODE !hitl(0)---------------------------------------------------------------- !OLI_CODE ! aicetl(0) aicetl(1) aicetl(2) aicetl(3) !OLI_CODE !OLI_CODE ! move up over layers incrementing volume !OLI_CODE DO n = 1, m_index+1 !OLI_CODE !OLI_CODE area = sum(aicetl(:)) - & ! total area of sub-layer !OLI_CODE (rhos(n)/rau0) * sum(aicetl(n:jpl+1)) ! area of sub-layer occupied by snow !OLI_CODE !OLI_CODE vol = (hitl(n) - hitl(n-1)) * area ! thickness of sub-layer times area !OLI_CODE !OLI_CODE IF (vol >= rem_vol) THEN ! have reached the sub-layer with the depth within !OLI_CODE hpond = rem_vol / area + hitl(n-1) + alfan(m_index) - & !OLI_CODE alfan(1) !OLI_CODE exit !OLI_CODE ELSE ! still in sub-layer below the sub-layer with the depth !OLI_CODE rem_vol = rem_vol - vol !OLI_CODE END IF !OLI_CODE !OLI_CODE END DO !OLI_CODE !OLI_CODE END IF !OLI_CODE !OLI_CODE END SUBROUTINE calc_hpond !OLI_CODE !OLI_CODE !OLI_CODE SUBROUTINE permeability_phi(ticen, salin, vicen, perm) !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE !! *** ROUTINE permeability_phi *** !OLI_CODE !! !OLI_CODE !! ** Purpose : Determine the liquid fraction of brine in the ice !OLI_CODE !! and its permeability !OLI_CODE !!------------------------------------------------------------------- !OLI_CODE REAL (wp), DIMENSION(nlay_i), INTENT(IN) :: & !OLI_CODE ticen, & ! energy of melting for each ice layer (J/m2) !OLI_CODE salin !OLI_CODE !OLI_CODE REAL (wp), INTENT(IN) :: & !OLI_CODE vicen ! ice volume !OLI_CODE !OLI_CODE REAL (wp), INTENT(OUT) :: & !OLI_CODE perm ! permeability !OLI_CODE !OLI_CODE REAL (wp) :: & !OLI_CODE Sbr ! brine salinity !OLI_CODE !OLI_CODE REAL (wp), DIMENSION(nlay_i) :: & !OLI_CODE Tin, & ! ice temperature !OLI_CODE phi ! liquid fraction !OLI_CODE !OLI_CODE INTEGER :: k !OLI_CODE !OLI_CODE REAL (wp) :: & !OLI_CODE c2 = 2.0_wp !OLI_CODE !OLI_CODE !----------------------------------------------------------------- !OLI_CODE ! Compute ice temperatures from enthalpies using quadratic formula !OLI_CODE !----------------------------------------------------------------- !OLI_CODE !OLI_CODE DO k = 1,nlay_i !OLI_CODE Tin(k) = ticen(k) !OLI_CODE END DO !OLI_CODE !OLI_CODE !----------------------------------------------------------------- !OLI_CODE ! brine salinity and liquid fraction !OLI_CODE !----------------------------------------------------------------- !OLI_CODE !OLI_CODE IF (maxval(Tin-rtt) <= -c2) THEN !OLI_CODE !OLI_CODE DO k = 1,nlay_i !OLI_CODE Sbr = - 1.2_wp & !OLI_CODE -21.8_wp * (Tin(k)-rtt) & !OLI_CODE - 0.919_wp * (Tin(k)-rtt)**2 & !OLI_CODE - 0.01878_wp * (Tin(k)-rtt)**3 !OLI_CODE phi(k) = salin(k)/Sbr ! liquid fraction !OLI_CODE END DO ! k !OLI_CODE !OLI_CODE ELSE !OLI_CODE !OLI_CODE DO k = 1,nlay_i !OLI_CODE Sbr = -17.6_wp * (Tin(k)-rtt) & !OLI_CODE - 0.389_wp * (Tin(k)-rtt)**2 & !OLI_CODE - 0.00362_wp* (Tin(k)-rtt)**3 !OLI_CODE phi(k) = salin(k)/Sbr ! liquid fraction !OLI_CODE END DO !OLI_CODE !OLI_CODE END IF !OLI_CODE !OLI_CODE !----------------------------------------------------------------- !OLI_CODE ! permeability !OLI_CODE !----------------------------------------------------------------- !OLI_CODE !OLI_CODE perm = 3.0e-08_wp * (minval(phi))**3 !OLI_CODE !OLI_CODE END SUBROUTINE permeability_phi !OLI_CODE !OLI_CODE #else !OLI_CODE !!---------------------------------------------------------------------- !OLI_CODE !! Default option Dummy Module No LIM-3 sea-ice model !OLI_CODE !!---------------------------------------------------------------------- !OLI_CODE CONTAINS !OLI_CODE SUBROUTINE lim_mp_init ! Empty routine !OLI_CODE END SUBROUTINE lim_mp_init !OLI_CODE SUBROUTINE lim_mp ! Empty routine !OLI_CODE END SUBROUTINE lim_mp !OLI_CODE SUBROUTINE compute_mp_topo ! Empty routine !OLI_CODE END SUBROUTINE compute_mp_topo !OLI_CODE SUBROUTINE pond_area ! Empty routine !OLI_CODE END SUBROUTINE pond_area !OLI_CODE SUBROUTINE calc_hpond ! Empty routine !OLI_CODE END SUBROUTINE calc_hpond !OLI_CODE SUBROUTINE permeability_phy ! Empty routine !OLI_CODE END SUBROUTINE permeability_phy !OLI_CODE #endif !OLI_CODE !!====================================================================== !OLI_CODE END MODULE limmp_topo !OLI_CODE #else !!---------------------------------------------------------------------- !! Default option Empty module NO LIM sea-ice model !!---------------------------------------------------------------------- CONTAINS SUBROUTINE lim_mp_init ! Empty routine END SUBROUTINE lim_mp_init SUBROUTINE lim_mp ! Empty routine END SUBROUTINE lim_mp SUBROUTINE lim_mp_topo ! Empty routine END SUBROUTINE lim_mp_topo SUBROUTINE lim_mp_area ! Empty routine END SUBROUTINE lim_mp_area SUBROUTINE lim_mp_perm ! Empty routine END SUBROUTINE lim_mp_perm #endif !!====================================================================== END MODULE limmp