!!>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>> !! NEMO/OPA Configuration namelist : used to overwrite defaults values defined in SHARED/namelist_ref !!>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>> ! !----------------------------------------------------------------------- &namrun ! parameters of the run !----------------------------------------------------------------------- cn_exp = "VORTEX" ! experience name nn_date0 = 19500101 ! initial date nn_it000 = 1 ! first time step nn_itend = 18000 ! last time step (std 5475) nn_stock = 0 ! frequency of creation of a restart file (modulo referenced to 1) nn_istate = 0 ! output the initial state (1) or not (0) / !----------------------------------------------------------------------- &namagrif ! AGRIF zoom ("key_agrif") !----------------------------------------------------------------------- nn_cln_update = 1 ! baroclinic update frequency ln_spc_dyn = .true. ! use 0 as special value for dynamics rn_sponge_tra = 800. ! coefficient for tracer sponge layer [m2/s] rn_sponge_dyn = 800. ! coefficient for dynamics sponge layer [m2/s] / !----------------------------------------------------------------------- &namcfg ! parameters of the configuration !----------------------------------------------------------------------- cp_cfg = "vortex" ! name of the configuration cp_cfz = '' ! name of the zoom of configuration jp_cfg = 0 ! resolution of the configuration jpidta = 63 ! 1st lateral dimension ( >= jpi ) jpjdta = 63 ! 2nd " " ( >= jpj ) jpkdta = 11 ! number of levels ( >= jpk ) jpiglo = 63 ! 1st dimension of global domain --> i =jpidta jpjglo = 63 ! 2nd - - --> j =jpjdta jpizoom = 1 ! left bottom (i,j) indices of the zoom jpjzoom = 1 ! in data domain indices jperio = 0 ! lateral cond. type (between 0 and 6) / !----------------------------------------------------------------------- &namzgr ! vertical coordinate !----------------------------------------------------------------------- ln_zco = .true. ! z-coordinate - full steps (T/F) ("key_zco" may also be defined) ln_zps = .false. ! z-coordinate - partial steps (T/F) / !----------------------------------------------------------------------- &nam_vvl ! vertical coordinate options !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namdom ! space and time domain (bathymetry, mesh, timestep) !----------------------------------------------------------------------- nn_msh = 0 ! create (=1) a mesh file or not (=0) nn_bathy = 0 ! compute (=0) or read (=1) the bathymetry file rn_bathy = 5000. ! value of the bathymetry. if (=0) bottom flat at jpkm1 ! rn_rdt = 480. ! time step for the dynamics (and tracer if nn_acc=0) rn_atfp = 0.05 ! asselin time filter parameter jphgr_msh = 3 ! type of horizontal mesh ! = 0 curvilinear coordinate on the sphere read in coordinate.nc ! = 1 geographical mesh on the sphere with regular grid-spacing ! = 2 f-plane with regular grid-spacing ! = 3 beta-plane with regular grid-spacing ! = 4 Mercator grid with T/U point at the equator ppgphi0 = 38.5 ! latitude of first raw and column T-point (jphgr_msh = 1) ppe1_m = 30000.0 ! zonal grid-spacing (meters) ppe2_m = 30000.0 ! meridional grid-spacing (meters) ppsur = 999999. ! ORCA r4, r2 and r05 coefficients ppa0 = 999999. ! (default coefficients) ppa1 = 999999. ! ppkth = 0. ! =0 means uniform vertical grid pphmax = 5000. ! Maximum depth ldbletanh = .FALSE. ! Use/do not use double tanf function for vertical coordinates / !----------------------------------------------------------------------- &namsplit ! time splitting parameters ("key_dynspg_ts") !----------------------------------------------------------------------- ln_bt_nn_auto = .FALSE. ! Set nn_baro automatically to be just below ! a user defined maximum courant number (rn_bt_cmax) nn_baro = 24 ! Number of iterations of barotropic mode ! during rn_rdt seconds. Only used if ln_bt_nn_auto=F / !----------------------------------------------------------------------- &namcrs ! Grid coarsening for dynamics output and/or ! passive tracer coarsened online simulations !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namtsd ! data : Temperature & Salinity !----------------------------------------------------------------------- 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) !----------------------------------------------------------------------- ln_ana = .true. ! analytical formulation (T => fill namsbc_ana ) ln_blk_core = .false. ! CORE bulk formulation (T => fill namsbc_core) nn_ice = 0 ! =0 no ice boundary condition , ln_rnf = .false. ! runoffs (T => fill namsbc_rnf) ln_ssr = .false. ! Sea Surface Restoring on T and/or S (T => fill namsbc_ssr) nn_fwb = 0 ! FreshWater Budget: =0 unchecked / !----------------------------------------------------------------------- &namsbc_ana ! analytical surface boundary condition !----------------------------------------------------------------------- rn_utau0 = 0.e0 ! uniform value for the i-stress / !----------------------------------------------------------------------- &namsbc_core ! namsbc_core CORE bulk formulae !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namtra_qsr ! penetrative solar radiation !----------------------------------------------------------------------- ln_traqsr = .false. ! Light penetration (T) or not (F) / !----------------------------------------------------------------------- &namsbc_rnf ! runoffs namelist surface boundary condition !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_ssr ! surface boundary condition : sea surface restoring !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsbc_alb ! albedo parameters !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namberg ! iceberg parameters !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namlbc ! lateral momentum boundary condition !----------------------------------------------------------------------- rn_shlat = 0 ! shlat = 0 ! 0 < shlat < 2 ! shlat = 2 ! 2 < shlat ! free slip ! partial slip ! no slip ! strong slip / !----------------------------------------------------------------------- &namcla ! cross land advection !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nambfr ! bottom friction !----------------------------------------------------------------------- nn_bfr = 0 ! type of bottom friction : = 0 : free slip, = 1 : linear friction ! = 2 : nonlinear friction / !----------------------------------------------------------------------- &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) / !----------------------------------------------------------------------- &nameos ! ocean physical parameters !----------------------------------------------------------------------- nn_eos = 1 ! type of equation of state and Brunt-Vaisala frequency ! =-1, TEOS-10 ! = 0, EOS-80 ! = 1, S-EOS (simplified eos) ln_useCT = .false. ! use of Conservative Temp. ==> surface CT converted in Pot. Temp. in sbcssm ! ! ! ! S-EOS coefficients : ! ! rd(T,S,Z)*rau0 = -a0*(1+.5*lambda*dT+mu*Z+nu*dS)*dT+b0*dS rn_a0 = 0.28 ! thermal expension coefficient (nn_eos= 1) rn_b0 = 0. ! saline expension coefficient (nn_eos= 1) rn_lambda1 = 0. ! cabbeling coeff in T^2 (=0 for linear eos) rn_lambda2 = 0. ! cabbeling coeff in S^2 (=0 for linear eos) rn_mu1 = 0. ! thermobaric coeff. in T (=0 for linear eos) rn_mu2 = 0. ! thermobaric coeff. in S (=0 for linear eos) rn_nu = 0. ! cabbeling coeff in T*S (=0 for linear eos) / !----------------------------------------------------------------------- &namtra_adv ! advection scheme for tracer !----------------------------------------------------------------------- ln_traadv_cen2 = .false. ! 2nd order centered scheme ln_traadv_tvd = .false. ! TVD scheme ln_traadv_ubs = .true. ! UBS scheme / !----------------------------------------------------------------------- &namtra_adv_mle ! mixed layer eddy parametrisation (Fox-Kemper param) !----------------------------------------------------------------------- ln_mle = .false. ! (T) use the Mixed Layer Eddy (MLE) parameterisation / !----------------------------------------------------------------------- &namtra_adv_mle ! mixed layer eddy parametrisation (Fox-Kemper param) !----------------------------------------------------------------------- / !---------------------------------------------------------------------------------- &namtra_ldf ! lateral diffusion scheme for tracers !---------------------------------------------------------------------------------- ! ! Operator type: ln_traldf_lap = .false. ! laplacian operator ln_traldf_bilap = .false. ! bilaplacian operator ! ! Direction of action: ln_traldf_level = .false. ! iso-level ln_traldf_hor = .true. ! horizontal (geopotential) (needs "key_ldfslp" when ln_sco=T) ln_traldf_iso = .false. ! iso-neutral (needs "key_ldfslp") / !----------------------------------------------------------------------- &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 !----------------------------------------------------------------------- ln_dynadv_vec = .false. ! vector form (T) or flux form (F) nn_dynkeg = 0 ! scheme for grad(KE): =0 C2 ; =1 Hollingsworth correction ln_dynadv_cen2= .false. ! flux form - 2nd order centered scheme ln_dynadv_ubs = .true. ! flux form - 3rd order UBS scheme ln_dynzad_zts = .false. ! Use (T) sub timestepping for vertical momentum advection / !----------------------------------------------------------------------- &namdyn_vor ! option of physics/algorithm (not control by CPP keys) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namdyn_hpg ! Hydrostatic pressure gradient option !----------------------------------------------------------------------- ln_hpg_zps = .false. ! z-coordinate - partial steps (interpolation) ln_hpg_sco = .true. ! s-coordinate (standard jacobian formulation) / !----------------------------------------------------------------------- &namdyn_ldf ! lateral diffusion on momentum !----------------------------------------------------------------------- ! ! Type of the operator : ln_dynldf_lap = .false. ! laplacian operator ln_dynldf_bilap = .false. ! bilaplacian operator ! ! Direction of action : ln_dynldf_level = .false. ! iso-level ln_dynldf_hor = .true. ! horizontal (geopotential) (require "key_ldfslp" in s-coord.) ln_dynldf_iso = .false. ! iso-neutral (require "key_ldfslp") ! ! Coefficient / !----------------------------------------------------------------------- &namzdf ! vertical physics !----------------------------------------------------------------------- rn_avm0 = 0.e-4 ! vertical eddy viscosity [m2/s] (background Kz if not "key_zdfcst") rn_avt0 = 0.e-5 ! vertical eddy diffusivity [m2/s] (background Kz if not "key_zdfcst") ln_zdfevd = .true. ! enhanced vertical diffusion (evd) (T) or not (F) nn_evdm = 0 ! evd apply on tracer (=0) or on tracer and momentum (=1) rn_avevd = 0. ! evd mixing coefficient [m2/s] / !----------------------------------------------------------------------- &nambdy ! unstructured open boundaries ("key_bdy") nb_bdy = 0 ! number of open boundary sets ln_coords_file = .false.,.false.,.false.,.false. ! =T : read bdy coordinates from file cn_coords_file = '','','','' ! bdy coordinates files ln_mask_file = .false. ! =T : read mask from file cn_mask_file = '' ! name of mask file (if ln_mask_file=.TRUE.) cn_dyn2d = 'flather','flather','flather','flather' ! nn_dyn2d_dta = 0,0,0,0 ! = 0, bdy data are equal to the initial state ! = 1, bdy data are read in 'bdydata .nc' files ! = 2, use tidal harmonic forcing data from files ! = 3, use external data AND tidal harmonic forcing cn_dyn3d = 'specified','specified','specified','specified' ! nn_dyn3d_dta = 0,0,0,0 ! = 0, bdy data are equal to the initial state ! = 1, bdy data are read in 'bdydata .nc' files cn_tra = 'specified','specified','specified','specified' ! nn_tra_dta = 0,0,0,0 ! = 0, bdy data are equal to the initial state ! = 1, bdy data are read in 'bdydata .nc' files ln_tra_dmp =.false.,.false.,.false.,.false. ! open boudaries conditions for tracers ln_dyn3d_dmp =.false.,.false.,.false.,.false. ! open boundary condition for baroclinic velocities rn_time_dmp = 100., 100., 100., 100. ! Damping time scale in days rn_time_dmp_out = 100., 100., 100., 100. ! Outflow damping time scale nn_rimwidth = 1, 1, 1, 1 ! width of the relaxation zone ln_vol = .false. ! total volume correction (see nn_volctl parameter) nn_volctl = 1 ! = 0, the total water flux across open boundaries is zero / !----------------------------------------------------------------------- &nambdy_index ! structured open boundaries definition ("key_bdy") !----------------------------------------------------------------------- ctypebdy ='S' ! Open boundary type (W,E,S or N) nbdyind = -1 ! indice of velocity row or column ! if ==-1, set obc at the domain boundary ! , discard start and end indices nbdybeg = -99 ! indice of segment start nbdyend = -99 ! indice of segment end / !----------------------------------------------------------------------- &nambdy_index ! structured open boundaries definition ("key_bdy") !----------------------------------------------------------------------- ctypebdy ='N' ! Open boundary type (W,E,S or N) nbdyind = -1 ! indice of velocity row or column ! if ==-1, set obc at the domain boundary ! , discard start and end indices nbdybeg = -99 ! indice of segment start nbdyend = -99 ! indice of segment end / !----------------------------------------------------------------------- &nambdy_index ! structured open boundaries definition ("key_bdy") !----------------------------------------------------------------------- ctypebdy ='W' ! Open boundary type (W,E,S or N) nbdyind = -1 ! indice of velocity row or column ! if ==-1, set obc at the domain boundary ! , discard start and end indices nbdybeg = -99 ! indice of segment start nbdyend = -99 ! indice of segment end / !----------------------------------------------------------------------- &nambdy_index ! structured open boundaries definition ("key_bdy") !----------------------------------------------------------------------- ctypebdy ='E' ! Open boundary type (W,E,S or N) nbdyind = -1 ! indice of velocity row or column ! if ==-1, set obc at the domain boundary ! , discard start and end indices nbdybeg = -99 ! indice of segment start nbdyend = -99 ! indice of segment end / !----------------------------------------------------------------------- &namzdf_tke ! turbulent eddy kinetic dependent vertical diffusion ("key_zdftke") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namzdf_ddm ! double diffusive mixing parameterization ("key_zdfddm") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namzdf_tmx ! tidal mixing parameterization ("key_zdftmx") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namzdf_tmx_new ! new tidal mixing parameterization ("key_zdftmx_new") !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsol ! elliptic solver / island / free surface !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nammpp ! Massively Parallel Processing ("key_mpp_mpi) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namctl ! Control prints & Benchmark !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namptr ! Poleward Transport Diagnostic !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namhsb ! Heat and salt budgets !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namdyn_nept ! Neptune effect (simplified: lateral and vertical diffusions removed) !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namobs ! observation usage ('key_diaobs') !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &nam_asminc ! assimilation increments ('key_asminc') !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namsto ! Stochastic parametrization of EOS !----------------------------------------------------------------------- / !----------------------------------------------------------------------- &namtrd ! diagnostics on dynamics and/or tracer trends ! ! and/or mixed-layer trends and/or barotropic vorticity !----------------------------------------------------------------------- /