!!>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>> !! NEMO/OPA : ISOMIP Configuration namelist to overwrite reference dynamical namelist !!>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>> !----------------------------------------------------------------------- &namusr_def ! ISOMIP user defined namelist !----------------------------------------------------------------------- ln_zco = .false. ! z-coordinate ln_zps = .true. ! z-partial-step coordinate ln_sco = .false. ! s-coordinate rn_lam0 = 0.0 ! longitude of first raw and column T-point (jphgr_msh = 1) rn_phi0 = -80.0 ! latitude of first raw and column T-point (jphgr_msh = 1) rn_e1deg = 0.3 ! zonal grid-spacing (degrees) rn_e2deg = 0.1 ! meridional grid-spacing (degrees) rn_e3 = 30. ! vertical resolution / !----------------------------------------------------------------------- &namrun ! parameters of the run !----------------------------------------------------------------------- cn_exp = "ISOMIP" ! experience name nn_it000 = 1 ! first time step nn_itend = 525600 ! last time step nn_leapy = 0 ! Leap year calendar (1) or not (0) ln_clobber = .true. ! clobber (overwrite) an existing file nn_stock = 99999999 ! frequency of creation of a restart file (modulo referenced to 1) nn_write = 48 ! frequency of write in the output file (modulo referenced to nn_it000) nn_istate = 0 ! output the initial state (1) or not (0) / !----------------------------------------------------------------------- &namcfg ! parameters of the configuration !----------------------------------------------------------------------- ln_read_cfg = .false. ! (=T) read the domain configuration file ! ! (=F) user defined configuration ==>>> see usrdef(_...) modules ! ln_write_cfg= .true. ! (=T) create the domain configuration file cn_domcfg_out = "ISOMIP_cfg_out" ! newly created domain configuration filename / !----------------------------------------------------------------------- &namdom ! space and time domain (bathymetry, mesh, timestep) !----------------------------------------------------------------------- ln_linssh = .false. ! =T linear free surface ==>> model level are fixed in time ! nn_msh = 1 ! create (>0) a mesh file or not (=0) ! rn_rdt = 1800. ! time step for the dynamics (and tracer if nn_acc=0) / !----------------------------------------------------------------------- &namcrs ! Grid coarsening for dynamics output and/or ! ! passive tracer coarsened online simulations !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namtsd ! data : Temperature & Salinity !----------------------------------------------------------------------- cn_dir = './' ! root directory for the location of the runoff files ln_tsd_init = .false. ! Initialisation of ocean T & S with T &S input data (T) or not (F) ln_tsd_tradmp = .false. ! damping of ocean T & S toward T &S input data (T) or not (F) / !----------------------------------------------------------------------- &namsbc ! Surface Boundary Condition (surface module) !----------------------------------------------------------------------- nn_fsbc = 6 ! frequency of surface boundary condition computation ! ! (also = the frequency of sea-ice model call) ln_blk = .false. ! Bulk formulation (T => fill namsbc_blk ) ln_usr = .true. ! user defined formulation (T => check usrdef_sbc) nn_ice = 0 ! =0 no ice boundary condition , ! =1 use observed ice-cover , ! =2 ice-model used nn_ice_embd = 0 ! =0 levitating ice (no mass exchange, concentration/dilution effect) ! =1 levitating ice with mass and salt exchange but no presure effect ! =2 embedded sea-ice (full salt and mass exchanges and pressure) ln_traqsr = .false. ! Light penetration (T) or not (F) ln_rnf = .false. ! runoffs (T => fill namsbc_rnf) ln_isf = .true. ! ice shelf melting/freezing (T => fill namsbc_isf) ln_ssr = .false. ! Sea Surface Restoring on T and/or S (T => fill namsbc_ssr) nn_fwb = 0 ! FreshWater Budget: =0 unchecked ! =1 global mean of e-p-r set to zero at each time step ! =2 annual global mean of e-p-r set to zero / !----------------------------------------------------------------------- &namsbc_flx ! surface boundary condition : flux formulation !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_clio ! namsbc_clio CLIO bulk formulae !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_core ! namsbc_core CORE bulk formulae !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_mfs ! namsbc_mfs MFS bulk formulae !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_cpl ! coupled ocean/atmosphere model ("key_oasis3") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namtra_qsr ! penetrative solar radiation !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_rnf ! runoffs namelist surface boundary condition !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_isf ! Top boundary layer (ISF) !----------------------------------------------------------------------- ! ! file name ! frequency (hours) ! variable ! time interpol. ! clim ! 'yearly'/ ! weights ! rotation ! land/sea mask ! ! ! ! (if <0 months) ! name ! (logical) ! (T/F) ! 'monthly' ! filename ! pairing ! filename ! ! nn_isf == 4 sn_fwfisf = 'rnfisf' , -12 ,'sowflisf', .false. , .true. , 'yearly' , '' , '' , '' ! nn_isf == 3 sn_rnfisf = 'rnfisf' , -12 ,'sofwfisf', .false. , .true. , 'yearly' , '' , '' , '' ! nn_isf == 2 and 3 sn_depmax_isf = 'rnfisf' , -12 ,'sozisfmax' , .false. , .true. , 'yearly' , '' , '' , '' sn_depmin_isf = 'rnfisf' , -12 ,'sozisfmin' , .false. , .true. , 'yearly' , '' , '' , '' ! nn_isf == 2 sn_Leff_isf = 'rnfisf' , -12 ,'Leff' , .false. , .true. , 'yearly' , '' , '' , '' ! for all case nn_isf = 1 ! ice shelf melting/freezing ! 1 = presence of ISF 2 = bg03 parametrisation ! 3 = rnf file for isf 4 = ISF fwf specified ! option 1 and 4 need ln_isfcav = .true. (domzgr) ! only for nn_isf = 1 or 2 rn_gammat0 = 1.0e-4 ! gammat coefficient used in blk formula rn_gammas0 = 1.0e-4 ! gammas coefficient used in blk formula ! only for nn_isf = 1 or 4 rn_hisf_tbl = 30. ! thickness of the top boundary layer (Losh et al. 2008) ! 0 => thickness of the tbl = thickness of the first wet cell ! only for nn_isf = 1 nn_isfblk = 1 ! 1 ISOMIP like: 2 equations formulation (Hunter et al., 2006) ! 2 ISOMIP+ like: 3 equations formulation (Asay-Davis et al., 2015) nn_gammablk = 0 ! 0 = cst Gammat (= gammat/s) ! 1 = velocity dependend Gamma (u* * gammat/s) (Jenkins et al. 2010) ! 2 = velocity and stability dependent Gamma (Holland et al. 1999) / !----------------------------------------------------------------------- &namsbc_apr ! Atmospheric pressure used as ocean forcing or in bulk !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_ssr ! surface boundary condition : sea surface restoring !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_alb ! albedo parameters !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namberg ! iceberg parameters !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namlbc ! lateral momentum boundary condition !----------------------------------------------------------------------- ! free slip ! partial slip ! no slip ! strong slip rn_shlat = 0. ! shlat = 0 ! 0 < shlat < 2 ! shlat = 2 ! 2 < shlat ln_vorlat = .false. ! consistency of vorticity boundary condition with analytical eqs. / !----------------------------------------------------------------------- &namagrif ! AGRIF zoom ("key_agrif") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nam_tide ! tide parameters (#ifdef key_tide) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nambdy ! unstructured open boundaries ("key_bdy") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nambdy_dta ! open boundaries - external data ("key_bdy") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nambdy_tide ! tidal forcing at open boundaries !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nambfr ! bottom friction !----------------------------------------------------------------------- nn_bfr = 2 ! type of bottom friction : = 0 : free slip, = 1 : linear friction ! = 2 : nonlinear friction rn_bfri1 = 4.e-4 ! bottom drag coefficient (linear case) rn_bfri2 = 1.e-3 ! bottom drag coefficient (non linear case). Minimum coeft if ln_loglayer=T rn_bfri2_max = 1.e-1 ! max. bottom drag coefficient (non linear case and ln_loglayer=T) rn_bfeb2 = 2.5e-3 ! bottom turbulent kinetic energy background (m2/s2) rn_bfrz0 = 3.e-3 ! bottom roughness [m] if ln_loglayer=T ln_bfr2d = .false. ! horizontal variation of the bottom friction coef (read a 2D mask file ) rn_bfrien = 50. ! local multiplying factor of bfr (ln_bfr2d=T) rn_tfri1 = 4.e-4 ! top drag coefficient (linear case) rn_tfri2 = 2.5e-3 ! top drag coefficient (non linear case). Minimum coeft if ln_loglayer=T rn_tfri2_max = 1.e-1 ! max. top drag coefficient (non linear case and ln_loglayer=T) rn_tfeb2 = 0.0 ! top turbulent kinetic energy background (m2/s2) rn_tfrz0 = 3.e-3 ! top roughness [m] if ln_loglayer=T ln_tfr2d = .false. ! horizontal variation of the top friction coef (read a 2D mask file ) rn_tfrien = 50. ! local multiplying factor of tfr (ln_tfr2d=T) ln_bfrimp = .true. ! implicit bottom friction (requires ln_zdfexp = .false. if true) ln_loglayer = .false. ! logarithmic formulation (non linear case) / !----------------------------------------------------------------------- &nambbc ! bottom temperature boundary condition !----------------------------------------------------------------------- ln_trabbc = .false. ! Apply a geothermal heating at the ocean bottom / !----------------------------------------------------------------------- &nambbl ! bottom boundary layer scheme !----------------------------------------------------------------------- nn_bbl_ldf = 0 ! diffusive bbl (=1) or not (=0) nn_bbl_adv = 0 ! advective bbl (=1/2) or not (=0) / !----------------------------------------------------------------------- &nameos ! ocean physical parameters !----------------------------------------------------------------------- ln_teos10 = .false. ! = Use TEOS-10 equation of state ln_eos80 = .true. ! = Use EOS80 equation of state ! ! rd(T,S,Z)*rau0 = -a0*(1+.5*lambda*dT+mu*Z+nu*dS)*dT+b0*dS / !----------------------------------------------------------------------- &namtra_adv ! advection scheme for tracer !----------------------------------------------------------------------- ln_traadv_fct = .true. ! FCT scheme nn_fct_h = 2 ! =2/4, horizontal 2nd / 4th order nn_fct_v = 2 ! =2/4, vertical 2nd / COMPACT 4th order nn_fct_zts = 0 ! >=1, 2nd order FCT scheme with vertical sub-timestepping ! ! (number of sub-timestep = nn_fct_zts) / !----------------------------------------------------------------------- &namtra_adv_mle ! mixed layer eddy parametrisation (Fox-Kemper param) !----------------------------------------------------------------------- / !---------------------------------------------------------------------------------- &namtra_ldf ! lateral diffusion scheme for tracers !---------------------------------------------------------------------------------- ! ! Operator type: ln_traldf_lap = .true. ! laplacian operator ln_traldf_blp = .false. ! bilaplacian operator ! ! Direction of action: ln_traldf_lev = .false. ! iso-level ln_traldf_hor = .true. ! horizontal (geopotential) ln_traldf_iso = .false. ! iso-neutral (standard operator) ln_traldf_triad = .false. ! iso-neutral (triad operator) ! ! ! iso-neutral options: ln_traldf_msc = .false. ! Method of Stabilizing Correction (both operators) rn_slpmax = 0.01 ! slope limit (both operators) ln_triad_iso = .false. ! pure horizontal mixing in ML (triad only) rn_sw_triad = 1 ! =1 switching triad ; =0 all 4 triads used (triad only) ln_botmix_triad = .false. ! lateral mixing on bottom (triad only) ! ! ! Coefficients: nn_aht_ijk_t = 0 ! space/time variation of eddy coef ! ! =-20 (=-30) read in eddy_induced_velocity_2D.nc (..._3D.nc) file ! ! = 0 constant ! ! = 10 F(k) =ldf_c1d ! ! = 20 F(i,j) =ldf_c2d ! ! = 21 F(i,j,t) =Treguier et al. JPO 1997 formulation ! ! = 30 F(i,j,k) =ldf_c2d * ldf_c1d ! ! = 31 F(i,j,k,t)=F(local velocity and grid-spacing) rn_aht_0 = 100. ! lateral eddy diffusivity (lap. operator) [m2/s] rn_bht_0 = 1.e+12 ! lateral eddy diffusivity (bilap. operator) [m4/s] / !---------------------------------------------------------------------------------- &namtra_ldfeiv ! eddy induced velocity param. !---------------------------------------------------------------------------------- ln_ldfeiv =.false. ! use eddy induced velocity parameterization / !----------------------------------------------------------------------- &namtra_dmp ! tracer: T & S newtonian damping !----------------------------------------------------------------------- ln_tradmp = .false. ! add a damping termn (T) or not (F) / !----------------------------------------------------------------------- &namdyn_adv ! formulation of the momentum advection !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namdyn_vor ! option of physics/algorithm (not control by CPP keys) !----------------------------------------------------------------------- ln_dynvor_ene = .true. ! enstrophy conserving scheme ln_dynvor_ens = .false. ! energy conserving scheme ln_dynvor_mix = .false. ! mixed scheme ln_dynvor_een = .false. ! energy & enstrophy scheme nn_een_e3f = 1 ! e3f = masked averaging of e3t divided by 4 (=0) or by the sum of mask (=1) / !----------------------------------------------------------------------- &namdyn_hpg ! Hydrostatic pressure gradient option !----------------------------------------------------------------------- ln_hpg_zps = .false. ! z-coordinate - partial steps (interpolation) ln_hpg_isf = .true. ! s-coordinate adapted for isf (standard jacobian formulation) / !----------------------------------------------------------------------- &namdyn_spg ! surface pressure gradient !----------------------------------------------------------------------- ln_dynspg_ts = .true. ! split-explicit free surface / !----------------------------------------------------------------------- &namdyn_ldf ! lateral diffusion on momentum !----------------------------------------------------------------------- ! ! Type of the operator : ! ! no diffusion: set ln_dynldf_lap=..._blp=F ln_dynldf_lap = .true. ! laplacian operator ln_dynldf_blp = .false. ! bilaplacian operator ! ! Direction of action : ln_dynldf_lev = .false. ! iso-level ln_dynldf_hor = .true. ! horizontal (geopotential) ln_dynldf_iso = .false. ! iso-neutral ! ! Coefficient nn_ahm_ijk_t = 0 ! space/time variation of eddy coef ! ! =-30 read in eddy_viscosity_3D.nc file ! ! =-20 read in eddy_viscosity_2D.nc file ! ! = 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) rn_ahm_0 = 600. ! horizontal laplacian eddy viscosity [m2/s] rn_ahm_b = 0. ! background eddy viscosity for ldf_iso [m2/s] rn_bhm_0 = 1.e+12 ! horizontal bilaplacian eddy viscosity [m4/s] ! ! Caution in 20 and 30 cases the coefficient have to be given for a 1 degree grid (~111km) / !----------------------------------------------------------------------- &namzdf ! vertical physics (default: NO selection) !----------------------------------------------------------------------- ! ! type of vertical closure ln_zdfcst = .true. ! constant mixing ln_zdfric = .false. ! local Richardson dependent formulation (T => fill namzdf_ric) ln_zdftke = .false. ! Turbulent Kinetic Energy closure (T => fill namzdf_tke) ln_zdfgls = .false. ! Generic Length Scale closure (T => fill namzdf_gls) ! ! ! convection ln_zdfevd = .true. ! enhanced vertical diffusion nn_evdm = 1 ! apply on tracer (=0) or on tracer and momentum (=1) rn_evd = 0.1 ! mixing coefficient [m2/s] ln_zdfnpc = .false. ! Non-Penetrative Convective algorithm nn_npc = 1 ! frequency of application of npc nn_npcp = 365 ! npc control print frequency ! ln_zdfddm = .false. ! double diffusive mixing ! ! ! gravity wave-driven vertical mixing ln_zdfiwm = .false. ! internal wave-induced mixing (T => fill namzdf_iwm) ln_zdfswm = .false. ! surface wave-induced mixing (T => ln_wave=ln_sdw=T ) ! ! ! time-stepping ln_zdfexp = .false. ! split-explicit (T) or implicit (F) scheme ! ! ! coefficients rn_avm0 = 1.e-3 ! vertical eddy viscosity [m2/s] (background Kz if ln_zdfcst=F) rn_avt0 = 5.e-5 ! vertical eddy diffusivity [m2/s] (background Kz if ln_zdfcst=F) nn_avb = 0 ! profile for background avt & avm (=1) or not (=0) nn_havtb = 0 ! horizontal shape for avtb (=1) or not (=0) / !----------------------------------------------------------------------- &nammpp ! Massively Parallel Processing ("key_mpp_mpi) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namctl ! Control prints & Benchmark !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namnc4 ! netcdf4 chunking and compression settings ("key_netcdf4") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namtrd ! diagnostics on dynamics and/or tracer trends ("key_trddyn" and/or "key_trdtra") ! ! or mixed-layer trends or barotropic vorticity ("key_trdmld" or "key_trdvor") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namhsb ! Heat and salt budgets !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namobs ! observation usage switch (ln_diaobs =T) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nam_asminc ! assimilation increments ('key_asminc') !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_wave ! External fields from wave model !----------------------------------------------------------------------- /