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 113 additions and 80 deletions
......@@ -9,8 +9,8 @@
nn_time0 = 0 ! initial time of day in hhmm
nn_leapy = 0 ! Leap year calendar (1) or not (0)
ln_rstart = .false. ! start from rest (F) or from a restart file (T)
nn_euler = 1 ! = 0 : start with forward time step if ln_rstart=T
nn_rstctl = 0 ! restart control ==> activated only if ln_rstart=T
ln_1st_euler = .false. ! =T force a start with forward time step (ln_rstart=T)
nn_rstctl = 0 ! restart control ==> activated only if ln_rstart=T
! ! = 0 nn_date0 read in namelist ; nn_it000 : read in namelist
! ! = 1 nn_date0 read in namelist ; nn_it000 : check consistancy between namelist and restart
! ! = 2 nn_date0 read in restart ; nn_it000 : check consistancy between namelist and restart
......@@ -18,7 +18,6 @@
cn_ocerst_indir = "." ! directory from which to read input ocean restarts
cn_ocerst_out = "restart" ! suffix of ocean restart name (output)
cn_ocerst_outdir = "." ! directory in which to write output ocean restarts
ln_iscpl = .false. ! cavity evolution forcing or coupling to ice sheet model
nn_istate = 0 ! 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 = 0 ! used only if ln_rst_list = F: output restart freqeuncy (modulo referenced to 1)
......@@ -32,6 +31,6 @@
ln_cfmeta = .false. ! output additional data to netCDF files required for compliance with the CF metadata standard
ln_clobber = .true. ! clobber (overwrite) an existing file
nn_chunksz = 0 ! chunksize (bytes) for NetCDF file (works only with iom_nf90 routines)
ln_xios_read = .FALSE. ! use XIOS to read restart file (only for a single file restart)
ln_xios_read = .false. ! use XIOS to read restart file (only for a single file restart)
nn_wxios = 0 ! use XIOS to write restart file 0 - no, 1 - single file output, 2 - multiple file output
/
......@@ -3,25 +3,25 @@
!-----------------------------------------------------------------------
nn_fsbc = 2 ! frequency of SBC module call
! ! (control sea-ice & iceberg model call)
! Type of air-sea fluxes
! Type of air-sea fluxes
ln_usr = .false. ! user defined formulation (T => check usrdef_sbc)
ln_flx = .false. ! flux formulation (T => fill namsbc_flx )
ln_blk = .false. ! Bulk formulation (T => fill namsbc_blk )
ln_abl = .false. ! ABL formulation (T => fill namsbc_abl )
! ! Type of coupling (Ocean/Ice/Atmosphere) :
ln_cpl = .false. ! atmosphere coupled formulation ( requires key_oasis3 )
ln_mixcpl = .false. ! forced-coupled mixed formulation ( requires key_oasis3 )
nn_components = 0 ! configuration of the opa-sas OASIS coupling
! ! =0 no opa-sas OASIS coupling: default single executable config.
! ! =1 opa-sas OASIS coupling: multi executable config., OPA component
! ! =2 opa-sas OASIS coupling: multi executable config., SAS component
! ! =1 opa-sas OASIS coupling: multi executable config., OCE component
! ! =2 opa-sas OASIS coupling: multi executable config., SAS component
! Sea-ice :
nn_ice = 0 ! =0 no ice boundary condition
nn_ice = 0 ! =0 no ice boundary condition
! ! =1 use observed ice-cover ( => fill namsbc_iif )
! ! =2 or 3 automatically for SI3 or CICE ("key_si3" or "key_cice")
! ! except in AGRIF zoom where it has to be specified
! ! =2 or 3 for SI3 and CICE, respectively
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 :
! Misc. options of sbc :
ln_traqsr = .false. ! Light penetration in the ocean (T => fill namtra_qsr)
ln_dm2dc = .false. ! daily mean to diurnal cycle on short wave
ln_ssr = .false. ! Sea Surface Restoring on T and/or S (T => fill namsbc_ssr)
......@@ -30,7 +30,6 @@
! ! =2 annual global mean of e-p-r set to zero
ln_rnf = .false. ! runoffs (T => fill namsbc_rnf)
ln_apr_dyn = .false. ! Patm gradient added in ocean & ice Eqs. (T => fill namsbc_apr )
ln_isf = .false. ! ice shelf (T => fill namsbc_isf & namsbc_iscpl)
ln_wave = .false. ! Activate coupling with wave (T => 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)
......
......@@ -2,27 +2,37 @@
&namsbc_blk ! namsbc_blk generic Bulk formula (ln_blk =T)
!-----------------------------------------------------------------------
! ! bulk algorithm :
ln_NCAR = .true. ! "NCAR" algorithm (Large and Yeager 2008)
ln_COARE_3p0 = .false. ! "COARE 3.0" algorithm (Fairall et al. 2003)
ln_COARE_3p6 = .false. ! "COARE 3.6" algorithm (Edson et al. 2013)
ln_ECMWF = .false. ! "ECMWF" algorithm (IFS cycle 45r1)
!
rn_zqt = 10. ! Air temperature & humidity reference height (m)
rn_zu = 10. ! Wind vector reference height (m)
ln_Cd_L12 = .false. ! air-ice drags = F(ice conc.) (Lupkes et al. 2012)
ln_Cd_L15 = .false. ! air-ice drags = F(ice conc.) (Lupkes et al. 2015)
! ! - module of the mean stress" data
rn_pfac = 1. ! multipl. factor for precipitation (total & snow)
rn_efac = 1. ! multipl. factor for evaporation (0. or 1.)
rn_vfac = 0. ! multipl. factor for ocean & ice velocity
! ! used to calculate the wind stress
! ! (0. => absolute or 1. => relative winds)
ln_skin_cs = .false. ! use the cool-skin parameterization
ln_skin_wl = .false. ! use the warm-layer parameterization
! ! ==> only available in ECMWF and COARE algorithms
ln_humi_sph = .true. ! humidity "sn_humi" is specific humidity [kg/kg]
ln_humi_dpt = .false. ! humidity "sn_humi" is dew-point temperature [K]
ln_humi_rlh = .false. ! humidity "sn_humi" is relative humidity [%]
ln_NCAR = .true. ! "NCAR" algorithm (Large and Yeager 2008)
ln_COARE_3p0 = .false. ! "COARE 3.0" algorithm (Fairall et al. 2003)
ln_COARE_3p6 = .false. ! "COARE 3.6" algorithm (Edson et al. 2013)
ln_ECMWF = .false. ! "ECMWF" algorithm (IFS cycle 45r1)
ln_ANDREAS = .false. ! "ANDREAS" algorithm (Andreas et al. 2015)
rn_zqt = 10. ! Air temperature & humidity reference height (m)
rn_zu = 10. ! Wind vector reference height (m)
nn_iter_algo = 5 ! Number of iterations in bulk param. algo ("stable ABL + weak wind" requires more)
ln_skin_cs = .false. ! use the cool-skin parameterization => use at least nn_iter_algo > 10
ln_skin_wl = .false. ! use the warm-layer parameterization => use at least nn_iter_algo > 10
!
rn_pfac = 1. ! multipl. factor for precipitation (total & snow)
rn_efac = 1. ! multipl. factor for evaporation (0. or 1.)
!
ln_crt_fbk = .false. ! Add surface current feedback to the wind stress (Renault et al. 2020, doi: 10.1029/2019MS001715)
rn_stau_a = -2.9e-3 ! Alpha from eq. 10: Stau = Alpha * Wnd + Beta
rn_stau_b = 8.0e-3 ! Beta
!
ln_humi_sph = .true. ! humidity "sn_humi" is specific humidity [kg/kg]
ln_humi_dpt = .false. ! humidity "sn_humi" is dew-point temperature [K]
ln_humi_rlh = .false. ! humidity "sn_humi" is relative humidity [%]
ln_tair_pot = .false. ! air temperature read in "sn_tair" is already POTENTIAL TEMPERATURE, NOT ABSOLUTE (ECMWF => ln_tair_pot=.false.)
!!
!! Bulk transfer coefficients over sea-ice: (relevant IF: nn_ice >=1 )
ln_Cx_ice_cst = .true. ! use constant ice-air bulk transfer coefficients (value given below)
rn_Cd_i = 1.4e-3 ! sea-ice drag coefficient
rn_Ce_i = 1.4e-3 ! " sublimation coefficient
rn_Ch_i = 1.4e-3 ! " sensible heat flux coefficient
ln_Cx_ice_AN05 = .false. ! (Andreas et al. 2005)
ln_Cx_ice_LU12 = .false. ! (Lupkes et al. 2012)
ln_Cx_ice_LG15 = .false. ! (Lupkes & Gryanik 2015)
!
cn_dir = './' ! root directory for the bulk data location
!___________!_________________________!___________________!___________!_____________!________!___________!______________________________________!__________!_______________!
......
......@@ -34,23 +34,22 @@
sn_rcv_rnf = 'coupled' , 'no' , '' , '' , ''
sn_rcv_cal = 'coupled' , 'no' , '' , '' , ''
sn_rcv_co2 = 'coupled' , 'no' , '' , '' , ''
sn_rcv_hsig = 'none' , 'no' , '' , '' , ''
sn_rcv_iceflx = 'none' , 'no' , '' , '' , ''
sn_rcv_mslp = 'none' , 'no' , '' , '' , ''
sn_rcv_phioc = 'none' , 'no' , '' , '' , ''
sn_rcv_sdrfx = 'none' , 'no' , '' , '' , ''
sn_rcv_sdrfy = 'none' , 'no' , '' , '' , ''
sn_rcv_wper = 'none' , 'no' , '' , '' , ''
sn_rcv_wnum = 'none' , 'no' , '' , '' , ''
sn_rcv_wstrf = 'none' , 'no' , '' , '' , ''
sn_rcv_wdrag = 'none' , 'no' , '' , '' , ''
sn_rcv_ts_ice = 'none' , 'no' , '' , '' , ''
sn_rcv_isf = 'none' , 'no' , '' , '' , ''
sn_rcv_icb = 'none' , 'no' , '' , '' , ''
sn_rcv_wdrag = 'none' , 'no' , '' , '' , ''
sn_rcv_charn = 'none' , 'no' , '' , '' , ''
sn_rcv_hsig = 'none' , 'no' , '' , '' , 'T'
sn_rcv_phioc = 'none' , 'no' , '' , '' , 'T'
sn_rcv_sdrfx = 'none' , 'no' , '' , '' , 'T'
sn_rcv_sdrfy = 'none' , 'no' , '' , '' , 'T'
sn_rcv_wper = 'none' , 'no' , '' , '' , 'T'
sn_rcv_wnum = 'none' , 'no' , '' , '' , 'T'
sn_rcv_wstrf = 'none' , 'no' , '' , '' , 'T'
sn_rcv_wdrag = 'none' , 'no' , '' , '' , 'T'
sn_rcv_charn = 'none' , 'no' , '' , '' , 'T'
sn_rcv_taw = 'none' , 'no' , '' , '' , 'U,V'
sn_rcv_bhd = 'none' , 'no' , '' , '' , ''
sn_rcv_tusd = 'none' , 'no' , '' , '' , ''
sn_rcv_tvsd = 'none' , 'no' , '' , '' , ''
sn_rcv_bhd = 'none' , 'no' , '' , '' , 'T'
sn_rcv_tusd = 'none' , 'no' , '' , '' , 'T'
sn_rcv_tvsd = 'none' , 'no' , '' , '' , 'T'
/
......@@ -2,24 +2,26 @@
&namsbc_rnf ! runoffs (ln_rnf =T)
!-----------------------------------------------------------------------
ln_rnf_mouth = .false. ! specific treatment at rivers mouths
rn_hrnf = 15.e0 ! depth over which enhanced vertical mixing is used (ln_rnf_mouth=T)
rn_avt_rnf = 1.e-3 ! value of the additional vertical mixing coef. [m2/s] (ln_rnf_mouth=T)
rn_rfact = 1.e0 ! multiplicative factor for runoff
rn_hrnf = 15.e0 ! depth over which enhanced vertical mixing is used (ln_rnf_mouth=T)
rn_avt_rnf = 1.e-3 ! value of the additional vertical mixing coef. [m2/s] (ln_rnf_mouth=T)
rn_rfact = 1.e0 ! multiplicative factor for runoff
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. ! compute depth at initialisation from runoff file
rn_rnf_max = 5.735e-4 ! max value of the runoff climatologie over global domain ( 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)
ln_rnf_tem = .false. ! read in temperature information for runoff
ln_rnf_sal = .false. ! read in salinity information for runoff
ln_rnf_icb = .false. ! read iceberg flux
ln_rnf_depth_ini = .false. ! compute depth at initialisation from runoff file
rn_rnf_max = 5.735e-4 ! max value of the runoff climatologie over global domain ( 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)
cn_dir = './' ! root directory for the runoff data location
cn_dir = './' ! root directory for the runoff 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_rnf = 'runoff_core_monthly' , -1. , 'sorunoff', .true. , .true. , 'yearly' , '' , '' , ''
sn_cnf = 'runoff_core_monthly' , 0. , 'socoefr0', .false. , .true. , 'yearly' , '' , '' , ''
sn_cnf = 'runoff_core_monthly' , -12. , 'socoefr0', .false. , .true. , 'yearly' , '' , '' , ''
sn_s_rnf = 'runoffs' , 24. , 'rosaline', .true. , .true. , 'yearly' , '' , '' , ''
sn_t_rnf = 'runoffs' , 24. , 'rotemper', .true. , .true. , 'yearly' , '' , '' , ''
sn_dep_rnf = 'runoffs' , 0. , 'rodepth' , .false. , .true. , 'yearly' , '' , '' , ''
sn_i_rnf = 'NOT USED' , 24. , 'xxxxxxxx', .true. , .true. , 'yearly' , '' , '' , ''
sn_dep_rnf = 'runoffs' , -12. , 'rodepth' , .false. , .true. , 'yearly' , '' , '' , ''
/
......@@ -16,4 +16,9 @@
sn_ssh = 'sas_grid_T' , 120. , 'sossheig', .true. , .true. , 'yearly' , '' , '' , ''
sn_e3t = 'sas_grid_T' , 120. , 'e3t_m' , .true. , .true. , 'yearly' , '' , '' , ''
sn_frq = 'sas_grid_T' , 120. , 'frq_m' , .true. , .true. , 'yearly' , '' , '' , ''
!!
!! Following only needed with STATION_ASF compiled with "sea-ice" support: "key_si3" (ice fraction, ice surface temperature and sea-ice albedo:
sn_ifr = 'NOT USED' , 1. , 'siconc' , .true. , .false. , 'yearly' , '' , '' , ''
sn_tic = 'NOT USED' , 1. , 'istl1' , .true. , .false. , 'yearly' , '' , '' , ''
sn_ial = 'NOT USED' , 1. , 'fal' , .true. , .false. , 'yearly' , '' , '' , ''
/
......@@ -8,6 +8,10 @@
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]
nn_sssr_ice = 1 ! control of sea surface restoring under sea-ice
! 0 = no restoration under ice : * (1-icefrac)
! 1 = restoration everywhere
! >1 = enhanced restoration under ice : 1+(nn_icedmp-1)*icefrac
cn_dir = './' ! root directory for the SST/SSS data location
!___________!_________________________!___________________!___________!_____________!________!___________!__________________!__________!_______________!
......
......@@ -12,7 +12,7 @@
ln_phioc = .false. ! TKE flux from wave model
ln_bern_srfc= .false. ! wave induced pressure. Bernoulli head J term
ln_breivikFV_2016 = .false. ! breivik 2016 vertical stokes profile
ln_vortex_force = .false. ! Vortex Force term
ln_vortex_force = .false. ! Vortex Force term
ln_stshear = .false. ! include stokes shear in EKE computation
!
cn_dir = './' ! root directory for the waves data location
......
......@@ -5,6 +5,6 @@
ln_icedA = .true. ! activate lateral melting param. (T) or not (F)
ln_icedO = .true. ! activate ice growth in open-water (T) or not (F)
ln_icedS = .true. ! activate brine drainage (T) or not (F)
!
!
ln_leadhfx = .true. ! heat in the leads is used to melt sea-ice before warming the ocean
/
!------------------------------------------------------------------------------
&namthd_pnd ! Melt ponds
!------------------------------------------------------------------------------
ln_pnd = .false. ! activate melt ponds or not
ln_pnd_LEV = .false. ! level ice melt ponds (from Flocco et al 2007,2010 & Holland et al 2012)
rn_apnd_min = 0.15 ! minimum ice fraction that contributes to melt pond. range: 0.0 -- 0.15 ??
rn_apnd_max = 0.85 ! maximum ice fraction that contributes to melt pond. range: 0.7 -- 0.85 ??
ln_pnd = .true. ! activate melt ponds or not
ln_pnd_TOPO = .false. ! topographic melt ponds
ln_pnd_LEV = .true. ! level ice melt ponds
rn_apnd_min = 0.15 ! minimum meltwater fraction contributing to pond growth (TOPO and LEV)
rn_apnd_max = 0.85 ! maximum meltwater fraction contributing to pond growth (TOPO and LEV)
rn_pnd_flush= 0.1 ! pond flushing efficiency (tuning parameter) (LEV)
ln_pnd_CST = .false. ! constant melt ponds
rn_apnd = 0.2 ! prescribed pond fraction, at Tsu=0 degC
rn_hpnd = 0.05 ! prescribed pond depth, at Tsu=0 degC
......
......@@ -10,5 +10,5 @@
rn_kappa_s = 10.0 ! nn_qtrice = 0: radiation attenuation coefficient in snow [1/m]
rn_kappa_smlt = 7.0 ! nn_qtrice = 1: radiation attenuation coefficient in melting snow [1/m]
rn_kappa_sdry = 10.0 ! radiation attenuation coefficient in dry snow [1/m]
ln_zdf_chkcvg = .false. ! check convergence of heat diffusion scheme (output variable: tice_cvg)
ln_zdf_chkcvg = .false. ! check convergence of heat diffusion scheme (outputs: tice_cvgerr, tice_cvgstp)
/
......@@ -2,6 +2,6 @@
&namtile ! parameters of the tiling
!-----------------------------------------------------------------------
ln_tile = .false. ! Use tiling (T) or not (F)
nn_ltile_i = 10 ! Length of tiles in i
nn_ltile_i = 99999 ! Length of tiles in i
nn_ltile_j = 10 ! Length of tiles in j
/
......@@ -6,8 +6,8 @@
nn_cen_h = 4 ! =2/4, horizontal 2nd order CEN / 4th order CEN
nn_cen_v = 4 ! =2/4, vertical 2nd order CEN / 4th order COMPACT
ln_traadv_fct = .false. ! 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_h = 2 ! =2/4, horizontal 2nd / 4th order
nn_fct_v = 2 ! =2/4, vertical 2nd / COMPACT 4th order
ln_traadv_mus = .false. ! MUSCL scheme
ln_mus_ups = .false. ! use upstream scheme near river mouths
ln_traadv_ubs = .false. ! UBS scheme
......
......@@ -6,12 +6,12 @@
! ! Coefficients:
nn_aei_ijk_t = 0 ! space/time variation of eddy coefficient:
! ! =-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
! ! = 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
! ! time invariant coefficients: aei0 = 1/2 Ue*Le
! ! time invariant coefficients: aei0 = 1/2 Ue*Le
rn_Ue = 0.02 ! lateral diffusive velocity [m/s] (nn_aht_ijk_t= 0, 10, 20, 30)
rn_Le = 200.e+3 ! lateral diffusive length [m] (nn_aht_ijk_t= 0, 10)
!
......
......@@ -12,7 +12,7 @@
ln_traldf_iso = .false. ! iso-neutral (standard operator)
ln_traldf_triad = .false. ! iso-neutral (triad operator)
!
! ! iso-neutral options:
! ! 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)
......@@ -22,13 +22,13 @@
! ! Coefficients:
nn_aht_ijk_t = 0 ! 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
! ! = 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)
! ! time invariant coefficients: aht0 = 1/2 Ud*Ld (lap case)
! ! or = 1/12 Ud*Ld^3 (blp case)
rn_Ud = 0.01 ! lateral diffusive velocity [m/s] (nn_aht_ijk_t= 0, 10, 20, 30)
rn_Ld = 200.e+3 ! lateral diffusive length [m] (nn_aht_ijk_t= 0, 10)
......
......@@ -10,7 +10,7 @@
rn_si0 = 0.35 ! RGB & 2BD: shortess depth of extinction
nn_chldta = 0 ! RGB : Chl data (=1) or cst value (=0)
rn_si1 = 23.0 ! 2BD : longest depth of extinction
cn_dir = './' ! root directory for the chlorophyl data location
!___________!_________________________!___________________!___________!_____________!________!___________!__________________!__________!_______________!
! ! file name ! frequency (hours) ! variable ! time interp.! clim ! 'yearly'/ ! weights filename ! rotation ! land/sea mask !
......
......@@ -14,6 +14,8 @@
ln_trcdta = .false. ! Initialisation from data input file (T) or not (F)
ln_trcdmp = .false. ! add a damping termn (T) or not (F)
ln_trcdmp_clo = .false. ! damping term (T) or not (F) on closed seas
ln_trcbc = .false. ! Surface, Lateral or Open Boundaries conditions
ln_trcais = .false. ! Antarctic Ice Sheet nutrient supply
!
jp_dia3d = 0 ! Number of 3D diagnostic variables
jp_dia2d = 0 ! Number of 2D diagnostic variables
......
......@@ -5,5 +5,6 @@
cn_dir_cbc = './' ! root directory for the location of COASTAL data files
cn_dir_obc = './' ! root directory for the location of OPEN data files
ln_rnf_ctl = .false. ! Remove runoff dilution on tracers with absent river load
rn_bc_time = 86400. ! Time scaling factor for SBC and CBC data (seconds in a day)
rn_sbc_time = 86400. ! Time scaling factor for SBC data (seconds in a day)
rn_cbc_time = 86400. ! Time scaling factor for CBC data (seconds in a day)
/
!-----------------------------------------------------------------------
&namtrc_opt ! light availability in the water column
!-----------------------------------------------------------------------
! ! 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_par = 'par.orca' , 24 , 'fr_par' , .true. , .true. , 'yearly' , '' , '' , ''
cn_dir = './' ! root directory for the location of the dynamical files
ln_varpar = .true. ! Read PAR from file
parlux = 0.43 ! Fraction of shortwave as PAR
light_loc = 'center' ! Light location in the water cell ('center', 'integral')
/
!-----------------------------------------------------------------------
&namtrc_run ! run information
!-----------------------------------------------------------------------
nn_dttrc = 1 ! time step frequency for passive sn_tracers
ln_top_euler = .false. ! use Euler time-stepping for TOP
ln_rsttr = .false. ! start from a restart file (T) or not (F)
nn_rsttr = 0 ! restart control = 0 initial time step is not compared to the restart file value
......
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