!----------------------------------------------------------------------- &namrun ! parameters of the run !----------------------------------------------------------------------- nn_no = 0 ! job number (no more used...) cn_exp = "eORCA1L3_OSM_N" ! experience name nn_it000 = 1 !8993 !33 !8992 ! first time step nn_itend = 35040 !72 !35040 !35040 !6 4 !11680 !32 !2464 !35040 !64 !9000 !116800 ! last time step (std 5475) nn_date0 = 19800101 ! date at nit_0000 (format yyyymmdd) used if ln_rstart=F or (ln_rstart=T and nn_rstctl=0 or 1) nn_leapy = 0 ! Leap year calendar (1) or not (0) ln_rstart = .false. !.false. ! start from rest (F) or from a restart file (T) ! nn_rstctl = 2 !0 ! 2 ! restart control ==> activated only if ln_rstart=T cn_ocerst_in = "restart" ! "eORCA1L3_OSM_no_w_00000032_restart" ! suffix of ocean restart name (input) cn_ocerst_indir = "RESTARTS" ! directory from which to read input ocean restarts cn_ocerst_outdir = "RESTARTS" ! directory from which to read input ocean restarts nn_istate = 0 !1 ! output the initial state (1) or not (0) ln_rst_list = .false. ! output restarts at list of times using nn_stocklist (T) or at set frequency with nn_stock (F) nn_stock = 11680 !8892 ! 32 !8892 !11680 ! frequency of creation of a restart file (modulo referenced to 1) nn_stocklist = 8892,11680,0,0,0,0,0,0 ! List of timesteps when a restart file is to be written nn_write = 11680 ! frequency of write in the output file (modulo referenced to nn_it000) ln_mskland = .false. ! mask land points in NetCDF outputs (costly: + ~15%) ln_cfmeta = .false. ! output additional data to netCDF files required for compliance with the CF metadata standard nn_chunksz = 0 ! chunksize (bytes) for NetCDF file (works only with iom_nf90 routines) / !----------------------------------------------------------------------- &namcfg ! parameters of the configuration (default: user defined GYRE) !----------------------------------------------------------------------- ln_read_cfg = .true. ! (=T) read the domain configuration file ! ! (=F) user defined configuration ==>>> see usrdef(_...) modules cn_domcfg = "eORCA_R1_zps_domcfg" ! domain configuration filename / !----------------------------------------------------------------------- &namdom ! time and space domain !----------------------------------------------------------------------- rn_rdt = 2700. ! time step for the dynamics ln_meshmask = .false. !.true. ! create meshfile / !----------------------------------------------------------------------- &namtsd ! data : Temperature & Salinity !----------------------------------------------------------------------- ! ! =T read T-S fields for: ln_tsd_init = .true. ! ocean initialisation ln_tsd_dmp = .false. ! T-S restoring (see namtra_dmp) cn_dir = '/hpcdata/scratch/agn/OSMOSIS/FORCING/SHACONEMO_eORCA_LIM3/' ! root directory for the T-S 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 = 'conservative_temperature_WOA13_decav_Reg1L75_clim', -1 ,'votemper' , .true. , .true. , 'yearly' , 'weights_3D_WOA13d1_2_eorca1_bilinear.nc' , '' , '' sn_sal = 'absolute_salinity_WOA13_decav_Reg1L75_clim' , -1 ,'vosaline' , .true. , .true. , 'yearly' , 'weights_3D_WOA13d1_2_eorca1_bilinear.nc' , '' , '' / !----------------------------------------------------------------------- &namwad ! Wetting and drying default is no WAD !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namcrs ! coarsened grid (for outputs and/or TOP) (ln_crs =T) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namc1d ! 1D configuration options ("key_c1d") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namc1d_dyndmp ! U & V newtonian damping ("key_c1d") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namc1d_uvd ! data: U & V currents ("key_c1d") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc ! Surface Boundary Condition (surface module) !----------------------------------------------------------------------- nn_fsbc = 1 ! frequency of surface boundary condition computation ! (also = the frequency of sea-ice & iceberg model call) ! Type of air-sea fluxes ln_blk = .true. ! Bulk formulation (T => fill namsbc_blk ) nn_ice = 2 ! =0 no ice boundary condition ! =1 use observed ice-cover ( => fill namsbc_iif ) ! =2 or 3 automatically for LIM3 or CICE ("key_lim3" or "key_cice") ! except in AGRIF zoom where it has to be specified ln_ice_embd = .false. ! =T embedded sea-ice (pressure + mass and salt exchanges) ! =F levitating ice (no pressure, mass and salt exchanges) ! Misc. options of sbc : ln_traqsr = .true. ! Light penetration in the ocean (T => fill namtra_qsr) ln_dm2dc = .true. ! daily mean to diurnal cycle on short wave ln_rnf = .true. ! runoffs (T => fill namsbc_rnf) ln_ssr = .true. ! Sea Surface Restoring on T and/or S (T => fill namsbc_ssr) nn_fwb = 2 ! 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 ln_isf = .true. ! ice shelf (T => fill namsbc_isf) ln_wave = .true. ! Activate coupling with wave (T => fill namsbc_wave) ln_cdgw = .false. ! Neutral drag coefficient read from wave model (T => ln_wave=.true. & fill namsbc_wave) ln_sdw = .true. !.false. ! Read 2D Surf Stokes Drift & Computation of 3D stokes drift (T => ln_wave=.true. & fill namsbc_wave) nn_sdrift = 1 ! Parameterization for the calculation of 3D-Stokes drift from the surface Stokes drift ! = 0 Breivik 2015 parameterization: v_z=v_0*[exp(2*k*z)/(1-8*k*z)] ! = 1 Phillips: v_z=v_o*[exp(2*k*z)-beta*sqrt(-2*k*pi*z)*erfc(sqrt(-2*k*z))] ! = 2 Phillips as (1) but using the wave frequency from a wave model ln_tauwoc = .false. ! Activate ocean stress modified by external wave induced stress (T => ln_wave=.true. & fill namsbc_wave) ln_stcor = .true. ! Activate Stokes Coriolis term (T => ln_wave=.true. & ln_sdw=.true. & fill namsbc_wave) nn_lsm = 0 ! =0 land/sea mask for input fields is not applied (keep empty land/sea mask filename field) , ! =1:n number of iterations of land/sea mask application for input fields (fill land/sea mask filename field) / !----------------------------------------------------------------------- &namsbc_flx ! surface boundary condition : flux formulation !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_blk ! namsbc_blk generic Bulk formula (ln_blk =T) !----------------------------------------------------------------------- ! ! 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_wndi = 'u_10_core_oonly' , 6 , 'U_10_MOD', .true. , .false. , 'yearly' , 'weights_coreII_2_eorca1_bicubic.nc' , 'U1' , '' sn_wndj = 'v_10_core_oonly' , 6 , 'V_10_MOD', .true. , .false. , 'yearly' , 'weights_coreII_2_eorca1_bicubic.nc' , 'V1' , '' sn_qsr = 'rad_core_oonly' , 24 , 'SWDN_MOD', .false. , .false. , 'yearly' , 'weights_coreII_2_eorca1_bilinear.nc' , '' , '' sn_qlw = 'rad_core_oonly' , 24 , 'LWDN_MOD', .true. , .false. , 'yearly' , 'weights_coreII_2_eorca1_bilinear.nc' , '' , '' sn_tair = 't_10_core_oonly' , 6 , 'T_10_MOD', .false. , .false. , 'yearly' , 'weights_coreII_2_eorca1_bilinear.nc' , '' , '' sn_humi = 'q_10_core_oonly' , 6 , 'Q_10_MOD', .false. , .false. , 'yearly' , 'weights_coreII_2_eorca1_bilinear.nc' , '' , '' sn_prec = 'tprecip_core_oonly' , -1 , 'TPRECIP' , .true. , .false. , 'yearly' , 'weights_coreII_2_eorca1_bilinear.nc' , '' , '' sn_snow = 'tprecip_core_oonly' , -1 , 'SNOW' , .true. , .false. , 'yearly' , 'weights_coreII_2_eorca1_bilinear.nc' , '' , '' sn_slp = 'slp_core_oonly' , 6 , 'SLP' , .true. , .false. , 'yearly' , 'weights_coreII_2_eorca1_bilinear.nc' , '' , '' ln_NCAR = .true. ! "NCAR" algorithm (Large and Yeager 2008) cn_dir = '/hpcdata/scratch/agn/OSMOSIS/FORCING/IAF_CORE/' ! root directory for the location of the flux files / !----------------------------------------------------------------------- &namsbc_cpl ! coupled ocean/atmosphere model ("key_oasis3") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_sas ! Stand-Alone Surface boundary condition !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_iif ! Ice-IF : use observed ice cover (nn_ice = 1) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namtra_qsr ! penetrative solar radiation (ln_traqsr =T) !----------------------------------------------------------------------- ! ! 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_chl ='merged_ESACCI_BIOMER4V1R1_CHL_REG05', -1 , 'CHLA' , .true. , .true. , 'yearly' , 'weights_reg05_2_eorca1_bilinear.nc' , '' , '' cn_dir = '/hpcdata/scratch/agn/OSMOSIS/FORCING/SHACONEMO_eORCA_LIM3/' ! root directory for the location of the flux files ln_qsr_rgb = .false. ! RGB (Red-Green-Blue) light penetration ln_qsr_2bd = .true. ! 2 bands light penetration ln_qsr_bio = .false. ! bio-model light penetration nn_chldta = 1 ! RGB : Chl data (=1) or cst value (=0) rn_abs = 0.58 ! RGB & 2 bands: fraction of light (rn_si1) rn_si0 = 0.35 ! RGB & 2 bands: shortess depth of extinction rn_si1 = 23.0 ! 2 bands: longest depth of extinction / !----------------------------------------------------------------------- &namsbc_rnf ! runoffs namelist surface boundary condition (ln_rnf =T) !----------------------------------------------------------------------- ! ! 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_rnf = 'runoff-icb_DaiTrenberth_Depoorter_eORCA1_JD.nc', -1 , 'sorunoff', .true. , .true. , 'yearly' , '' , '' , '' sn_cnf = 'runoff-icb_DaiTrenberth_Depoorter_eORCA1_JD.nc', 0 , 'socoeff' , .false. , .true. , 'yearly' , '' , '' , '' cn_dir = '/hpcdata/scratch/agn/OSMOSIS/FORCING/SHACONEMO_eORCA_LIM3/' ! root directory for the location of the flux files ln_rnf_mouth = .false. ! specific treatment at rivers mouths ln_rnf_depth = .false. ! read in depth information for runoff ln_rnf_tem = .false. ! read in temperature information for runoff ln_rnf_sal = .false. ! read in salinity information for runoff ln_rnf_depth_ini = .false. !.true. ! compute depth at initialisation from runoff file rn_rnf_max = 0.05 ! max value of the runoff climatology over global domain ( if ln_rnf_depth_ini = .true ) rn_dep_max = 150. ! depth over which runoffs is spread ( ln_rnf_depth_ini = .true ) nn_rnf_depth_file = 0 ! create (=1) a runoff depth file or not (=0) / !----------------------------------------------------------------------- &namsbc_isf ! Top boundary layer (ISF) (nn_isf >0) !----------------------------------------------------------------------- ! ! 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_rnfisf = 'runoff-icb_DaiTrenberth_Depoorter_eORCA1_JD.nc' , -12 ,'sornfisf' , .false. , .true. , 'yearly' , '' , '' , '' sn_depmax_isf = 'runoff-icb_DaiTrenberth_Depoorter_eORCA1_JD.nc' , -12 ,'sodepmax_isf' , .false. , .true. , 'yearly' , '' , '' , '' sn_depmin_isf = 'runoff-icb_DaiTrenberth_Depoorter_eORCA1_JD.nc' , -12 ,'sodepmin_isf' , .false. , .true. , 'yearly' , '' , '' , '' nn_isf = 3 ! 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) / !----------------------------------------------------------------------- &namsbc_iscpl ! land ice / ocean coupling option !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_apr ! Atmospheric pressure used as ocean forcing (ln_apr_dyn =T) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_ssr ! surface boundary condition : sea surface restoring (ln_ssr =T) !----------------------------------------------------------------------- ! ! 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_sss = 'sss_absolute_salinity_WOA13_decav_Reg1L75_clim', -1. , 'sosaline', .true. , .true. , 'yearly' , 'weights_WOA13d1_2_eorca1_bilinear.nc' , '' , '' cn_dir = '/hpcdata/scratch/agn/OSMOSIS/FORCING/SHACONEMO_eORCA_LIM3/' ! root directory for the location of the flux files rn_deds = -166.67 ! magnitude of the damping on salinity [mm/day] ln_sssr_bnd = .true. ! flag to bound erp term (associated with nn_sssr=2) rn_sssr_bnd = 4.e0 ! ABS(Max/Min) value of the damping erp term [mm/day] / !----------------------------------------------------------------------- &namsbc_wave ! External fields from wave model (ln_wave=T) !----------------------------------------------------------------------- ! ! 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_cdg = 'sdw_wave' , 1 , 'drag_coeff' , .true. , .false. , 'yearly' , '' , '' , '' sn_usd = 'ust' , 6 , 'ust' , .true. , .false. , 'monthly' , 'weights_grid05_eORCA1_bicubic.nc' , 'U1' , '' sn_vsd = 'vst' , 6 , 'vst' , .true. , .false. , 'monthly' , 'weights_grid05_eORCA1_bicubic.nc' , 'V1' , '' sn_hsw = 'swh' , 6 , 'swh' , .true. , .false. , 'monthly' , 'weights_grid05_eORCA1_bilin.nc' , '' , '' sn_wmp = 'mwp' , 6 , 'mwp' , .true. , .false. , 'monthly' , 'weights_grid05_eORCA1_bilin.nc' , '' , '' ! sn_wnum = 'sdw_wave' , 1 , 'wave_num' , .true. , .false. , 'yearly' , '' , '' , '' ! sn_tauoc = 'sdw_wave' , 1 , 'wave_stress', .true. , .false. , 'yearly' , '' , '' , '' ! cn_dir = '/hpcdata/scratch/agn/OSMOSIS/FORCING/ERA_INTERIM/WAVES/' ! root directory for the location of the flux files / !----------------------------------------------------------------------- &namberg ! iceberg parameters (default: No iceberg) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &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 !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nambdy ! unstructured open boundaries !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nambdy_dta ! open boundaries - external data !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nambdy_tide ! tidal forcing at open boundaries !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namdrg ! top/bottom drag coefficient (default: NO selection) !----------------------------------------------------------------------- ln_lin = .true. ! linear drag: Cd = Cd0 Uc0 / !----------------------------------------------------------------------- &namdrg_top ! TOP friction (ln_isfcav=T) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namdrg_bot ! BOTTOM friction !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nambbc ! bottom temperature boundary condition (default: NO) !----------------------------------------------------------------------- ! ! 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_qgh ='Goutorbe_ghflux.nc', -12. , 'gh_flux' , .false. , .true. , 'yearly' , 'weights_Goutorbe1_2_eorca1_bilinear.nc' , '' , '' ! ln_trabbc = .true. ! Apply a geothermal heating at the ocean bottom nn_geoflx = 2 ! geothermal heat flux: = 0 no flux ! ! = 1 constant flux ! ! = 2 variable flux (read in geothermal_heating.nc in mW/m2) rn_geoflx_cst = 86.4e-3 ! Constant value of geothermal heat flux [W/m2] cn_dir = '/hpcdata/scratch/agn/OSMOSIS/FORCING/SHACONEMO_eORCA_LIM3/' ! root directory for the location of the flux files / !----------------------------------------------------------------------- &nambbl ! bottom boundary layer scheme (default: NO) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nameos ! ocean Equation Of Seawater (default: NO) !----------------------------------------------------------------------- ln_teos10 = .true. ! = Use TEOS-10 equation of state / !----------------------------------------------------------------------- &namtra_adv ! advection scheme for tracer (default: NO selection) !----------------------------------------------------------------------- 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 / !----------------------------------------------------------------------- &namtra_mle ! mixed layer eddy parametrisation (Fox-Kemper param) (default: NO) !----------------------------------------------------------------------- ln_mle = .true. ! (T) use the Mixed Layer Eddy (MLE) parameterisation rn_ce = 0.04 ! magnitude of the MLE (typical value: 0.06 to 0.08) / !----------------------------------------------------------------------- &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_iso = .true. ! iso-neutral (standard operator) ln_traldf_triad = .false. ! iso-neutral (triad operator) ! ! ! iso-neutral options: ln_traldf_msc = .true. ! 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 = 20 ! space/time variation of eddy coefficient: ! ! =-20 (=-30) read in eddy_diffusivity_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) ! ! time invariant coefficients: aht0 = 1/2 Ud*Ld (lap case) ! ! or = 1/12 Ud*Ld^3 (blp case) / !----------------------------------------------------------------------- &namtra_ldfeiv ! eddy induced velocity param. (default: NO) !----------------------------------------------------------------------- ln_ldfeiv = .true. ! use eddy induced velocity parameterization rn_aeiv_0 = 1000. ! eddy induced velocity coefficient [m2/s] nn_aei_ijk_t = 21 ! space/time variation of the eiv coeficient ! ! =-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 ln_ldfeiv_dia =.true. ! diagnose eiv stream function and velocities / !----------------------------------------------------------------------- &namtra_dmp ! tracer: T & S newtonian damping (default: NO) !----------------------------------------------------------------------- ln_tradmp = .false. / !----------------------------------------------------------------------- &nam_vvl ! vertical coordinate options (default: z-star) !----------------------------------------------------------------------- ln_vvl_zstar = .true. ! z-star vertical coordinate / !----------------------------------------------------------------------- &namdyn_adv ! formulation of the momentum advection (default: NO selection) !----------------------------------------------------------------------- ln_dynadv_vec = .true. ! vector form - 2nd centered scheme nn_dynkeg = 0 ! grad(KE) scheme: =0 C2 ; =1 Hollingsworth correction ln_dynadv_cen2 = .false. ! flux form - 2nd order centered scheme / !----------------------------------------------------------------------- &namdyn_vor ! Vorticity / Coriolis scheme (default: NO) !----------------------------------------------------------------------- ln_dynvor_een = .true. ! 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 (default: NO selection) !----------------------------------------------------------------------- ln_hpg_sco = .true. ! s-coordinate (standard jacobian formulation) / !----------------------------------------------------------------------- &namdyn_spg ! surface pressure gradient (default: NO) !----------------------------------------------------------------------- ln_dynspg_ts = .true. ! split-explicit free surface ln_bt_fw = .false. ! 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 " " 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 rn_bt_alpha = 0. ! Temporal diffusion parameter (if ln_bt_av=F) / !----------------------------------------------------------------------- &namdyn_ldf ! lateral diffusion on momentum (default: NO selection) !----------------------------------------------------------------------- ! ! Type of the operator : ! ! no diffusion: set ln_dynldf_lap=..._blp=F ln_dynldf_lap = .true. ! laplacian operator ! ! Direction of action : ln_dynldf_lev = .true. ! iso-level ! ! Coefficient nn_ahm_ijk_t = 30 ! 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) ! ! = 32 F(i,j,k)=F(local gridscale and deformation rate) ! ! time invariant coefficients : ahm = 1/2 Uv*Lv (lap case) ! ! or = 1/12 Uv*Lv^3 (blp case) / !----------------------------------------------------------------------- &namzdf ! vertical physics (default: NO selection) !----------------------------------------------------------------------- ln_zdfosm = .true. ! OSMOSIS BL closure (T => fill namzdf_osm) ln_zdftke = .false. ! ! ! convection ln_zdfevd = .false. ! enhanced vertical diffusion rn_avm0 = 1.2e-4 ! vertical eddy viscosity [m2/s] (background Kz if ln_zdfcst=F) rn_avt0 = 1.2e-5 ! vertical eddy diffusivity [m2/s] (background Kz if ln_zdfcst=F) / !----------------------------------------------------------------------- &namzdf_ric ! richardson number dependent vertical diffusion (ln_zdfric =T) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namzdf_tke ! turbulent eddy kinetic dependent vertical diffusion (ln_zdftke =T) !----------------------------------------------------------------------- ! nn_etau = 0 ! penetration of tke below the mixed layer (ML) due to NIWs ! = 0 none ; = 1 add a tke source below the ML ! = 2 add a tke source just at the base of the ML ! = 3 as = 1 applied on HF part of the stress (ln_cpl=T) / !----------------------------------------------------------------------- &namzdf_gls ! GLS vertical diffusion (ln_zdfgls =T) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namzdf_osm ! OSM vertical diffusion (ln_zdfosm =T) !----------------------------------------------------------------------- ln_use_osm_la = .false. ! Use namelist rn_osm_la rn_osm_la = 0.3 ! Turbulent Langmuir number rn_osm_dstokes = 5. ! Depth scale of Stokes drift (m) nn_ave = 0 ! choice of horizontal averaging on avt, avmu, avmv ln_dia_osm = .true. ! output OSMOSIS-OBL variables rn_osm_hbl0 = 10. ! initial hbl value ln_kpprimix = .true. ! Use KPP-style Ri# mixing below BL rn_riinfty = 0.7 ! Highest local Ri_g permitting shear instability rn_difri = 0.005 ! max Ri# diffusivity at Ri_g = 0 (m^2/s) ln_convmix = .true. ! Use convective instability mixing below BL rn_difconv = 1. !0.01 !1. ! diffusivity when unstable below BL (m2/s) nn_osm_wave = 2 ! Method used to calculate Stokes drift ! = 2: Use ECMWF wave fields ! = 1: Pierson Moskowitz wave spectrum ! = 0: Constant La# = 0.3 !========================only if key_FK_osm is set ================================= ln_osm_mle = .true. ! Use integrated FK-OSM model / !----------------------------------------------------------------------- &namosm_mle ! mixed layer eddy parametrisation (Fox-Kemper) (default: OFF) !----------------------------------------------------------------------- rn_osm_mle_ce = 0.04 ! 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 = 43200 !172800. ! 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.03 ! 0.01 ! delta rho criterion used to calculate MLD for FK rn_osm_mle_thresh = 0.0001 ! delta b criterion used for FK MLD criterion rn_osm_mle_tau = 172800. ! time scale for FK-OSM (seconds) (case rn_osm_mle=0) !========================only if key_FK_osm is set ================================= / !----------------------------------------------------------------------- &namzdf_iwm ! internal wave-driven mixing parameterization (ln_zdfiwm =T) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nammpp ! Massively Parallel Processing ("key_mpp_mpi") !----------------------------------------------------------------------- ln_nnogather = .true. ! activate code to avoid mpi_allgather use at the northfold jpni = 16 !12 !16 !12 !16 !12 !16 ! 12 jpni number of processors following i (set automatically if < 1) jpnj = 15 !6 !15 !6 !15 !6 ! 15 ! 8 jpnj number of processors following j (set automatically if < 1) / !----------------------------------------------------------------------- &namctl ! Control prints !----------------------------------------------------------------------- ln_ctl = .false. ! Toggle all report printing on/off (T/F); Ignored if sn_cfctl%l_config is T / !----------------------------------------------------------------------- &namsto ! Stochastic parametrization of EOS (default: NO) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namtrd ! trend diagnostics (default F) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namptr ! Poleward Transport Diagnostic (default F) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namhsb ! Heat and salt budgets (default F) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namhth ! Extra ML depth and thermocline depth diagnostics (default F) !----------------------------------------------------------------------- ln_diahth = .true. ! produce extra diagnostics of BL and thermocline depth / !----------------------------------------------------------------------- &namdiu ! Cool skin and warm layer models (default F) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namflo ! float parameters ("key_float") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nam_diaharm ! Harmonic analysis of tidal constituents ("key_diaharm") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namdct ! transports through some sections ("key_diadct") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nam_diatmb ! Top Middle Bottom Output (default F) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nam_dia25h ! 25h Mean Output (default F) !----------------------------------------------------------------------- ln_dia25h = .false. ! Choose 25h mean output or not /