54 subroutine boundary(time, dtime, dxi, deta, &
55 delta_ts, glac_index, z_sl, dzsl_dtau, z_mar)
58 && (marine_ice_formation==2) \
59 && (marine_ice_calving==9))
68 real(dp),
intent(in) :: time, dtime, dxi, deta
70 real(dp),
intent(out) :: delta_ts, glac_index, dzsl_dtau, z_mar
71 real(dp),
intent(inout) :: z_sl
79 integer(i4b) :: i, j, n
80 integer(i4b) :: i_gr, i_kl
82 real(dp) :: z_sl_min, t1, t2, t3, t4, t5, t6
83 real(dp) :: time_gr, time_kl
84 real(dp) :: z_sle_present, z_sle_help
85 real(dp),
dimension(0:JMAX,0:IMAX,0:12) :: precip
86 real(dp),
dimension(0:JMAX,0:IMAX) :: &
91 real(dp),
dimension(0:JMAX,0:IMAX,12) :: temp_mm
92 real(dp),
dimension(0:JMAX,0:IMAX) :: temp_ma
93 real(dp),
dimension(12) :: temp_mm_help
94 real(dp) :: temp_jja_help
95 real(dp),
dimension(0:JMAX,0:IMAX) :: et
96 real(dp) :: gamma_t, temp_diff
97 real(dp) :: gamma_p, zs_thresh, &
98 temp_rain, temp_snow, &
99 inv_delta_temp_rain_snow, coeff(0:5), inv_sqrt2_s_stat, &
100 precip_fact, frac_solid
101 real(dp) :: s_stat, beta1, beta2, pmax, mu, lambda_lti, temp_lti
102 logical,
dimension(0:JMAX,0:IMAX) :: check_point
103 logical,
save :: firstcall = .true.
105 real(dp),
parameter :: &
106 inv_twelve = 1.0_dp/12.0_dp, one_third = 1.0_dp/3.0_dp
127 delta_ts = sine_amplit &
128 *cos(2.0_dp*
pi*time/(sine_period*year_sec)) &
145 if (i_kl.eq.i_gr)
then 156 *(time-time_kl)/(time_gr-time_kl)
165 delta_ts = delta_ts * grip_temp_fact
182 if (i_kl == i_gr)
then 193 *(time-time_kl)/(time_gr-time_kl)
215 t1 = -250000.0_dp *year_sec
216 t2 = -140000.0_dp *year_sec
217 t3 = -125000.0_dp *year_sec
218 t4 = -21000.0_dp *year_sec
219 t5 = -8000.0_dp *year_sec
220 t6 = 0.0_dp *year_sec
224 else if (time.lt.t2)
then 225 z_sl = z_sl_min*(time-t1)/(t2-t1)
226 else if (time.lt.t3)
then 227 z_sl = -z_sl_min*(time-t3)/(t3-t2)
228 else if (time.lt.t4)
then 229 z_sl = z_sl_min*(time-t3)/(t4-t3)
230 else if (time.lt.t5)
then 231 z_sl = -z_sl_min*(time-t5)/(t5-t4)
232 else if (time.lt.t6)
then 252 if (i_kl.eq.i_gr)
then 263 *(time-time_kl)/(time_gr-time_kl)
276 if ( z_sl_old > -999999.9_dp )
then 277 dzsl_dtau = (z_sl-z_sl_old)/dtime
286 #if ( MARINE_ICE_CALVING==2 || MARINE_ICE_CALVING==3 ) 288 #elif ( MARINE_ICE_CALVING==4 || MARINE_ICE_CALVING==5 ) 289 z_mar = fact_z_mar*z_sl
290 #elif ( MARINE_ICE_CALVING==6 || MARINE_ICE_CALVING==7 ) 291 if (z_sl >= -80.0_dp)
then 294 z_mar = 10.25_dp*(z_sl+80.0_dp)-200.0_dp
296 z_mar = fact_z_mar*z_mar
308 check_point(j,i) = .false.
314 if (
maske(j,i).ge.2)
then 315 check_point(j ,i ) = .true.
316 check_point(j ,i+1) = .true.
317 check_point(j ,i-1) = .true.
318 check_point(j+1,i ) = .true.
319 check_point(j-1,i ) = .true.
326 if (check_point(j,i))
then 336 if (check_point(j,i))
then 344 gamma_t = -4.5e-03_dp
354 temp_diff = gamma_t*(
zs(j,i)-
zs_ref(j,i)) + delta_ts
360 #elif (TSURFACE == 5) 365 temp_diff = gamma_t*(
zs(j,i)-
zs_ref(j,i))
377 temp_ma(j,i) = 0.0_dp
380 temp_ma(j,i) = temp_ma(j,i) + temp_mm(j,i,n)*inv_twelve
388 #if (ELEV_DESERT == 1) 390 gamma_p = gamma_p*1.0e-03_dp
392 zs_thresh = zs_thresh
396 #if (SOLID_PRECIP == 1) /* Marsiat (1994) */ 403 inv_delta_temp_rain_snow = 1.0_dp/(temp_rain-temp_snow)
405 #elif (SOLID_PRECIP == 2) /* Bales et al. (2009) */ 412 coeff(0) = 5.4714e-01_dp
413 coeff(1) = -9.1603e-02_dp
414 coeff(2) = -3.314e-03_dp
415 coeff(3) = 4.66e-04_dp
416 coeff(4) = 3.8e-05_dp
417 coeff(5) = 6.0e-07_dp
419 #elif (SOLID_PRECIP == 3) /* Huybrechts and de Wolde (1999) */ 423 temp_snow = temp_rain
429 inv_sqrt2_s_stat = 1.0_dp/(sqrt(2.0_dp)*s_stat)
433 #if (ABLSURFACE==1 || ABLSURFACE==2) 445 #elif (ABLSURFACE==3) 447 lambda_lti = lambda_lti *(0.001_dp/year_sec)*(
rho_w/
rho)
459 #if (ACCSURFACE <= 3) 463 #if (ELEV_DESERT == 0) 467 #elif (ELEV_DESERT == 1) 469 if (
zs_ref(j,i) < zs_thresh)
then 471 = exp(gamma_p*(max(
zs(j,i),zs_thresh)-zs_thresh))
474 = exp(gamma_p*(max(
zs(j,i),zs_thresh)-
zs_ref(j,i)))
478 stop
' >>> boundary: Parameter ELEV_DESERT must be either 0 or 1!' 490 precip_fact = accfact
492 precip_fact = 1.0_dp + gamma_s*delta_ts
494 precip_fact = exp(gamma_s*delta_ts)
497 #if (ACCSURFACE <= 3) 499 precip(j,i,0) = 0.0_dp
502 precip(j,i,n) = precip(j,i,n)*precip_fact
503 precip(j,i,0) = precip(j,i,0) + precip(j,i,n)*inv_twelve
507 #elif (ACCSURFACE == 5) 509 precip(j,i,0) = 0.0_dp
513 #if (PRECIP_ANOM_INTERPOL==1) 516 #elif (PRECIP_ANOM_INTERPOL==2) 522 precip(j,i,0) = precip(j,i,0) + precip(j,i,n)*inv_twelve
530 accum(j,i) = precip(j,i,0)
536 #if (SOLID_PRECIP == 1) /* Marsiat (1994) */ 538 if (temp_mm(j,i,n) >= temp_rain)
then 540 else if (temp_mm(j,i,n) <= temp_snow)
then 543 frac_solid = (temp_rain-temp_mm(j,i,n))*inv_delta_temp_rain_snow
546 #elif (SOLID_PRECIP == 2) /* Bales et al. (2009) */ 548 if (temp_mm(j,i,n) >= temp_rain)
then 550 else if (temp_mm(j,i,n) <= temp_snow)
then 553 frac_solid = coeff(0) + temp_mm(j,i,n) * ( coeff(1) &
554 + temp_mm(j,i,n) * ( coeff(2) &
555 + temp_mm(j,i,n) * ( coeff(3) &
556 + temp_mm(j,i,n) * ( coeff(4) &
557 + temp_mm(j,i,n) * coeff(5) ) ) ) )
561 #elif (SOLID_PRECIP == 3) /* Huybrechts and de Wolde (1999) */ 563 frac_solid = 1.0_dp &
564 - 0.5_dp*erfc((temp_rain-temp_mm(j,i,n))*inv_sqrt2_s_stat)
581 #if (ABLSURFACE==1 || ABLSURFACE==2) 586 temp_mm_help(n) = temp_mm(j,i,n)
589 call pdd(temp_mm_help, s_stat, et(j,i))
597 if ((beta1*et(j,i)) <= (pmax*
snowfall(j,i)))
then 598 melt_star(j,i) = beta1*et(j,i)
603 melt(j,i) = beta2*(et(j,i)-melt_star(j,i)/beta1)
607 #elif (ABLSURFACE==2) 612 melt_star(j,i) =
rainfall(j,i)+beta1*et(j,i)
618 *(et(j,i)-(melt_star(j,i)-
rainfall(j,i))/beta1)
625 melt(j,i) = beta2*et(j,i)
632 #elif (ABLSURFACE==3) 634 temp_jja_help = one_third*(temp_mm(j,i,6)+temp_mm(j,i,7)+temp_mm(j,i,8))
636 melt_star(j,i) = 0.0_dp
637 melt(j,i) = lambda_lti*max((temp_jja_help-temp_lti), 0.0_dp)
661 where (melt_star >= melt)
662 temp_s = temp_ma + mu*(melt_star-melt)
675 && (marine_ice_formation==2) \
676 && (marine_ice_calving==9))
683 if (firstcall) firstcall = .false.
integer(i4b) grip_time_stp
grip_time_stp: Time step of the data values for the surface temperature anomaly
integer(i4b) ndata_specmap
ndata_specmap: Number of data values for the sea level
real(dp), dimension(0:jmax, 0:imax, 12) temp_mm_present
temp_mm_present(j,i,n): Present-day mean monthly surface temperature
real(dp) rho_w
RHO_W: Density of pure water.
integer(i4b) specmap_time_max
specmap_time_max: Maximum time of the data values for the sea level
real(dp) mu_0
MU_0: Firn-warming correction.
real(dp), dimension(0:jmax, 0:imax) calv_grounded
calv_grounded(j,i): Calving rate of grounded ice
real(dp), dimension(0:jmax, 0:imax) snowfall
snowfall(j,i): Snowfall rate at the ice surface
integer(i2b), dimension(0:jmax, 0:imax) maske
maske(j,i): Ice-land-ocean mask. 0: grounded ice, 1: ice-free land, 2: ocean, 3: floating ice ...
integer(i4b) specmap_time_min
specmap_time_min: Minimum time of the data values for the sea level
Computation of the positive degree days (PDD) with statistical temperature fluctuations; based on sem...
real(dp), dimension(0:jmax, 0:imax) as_perp
as_perp(j,i): Accumulation-ablation function at the ice surface (SMB)
real(dp), dimension(:), allocatable glacial_index
glacial_index(n): Data values for the glacial index
real(dp) s_stat_0
S_STAT_0: Standard deviation of the air termperature for the degree-day model.
real(dp), dimension(0:jmax, 0:imax) runoff
runoff(j,i): Runoff rate at the ice surface
real(dp), dimension(0:jmax, 0:imax) zs_ref
zs_ref(j,i): Reference elevation for precip_present, temp_ma_present and temp_mj_present ...
integer(i2b) function, public mask_update_sea_level(z_sl, i, j)
Main function of mask_update_m: Update of the ice-land-ocean mask due to changes of the sea level...
real(dp), dimension(0:jmax, 0:imax) temp_s
temp_s(j,i): Ice surface temperature
integer(i4b) grip_time_max
grip_time_max: Maximum time of the data values for the surface temperature anomaly ...
Declarations of global variables for SICOPOLIS (for the ANT domain).
integer(i4b) ndata_gi
ndata_gi: Number of data values for the glacial index
integer(i4b) ndata_grip
ndata_grip: Number of data values for the surface temperature anomaly
real(dp) beta1_0
BETA1_0: Degree-day factor for snow.
real(dp), dimension(0:jmax, 0:imax) calv_uw_ice
Calving of "underwater ice".
Declarations of kind types for SICOPOLIS.
real(dp), dimension(0:jmax, 0:imax) zs
zs(j,i): Coordinate z of the surface topography
real(dp) pmax_0
PMAX_0: Saturation factor for the formation of superimposed ice.
real(dp), dimension(0:jmax, 0:imax) evap
evap(j,i): Evaporation rate at the ice surface
real(dp), dimension(0:jmax, 0:imax) accum
accum(j,i): Accumulation rate at the ice surface (includes liquid precipitation = rainfall!) ...
integer(i4b) gi_time_min
gi_time_min: Minimum time of the data values for the glacial index
real(dp), dimension(:), allocatable specmap_zsl
specmap_zsl(n): Data values for the sea level
real(dp) beta2_0
BETA2_0: Degree-day factor for ice.
integer(i4b) gi_time_stp
gi_time_stp: Time step of the data values for the glacial index
real(dp), dimension(0:jmax, 0:imax) rainfall
rainfall(j,i): Rainfall rate at the ice surface
integer(i4b) gi_time_max
gi_time_max: Maximum time of the data values for the glacial index
real(dp), dimension(0:jmax, 0:imax, 12) gamma_precip_lgm_anom
gamma_precip_lgm_anom(j,i,n): negative natural logarithm of precip_lgm_anom(j,i,n) ...
integer(i2b), dimension(0:jmax, 0:imax) maske_neu
maske_neu(j,i): New value of maske computed during an integration step
subroutine boundary(time, dtime, dxi, deta, delta_ts, glac_index, z_sl, dzsl_dtau, z_mar)
Main routine of boundary_m: Computation of the surface temperature (must be less than 0 deg C!) and o...
integer(i4b) specmap_time_stp
specmap_time_stp: Time step of the data values for the sea level
real(dp), parameter pi
pi: Constant pi
integer(i4b) grip_time_min
grip_time_min: Minimum time of the data values for the surface temperature anomaly ...
subroutine calving_underwater_ice(z_sl)
Main routine: Calving of "underwater ice".
Computation of the surface temperature (must be less than 0 deg C!) and of the accumulation-ablation ...
subroutine, public pdd(temp_mm, s_stat, ET)
Main subroutine of pdd_m: Computation of the positive degree days (PDD) with statistical temperature ...
real(dp) rho
RHO: Density of ice.
Update of the ice-land-ocean mask due to changes of the sea level.
integer, parameter dp
Double-precision reals.
real(dp), dimension(0:jmax, 0:imax, 12) precip_present
precip_present(j,i,n): Present-day mean monthly precipitation rate at the ice surface ...
real(dp), dimension(0:jmax, 0:imax, 12) precip_lgm_anom
precip_lgm_anom(j,i,n): LGM anomaly (ratio LGM/present) of the mean monthly precipitation rate at the...
real(dp), dimension(0:jmax, 0:imax, 12) temp_mm_lgm_anom
temp_mm_lgm_anom(j,i,n): LGM anomaly (difference LGM - present) of the mean monthly surface temperatu...
Declarations of global variables for SICOPOLIS.
real(dp), dimension(:), allocatable griptemp
griptemp(n): Data values for the surface temperature anomaly