Skip to content
Snippets Groups Projects
Commit b5683d3d authored by Nicolas Martin's avatar Nicolas Martin :speech_balloon:
Browse files

Update of namelist blocks in preparation to 4.2 release

parent fff940c9
No related branches found
No related tags found
No related merge requests found
Showing
with 141 additions and 75 deletions
......@@ -7,5 +7,5 @@
ln_loglayer = .false. ! logarithmic drag: Cd = vkarmn/log(z/z0) |U|
!
ln_drgimp = .true. ! implicit top/bottom friction flag
ln_drgice_imp = .false. ! implicit ice-ocean drag
ln_drgice_imp = .true. ! implicit ice-ocean drag
/
......@@ -2,7 +2,7 @@
&namdrg_bot ! BOTTOM friction (ln_drg_OFF =F)
!-----------------------------------------------------------------------
rn_Cd0 = 1.e-3 ! drag coefficient [-]
rn_Uc0 = 0.4 ! ref. velocity [m/s] (linear drag=Cd0*Uc0)
rn_Uc0 = 0.4 ! ref. velocity [m/s] (linear drag=Cd0*Uc0)
rn_Cdmax = 0.1 ! drag value maximum [-] (logarithmic drag)
rn_ke0 = 2.5e-3 ! background kinetic energy [m2/s2] (non-linear cases)
rn_z0 = 3.e-3 ! roughness [m] (ln_loglayer=T)
......
......@@ -2,7 +2,7 @@
&namdrg_top ! TOP friction (ln_drg_OFF =F & ln_isfcav=T)
!-----------------------------------------------------------------------
rn_Cd0 = 1.e-3 ! drag coefficient [-]
rn_Uc0 = 0.4 ! ref. velocity [m/s] (linear drag=Cd0*Uc0)
rn_Uc0 = 0.4 ! ref. velocity [m/s] (linear drag=Cd0*Uc0)
rn_Cdmax = 0.1 ! drag value maximum [-] (logarithmic drag)
rn_ke0 = 2.5e-3 ! background kinetic energy [m2/s2] (non-linear cases)
rn_z0 = 3.0e-3 ! roughness [m] (ln_loglayer=T)
......
!-----------------------------------------------------------------------
&namdta_dyn ! offline ocean input files (OFF_SRC only)
!-----------------------------------------------------------------------
ln_dynrnf = .false. ! runoffs option enabled (T) or not (F)
ln_dynrnf_depth = .false. ! runoffs is spread in vertical (T) or not (F)
!
cn_dir = './' ! root directory for the ocean data location
!___________!_________________________!___________________!___________!_____________!________!___________!__________________!__________!_______________!
! ! file name ! frequency (hours) ! variable ! time interp.! clim ! 'yearly'/ ! weights filename ! rotation ! land/sea mask !
! ! ! (if <0 months) ! name ! (logical) ! (T/F) ! 'monthly' ! ! pairing ! filename !
sn_tem = 'dyna_grid_T' , 120. , 'votemper' , .true. , .true. , 'yearly' , '' , '' , ''
sn_sal = 'dyna_grid_T' , 120. , 'vosaline' , .true. , .true. , 'yearly' , '' , '' , ''
sn_mld = 'dyna_grid_T' , 120. , 'somixhgt' , .true. , .true. , 'yearly' , '' , '' , ''
sn_emp = 'dyna_grid_T' , 120. , 'sowaflup' , .true. , .true. , 'yearly' , '' , '' , ''
sn_fmf = 'dyna_grid_T' , 120. , 'iowaflup' , .true. , .true. , 'yearly' , '' , '' , ''
sn_ice = 'dyna_grid_T' , 120. , 'soicecov' , .true. , .true. , 'yearly' , '' , '' , ''
sn_qsr = 'dyna_grid_T' , 120. , 'soshfldo' , .true. , .true. , 'yearly' , '' , '' , ''
sn_wnd = 'dyna_grid_T' , 120. , 'sowindsp' , .true. , .true. , 'yearly' , '' , '' , ''
sn_uwd = 'dyna_grid_U' , 120. , 'uocetr_eff', .true. , .true. , 'yearly' , '' , '' , ''
sn_vwd = 'dyna_grid_V' , 120. , 'vocetr_eff', .true. , .true. , 'yearly' , '' , '' , ''
sn_wwd = 'dyna_grid_W' , 120. , 'wocetr_eff', .true. , .true. , 'yearly' , '' , '' , ''
sn_avt = 'dyna_grid_W' , 120. , 'voddmavs' , .true. , .true. , 'yearly' , '' , '' , ''
sn_ubl = 'dyna_grid_U' , 120. , 'sobblcox' , .true. , .true. , 'yearly' , '' , '' , ''
sn_vbl = 'dyna_grid_V' , 120. , 'sobblcoy' , .true. , .true. , 'yearly' , '' , '' , ''
/
......@@ -14,4 +14,10 @@
rn_lf_bfr = 15. ! maximum bottom stress per unit volume [N/m3]
rn_lf_relax = 1.e-5 ! relaxation time scale to reach static friction [s-1]
rn_lf_tensile = 0.05 ! isotropic tensile strength [0-0.5??]
cn_dir = './' ! root directory for the grounded icebergs mask data location
!___________!________________!___________________!___________!_____________!________!___________!__________!__________!_______________!
! ! file name ! frequency (hours) ! variable ! time interp.! clim ! 'yearly'/ ! weights ! rotation ! land/sea mask !
! ! ! (if <0 months) ! name ! (logical) ! (T/F) ! 'monthly' ! filename ! pairing ! filename !
sn_icbmsk = 'NOT USED' , -12. , 'icb_mask', .false. , .true. , 'yearly' , '' , '' , ''
/
......@@ -6,5 +6,7 @@
ln_hpg_sco = .false. ! s-coordinate (standard jacobian formulation)
ln_hpg_isf = .false. ! s-coordinate (sco ) adapted to isf
ln_hpg_djc = .false. ! s-coordinate (Density Jacobian with Cubic polynomial)
ln_hpg_djc_vnh = .true. ! hor. bc type for djc scheme (T=von Neumann, F=linear extrapolation)
ln_hpg_djc_vnv = .true. ! vert. bc type for djc scheme (T=von Neumann, F=linear extrapolation)
ln_hpg_prj = .false. ! s-coordinate (Pressure Jacobian scheme)
/
......@@ -3,6 +3,7 @@
!-----------------------------------------------------------------------
! ! Type of the operator :
ln_dynldf_OFF = .false. ! No operator (i.e. no explicit diffusion)
nn_dynldf_typ = 0 ! =0 div-rot (default) ; =1 symmetric
ln_dynldf_lap = .false. ! laplacian operator
ln_dynldf_blp = .false. ! bilaplacian operator
! ! Direction of action :
......@@ -13,13 +14,13 @@
nn_ahm_ijk_t = 0 ! space/time variation of eddy coefficient :
! ! =-30 read in eddy_viscosity_3D.nc file
! ! =-20 read in eddy_viscosity_2D.nc file
! ! = 0 constant
! ! = 0 constant
! ! = 10 F(k)=c1d
! ! = 20 F(i,j)=F(grid spacing)=c2d
! ! = 30 F(i,j,k)=c2d*c1d
! ! = 31 F(i,j,k)=F(grid spacing and local velocity)
! ! = 32 F(i,j,k)=F(local gridscale and deformation rate)
! ! time invariant coefficients : ahm = 1/2 Uv*Lv (lap case)
! ! time invariant coefficients : ahm = 1/2 Uv*Lv (lap case)
! ! or = 1/12 Uv*Lv^3 (blp case)
rn_Uv = 0.1 ! lateral viscous velocity [m/s] (nn_ahm_ijk_t= 0, 10, 20, 30)
rn_Lv = 10.e+3 ! lateral viscous length [m] (nn_ahm_ijk_t= 0, 10)
......
......@@ -2,10 +2,18 @@
&namdyn_rdgrft ! Ice ridging/rafting
!------------------------------------------------------------------------------
! -- ice_rdgrft_strength -- !
ln_str_H79 = .true. ! ice strength param.: Hibler_79 => P = pstar*<h>*exp(-c_rhg*A)
ln_str_H79 = .true. ! ice strength param.: Hibler_79 => P = pstar*<h>*exp(-c_rhg*A)
rn_pstar = 2.0e+04 ! ice strength thickness parameter [N/m2]
rn_crhg = 20.0 ! ice strength conc. parameter (-)
rn_crhg = 20.0 ! ice strength conc. parameter (-)
ln_str_R75 = .false. ! ice strength param.: Rothrock_75 => P = fn of potential energy
rn_pe_rdg = 17.0 ! coef accouting for frictional dissipation
ln_str_CST = .false. ! ice strength param.: Constant
rn_str = 0.0 ! ice strength value
ln_str_smooth = .true. ! spatial smoothing of the ice strength
! -- ice_rdgrft -- !
ln_distf_lin = .true. ! redistribution function of ridged ice: linear (Hibler 1980)
ln_distf_exp = .false. ! redistribution function of ridged ice: exponential => not coded yet
rn_murdg = 3.0 ! e-folding scale of ridged ice (m**.5)
rn_csrdg = 0.5 ! fraction of shearing energy contributing to ridging
! -- ice_rdgrft_prep -- !
ln_partf_lin = .false. ! Linear ridging participation function (Thorndike et al, 1975)
......
......@@ -2,12 +2,20 @@
&namdyn_rhg ! Ice rheology
!------------------------------------------------------------------------------
ln_rhg_EVP = .true. ! EVP rheology
ln_rhg_EAP = .false. ! EAP rheology
ln_aEVP = .false. ! adaptive rheology (Kimmritz et al. 2016 & 2017)
ln_rhg_EAP = .false. ! EAP rheology
ln_aEVP = .true. ! adaptive rheology (Kimmritz et al. 2016 & 2017)
rn_creepl = 2.0e-9 ! creep limit [1/s]
rn_ecc = 2.0 ! eccentricity of the elliptical yield curve
nn_nevp = 120 ! number of EVP subcycles
nn_nevp = 100 ! number of EVP subcycles
rn_relast = 0.333 ! ratio of elastic timescale to ice time step: Telast = dt_ice * rn_relast
! advised value: 1/3 (rn_nevp=120) or 1/9 (rn_nevp=300)
ln_rhg_chkcvg = .false. ! check convergence of rheology (outputs: file ice_cvg.nc & variable uice_cvg)
! advised value: 1/3 (nn_nevp=100) or 1/9 (nn_nevp=300)
nn_rhg_chkcvg = 0 ! check convergence of rheology
! = 0 no check
! = 1 check at the main time step (output xml: uice_cvg)
! = 2 check at both main and rheology time steps (additional output: ice_cvg.nc)
! this option 2 asks a lot of communications between cpu
ln_rhg_VP = .false. ! VP rheology
nn_vp_nout = 10 ! number of outer iterations
nn_vp_ninn = 1500 ! number of inner iterations
nn_vp_chkcvg = 5 ! iteration step for convergence check
/
......@@ -6,10 +6,10 @@
ln_bt_fw = .true. ! Forward integration of barotropic Eqs.
ln_bt_av = .true. ! Time filtering of barotropic variables
nn_bt_flt = 1 ! Time filter choice = 0 None
! ! = 1 Boxcar over nn_baro sub-steps
! ! = 2 Boxcar over 2*nn_baro " "
! ! = 1 Boxcar over nn_e sub-steps
! ! = 2 Boxcar over 2*nn_e " "
ln_bt_auto = .true. ! Number of sub-step defined from:
rn_bt_cmax = 0.8 ! =T : the Maximum Courant Number allowed
nn_baro = 30 ! =F : the number of sub-step in rn_rdt seconds
nn_e = 30 ! =F : the number of sub-step in rn_Dt seconds
rn_bt_alpha = 0. ! Temporal diffusion parameter (if ln_bt_av=F)
/
......@@ -7,8 +7,10 @@
ln_dynvor_enT = .false. ! energy conserving scheme (T-point)
ln_dynvor_eeT = .false. ! energy conserving scheme (een using e3t)
ln_dynvor_een = .false. ! energy & enstrophy scheme
nn_een_e3f = 0 ! =0 e3f = mi(mj(e3t))/4
! ! =1 e3f = mi(mj(e3t))/mi(mj( tmask))
!
ln_dynvor_msk = .false. ! vorticity multiplied by fmask (=T) ==>>> PLEASE DO NOT ACTIVATE
! ! (f-point vorticity schemes only)
! ! (f-point vorticity schemes only)
!
nn_e3f_typ = 0 ! type of e3f (EEN, ENE, ENS, MIX only) =0 e3f = mi(mj(e3t))/4
! ! =1 e3f = mi(mj(e3t))/mi(mj( tmask))
/
......@@ -27,16 +27,16 @@
rn_hld_ini_n = 0.0 ! initial pond lid depth (m), North
rn_hld_ini_s = 0.0 ! " " South
! -- for nn_iceini_file = 1
sn_hti = 'Ice_initialization' , -12 ,'hti' , .false. , .true., 'yearly' , '' , '', ''
sn_hts = 'Ice_initialization' , -12 ,'hts' , .false. , .true., 'yearly' , '' , '', ''
sn_ati = 'Ice_initialization' , -12 ,'ati' , .false. , .true., 'yearly' , '' , '', ''
sn_smi = 'Ice_initialization' , -12 ,'smi' , .false. , .true., 'yearly' , '' , '', ''
sn_tmi = 'Ice_initialization' , -12 ,'tmi' , .false. , .true., 'yearly' , '' , '', ''
sn_tsu = 'Ice_initialization' , -12 ,'tsu' , .false. , .true., 'yearly' , '' , '', ''
sn_tms = 'NOT USED' , -12 ,'tms' , .false. , .true., 'yearly' , '' , '', ''
sn_hti = 'Ice_initialization' , -12. ,'hti' , .false. , .true., 'yearly' , '' , '', ''
sn_hts = 'Ice_initialization' , -12. ,'hts' , .false. , .true., 'yearly' , '' , '', ''
sn_ati = 'Ice_initialization' , -12. ,'ati' , .false. , .true., 'yearly' , '' , '', ''
sn_smi = 'Ice_initialization' , -12. ,'smi' , .false. , .true., 'yearly' , '' , '', ''
sn_tmi = 'Ice_initialization' , -12. ,'tmi' , .false. , .true., 'yearly' , '' , '', ''
sn_tsu = 'Ice_initialization' , -12. ,'tsu' , .false. , .true., 'yearly' , '' , '', ''
sn_tms = 'NOT USED' , -12. ,'tms' , .false. , .true., 'yearly' , '' , '', ''
! melt ponds (be careful, sn_apd is the pond concentration (not fraction), so it differs from rn_apd)
sn_apd = 'NOT USED' , -12 ,'apd' , .false. , .true., 'yearly' , '' , '', ''
sn_hpd = 'NOT USED' , -12 ,'hpd' , .false. , .true., 'yearly' , '' , '', ''
sn_hld = 'NOT USED' , -12 ,'hld' , .false. , .true., 'yearly' , '' , '', ''
sn_apd = 'NOT USED' , -12. ,'apd' , .false. , .true., 'yearly' , '' , '', ''
sn_hpd = 'NOT USED' , -12. ,'hpd' , .false. , .true., 'yearly' , '' , '', ''
sn_hld = 'NOT USED' , -12. ,'hld' , .false. , .true., 'yearly' , '' , '', ''
cn_dir='./'
/
......@@ -18,7 +18,7 @@
!
ln_isfcav_mlt = .false. ! ice shelf melting into the cavity (need ln_isfcav = .true. in domain_cfg.nc)
cn_isfcav_mlt = '3eq' ! ice shelf melting formulation (spe/2eq/3eq/oasis)
! ! spe = fwfisf is read from a forcing field
! ! spe = fwfisf is read from a forcing field ( melt > 0; freezing < 0 )
! ! 2eq = ISOMIP like: 2 equations formulation (Hunter et al., 2006 for a short description)
! ! 3eq = ISOMIP+ like: 3 equations formulation (Asay-Davis et al., 2016 for a short description)
! ! oasis = fwfisf is given by oasis and pattern by file sn_isfcav_fwf
......@@ -43,19 +43,27 @@
!
ln_isfpar_mlt = .false. ! ice shelf melting parametrised
cn_isfpar_mlt = 'spe' ! ice shelf melting parametrisation (spe/bg03/oasis)
! ! spe = fwfisf is read from a forcing field
! ! spe = fwfisf is read from a forcing field ( melt > 0; freezing < 0 )
! ! bg03 = melt computed using Beckmann and Goosse parametrisation
! ! oasis = fwfisf is given by oasis and pattern by file sn_isfpar_fwf
!
!* bg03 case
rn_isfpar_bg03_gt0 = 1.0e-4 ! gamma coeficient used in bg03 paper [m/s]
!
!*** File definition ***
!
!* all cases
!___________!_____________!___________________!___________!_____________!_________!___________!__________!__________!_______________!
! ! file name ! frequency (hours) ! variable ! time interp.! clim ! 'yearly'/ ! weights ! rotation ! land/sea mask !
! ! ! (if <0 months) ! name ! (logical) ! (T/F) ! 'monthly' ! filename ! pairing ! filename !
sn_isfpar_zmax = 'isfmlt_par', 0. ,'sozisfmax', .false. , .true. , 'yearly' , '' , '' , ''
sn_isfpar_zmin = 'isfmlt_par', 0. ,'sozisfmin', .false. , .true. , 'yearly' , '' , '' , ''
!
!* 'spe' and 'oasis' case
sn_isfpar_fwf = 'isfmlt_par' , -12. ,'sofwfisf' , .false. , .true. , 'yearly' , '' , '' , ''
!
!* 'bg03' case
!* Leff is in [km]
sn_isfpar_Leff = 'isfmlt_par', 0. ,'Leff' , .false. , .true. , 'yearly' , '' , '' , ''
!
! ---------------- ice sheet coupling -------------------------------
......
......@@ -5,5 +5,6 @@
rn_himean = 2.0 ! expected domain-average ice thickness (m)
ln_cat_usr = .false. ! ice categories are defined by rn_catbnd below (m)
rn_catbnd = 0.,0.45,1.1,2.1,3.7,6.0
rn_himin = 0.1 ! minimum ice thickness (m) used in remapping
rn_himin = 0.1 ! minimum ice thickness (m) allowed
rn_himax = 99.0 ! maximum ice thickness (m) allowed
/
......@@ -6,4 +6,6 @@
ln_nnogather = .true. ! activate code to avoid mpi_allgather use at the northfold
jpni = 0 ! number of processors following i (set automatically if < 1), see also ln_listonly = T
jpnj = 0 ! number of processors following j (set automatically if < 1), see also ln_listonly = T
nn_hls = 1 ! halo width (applies to both rows and columns)
nn_comm = 1 ! comm choice
/
......@@ -35,12 +35,12 @@
cn_sstbiasfiles = 'sstbias.nc' ! SST bias input file name
cn_gridsearchfile ='gridsearch.nc' ! Grid search file name
rn_gridsearchres = 0.5 ! Grid search resolution
rn_default_avglamscl = 0. ! Default E/W diameter of observation footprint (metres/degrees)
rn_default_avgphiscl = 0. ! Default N/S diameter of observation footprint (metres/degrees)
rn_mdtcorr = 1.61 ! MDT correction
rn_mdtcutoff = 65.0 ! MDT cutoff for computed correction
rn_dobsini = 00010101.000000 ! Initial date in window YYYYMMDD.HHMMSS
rn_dobsend = 00010102.000000 ! Final date in window YYYYMMDD.HHMMSS
rn_default_avglamscl = 0. ! Default E/W diameter of observation footprint (metres/degrees)
rn_default_avgphiscl = 0. ! Default N/S diameter of observation footprint (metres/degrees)
rn_sla_avglamscl = 0. ! E/W diameter of SLA observation footprint (metres/degrees)
rn_sla_avgphiscl = 0. ! N/S diameter of SLA observation footprint (metres/degrees)
rn_sst_avglamscl = 0. ! E/W diameter of SST observation footprint (metres/degrees)
......
......@@ -4,11 +4,11 @@
rn_osm_mle_ce = 0.06 ! magnitude of the MLE (typical value: 0.06 to 0.08)
nn_osm_mle = 0 ! MLE type: =0 standard Fox-Kemper ; =1 new formulation
rn_osm_mle_lf = 5.e+3 ! typical scale of mixed layer front (meters) (case rn_osm_mle=0)
rn_osm_mle_time = 172800. ! time scale for mixing momentum across the mixed layer (seconds) (case rn_osm_mle=0)
rn_osm_mle_time = 43200. ! time scale for mixing momentum across the mixed layer (seconds) (case rn_osm_mle=0)
rn_osm_mle_lat = 20. ! reference latitude (degrees) of MLE coef. (case rn_mle=1)
rn_osm_mle_rho_c = 0.01 ! delta rho criterion used to calculate MLD for FK
rn_osm_mle_thresh = 0.0005 ! delta b criterion used for FK MLE criterion
rn_osm_mle_tau = 172800. ! time scale for FK-OSM (seconds) (case rn_osm_mle=0)
ln_osm_hmle_limit = .false. ! limit hmle to rn_osm_hmle_limit*hbl
rn_osm_hmle_limit = 1.2
rn_osm_mle_rho_c = 0.03 ! delta rho criterion used to calculate MLD for FK
rn_osm_mle_thresh = 0.0001 ! delta b criterion used for FK MLE criterion
rn_osm_mle_tau = 172800. ! time scale for FK-OSM (seconds) (case rn_osm_mle=0)
ln_osm_hmle_limit = .true. ! If true, limit hmle to rn_osm_hmle_limit*hbl
rn_osm_hmle_limit = 1.5
/
......@@ -3,22 +3,22 @@
!-----------------------------------------------------------------------
concnno3 = 1.e-6 ! Nitrate half saturation of nanophytoplankton
concdno3 = 3.E-6 ! Nitrate half saturation for diatoms
concnnh4 = 1.E-7 ! NH4 half saturation for phyto
concdnh4 = 3.E-7 ! NH4 half saturation for diatoms
concnfer = 1.E-9 ! Iron half saturation for phyto
concdfer = 3.E-9 ! Iron half saturation for diatoms
concbfe = 1.E-11 ! Iron half-saturation for DOC remin.
concbnh4 = 2.E-8 ! NH4 half saturation for DOC remin.
concbno3 = 2.E-7 ! Nitrate half saturation for DOC remin.
concnnh4 = 1.E-6 ! NH4 half saturation for phyto
concdnh4 = 3.E-6 ! NH4 half saturation for diatoms
concnfer = 1.7E-9 ! Iron half saturation for phyto
concdfer = 5.E-9 ! Iron half saturation for diatoms
concbfe = 3.E-11 ! Iron half-saturation for DOC remin.
concbnh4 = 3.E-7 ! NH4 half saturation for DOC remin.
concbno3 = 3.E-7 ! Nitrate half saturation for DOC remin.
xsizedia = 1.E-6 ! Minimum size criteria for diatoms
xsizephy = 1.E-6 ! Minimum size criteria for phyto
xsizern = 3.0 ! Size ratio for nanophytoplankton
xsizerd = 3.0 ! Size ratio for diatoms
xksi1 = 2.E-6 ! half saturation constant for Si uptake
xsizerd = 4.0 ! Size ratio for diatoms
xksi1 = 8.E-6 ! half saturation constant for Si uptake
xksi2 = 20E-6 ! half saturation constant for Si/C
xkdoc = 417.E-6 ! half-saturation constant of DOC remineralization
qnfelim = 7.E-6 ! Optimal quota of phyto
qdfelim = 7.E-6 ! Optimal quota of diatoms
caco3r = 0.3 ! mean rain ratio
qnfelim = 10.E-6 ! Optimal quota of phyto
qdfelim = 10.E-6 ! Optimal quota of diatoms
caco3r = 0.2 ! mean rain ratio
oxymin = 1.E-6 ! Half-saturation constant for anoxia
/
!-----------------------------------------------------------------------
&namp4zmes ! parameters for mesozooplankton for PISCES std - ln_p4z
!-----------------------------------------------------------------------
part2 = 0.75 ! part of calcite not dissolved in mesozoo guts
grazrat2 = 0.75 ! maximal mesozoo grazing rate
resrat2 = 0.005 ! exsudation rate of mesozooplankton
mzrat2 = 0.03 ! mesozooplankton mortality rate
xpref2d = 1. ! mesozoo preference for diatoms
xpref2n = 0.3 ! mesozoo preference for nanophyto.
xpref2z = 1. ! mesozoo preference for microzoo.
xpref2c = 0.3 ! mesozoo preference for poc
xthresh2zoo = 1E-8 ! zoo feeding threshold for mesozooplankton
xthresh2dia = 1E-8 ! diatoms feeding threshold for mesozooplankton
xthresh2phy = 1E-8 ! nanophyto feeding threshold for mesozooplankton
xthresh2poc = 1E-8 ! poc feeding threshold for mesozooplankton
xthresh2 = 3E-7 ! Food threshold for grazing
xkgraz2 = 20.E-6 ! half saturation constant for meso grazing
epsher2 = 0.35 ! Efficicency of Mesozoo growth
epsher2min = 0.35 ! Minimum efficiency of mesozoo growth
sigma2 = 0.6 ! Fraction of mesozoo excretion as DOM
unass2 = 0.3 ! non assimilated fraction of P by mesozoo
grazflux = 3.e3 ! flux-feeding rate
part2 = 0.75 ! part of calcite not dissolved in mesozoo guts
grazrat2 = 0.5 ! maximal mesozoo grazing rate
resrat2 = 0.005 ! exsudation rate of mesozooplankton
mzrat2 = 0.01 ! mesozooplankton mortality rate
xpref2d = 1. ! mesozoo preference for diatoms
xpref2n = 0.3 ! mesozoo preference for nanophyto.
xpref2z = 1. ! mesozoo preference for microzoo.
xpref2c = 0.3 ! mesozoo preference for poc
xthresh2zoo = 1E-8 ! zoo feeding threshold for mesozooplankton
xthresh2dia = 1E-8 ! diatoms feeding threshold for mesozooplankton
xthresh2phy = 1E-8 ! nanophyto feeding threshold for mesozooplankton
xthresh2poc = 1E-8 ! poc feeding threshold for mesozooplankton
xthresh2 = 3E-7 ! Food threshold for grazing
xkgraz2 = 20.E-6 ! half saturation constant for meso grazing
epsher2 = 0.4 ! Efficicency of Mesozoo growth
epsher2min = 0.4 ! Minimum efficiency of mesozoo growth
sigma2 = 0.6 ! Fraction of mesozoo excretion as DOM
unass2 = 0.3 ! non assimilated fraction of P by mesozoo
grazflux = 3.e3 ! flux-feeding rate
xsigma2 = 0.5 ! Predation window size
xsigma2del = 1.0 ! Predation window size scaling
ln_dvm_meso = .false. ! Activates DVM for mesozooplankton
xfracmig = 0.3 ! Fraction of mesozooplankton performing DVM
/
!-----------------------------------------------------------------------
&namp4zmort ! parameters for phytoplankton sinks for PISCES std - ln_p4z
!-----------------------------------------------------------------------
wchl = 0.01 ! quadratic mortality of phytoplankton
wchld = 0.01 ! maximum quadratic mortality of diatoms
wchldm = 0.03 ! maximum quadratic mortality of diatoms
mprat = 0.01 ! phytoplankton mortality rate
mprat2 = 0.01 ! Diatoms mortality rate
wchln = 0.01 ! quadratic mortality of phytoplankton
wchld = 0.03 ! maximum quadratic mortality of diatoms
mpratn = 0.01 ! phytoplankton mortality rate
mpratd = 0.01 ! Diatoms mortality rate
/
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Finish editing this message first!
Please register or to comment