Skip to content
Snippets Groups Projects

Compare revisions

Changes are shown as if the source revision was being merged into the target revision. Learn more about comparing revisions.

Source

Select target project
No results found

Target

Select target project
  • nemo/nemo
  • sparonuz/nemo
  • hatfield/nemo
  • extdevs/nemo
4 results
Show changes
Showing
with 409 additions and 205 deletions
../../SHARED/field_def_nemo-pisces.xml
\ No newline at end of file
<?xml version="1.0"?>
<!--
============================================================================================================
= output files definition =
= Define your own filesfor ocean dynamics context =
= put the variables you want... =
============================================================================================================
-->
<file_definition type="one_file" name="@expname@_@freq@_@startdate@_@enddate@" sync_freq="1mo" min_digits="4">
<file_group id="oce_1d" output_freq="1d" output_level="10" enabled=".TRUE."> <!-- 5d files -->
</file_group>
<file_group id="oce_1m" output_freq="1mo" output_level="10" enabled=".TRUE."> <!-- real monthly files -->
<file id="file1" name_suffix="_nemo" description="pisces sms variables" >
<field field_ref="toce" />
<field field_ref="soce" />
<field field_ref="sst" />
<field field_ref="sss" />
<field field_ref="empmr" />
<field field_ref="wspd" />
<field field_ref="mldr10_1" name="mld" />
<field field_ref="qsr" name="qsr" />
<field field_ref="DIC" />
<field field_ref="Alkalini" />
<field field_ref="O2" />
<field field_ref="CaCO3" />
<field field_ref="PO4" />
<field field_ref="POC" />
<field field_ref="Si" />
<field field_ref="PHY" />
<field field_ref="ZOO" />
<field field_ref="DOC" />
<field field_ref="PHY2" />
<field field_ref="ZOO2" />
<field field_ref="DSi" />
<field field_ref="Fer" />
<field field_ref="BFe" />
<field field_ref="GOC" />
<field field_ref="SFe" />
<field field_ref="DFe" />
<field field_ref="GSi" />
<field field_ref="NFe" />
<field field_ref="NCHL" />
<field field_ref="DCHL" />
<field field_ref="NO3" />
<field field_ref="NH4" />
<field field_ref="INTPP" name="INTPP" />
<field field_ref="PAR" />
<field field_ref="PPPHYN" />
<field field_ref="PPPHYD" />
<field field_ref="PPNEWN" />
<field field_ref="PPNEWD" />
<field field_ref="PBSi" />
<field field_ref="PFeN" />
<field field_ref="PFeD" />
<field field_ref="GRAZ1" />
<field field_ref="GRAZ2" />
<field field_ref="EPC100" />
<field field_ref="EPFE100" />
<field field_ref="EPSI100" />
<field field_ref="EPCAL100" />
<field field_ref="Cflx" />
<field field_ref="Heup" />
</file>
</file_group>
<file_group id="oce_1y" output_freq="1y" output_level="10" enabled=".FALSE."> <!-- real yearly files -->
</file_group>
<file_group id="oce_1ts" output_freq="1ts" output_level="10" enabled=".TRUE."/> <!-- 1 time step files -->
<file_group id="oce_2h" output_freq="2h" output_level="10" enabled=".TRUE."/> <!-- 2h files -->
<file_group id="oce_3h" output_freq="3h" output_level="10" enabled=".TRUE."/> <!-- 3h files -->
<file_group id="oce_4h" output_freq="4h" output_level="10" enabled=".TRUE."/> <!-- 4h files -->
<file_group id="oce_6h" output_freq="6h" output_level="10" enabled=".TRUE."/> <!-- 6h files -->
<file_group id="oce_2m" output_freq="2mo" output_level="10" enabled=".TRUE."/> <!-- real 2m files -->
<file_group id="oce_3m" output_freq="3mo" output_level="10" enabled=".TRUE."/> <!-- real 3m files -->
<file_group id="oce_4m" output_freq="4mo" output_level="10" enabled=".TRUE."/> <!-- real 4m files -->
<file_group id="oce_6m" output_freq="6mo" output_level="10" enabled=".TRUE."/> <!-- real 6m files -->
<file_group id="oce_2y" output_freq="2y" output_level="10" enabled=".TRUE."/> <!-- real 2y files -->
<file_group id="oce_5y" output_freq="5y" output_level="10" enabled=".TRUE."/> <!-- real 5y files -->
<file_group id="oce_10y" output_freq="10y" output_level="10" enabled=".TRUE."/> <!-- real 10y files -->
</file_definition>
../../SHARED/grid_def_nemo.xml
\ No newline at end of file
......@@ -10,36 +10,40 @@
!! namcfg parameters of the configuration (default: user defined GYRE)
!! namwad Wetting and drying (default: OFF)
!! namtsd data: temperature & salinity (default: OFF)
!! namcrs coarsened grid (for outputs and/or TOP) (ln_crs =T)
!! namc1d 1D configuration options (ln_c1d =T)
!! namc1d_dyndmp 1D newtonian damping applied on currents (ln_c1d =T)
!! namc1d_uvd 1D data (currents) (ln_c1d =T)
!!======================================================================
!
!-----------------------------------------------------------------------
&namusr_def ! C1D user defined namelist
!-----------------------------------------------------------------------
rn_bathy = 4556. ! depth in meters
/
!-----------------------------------------------------------------------
&namrun ! parameters of the run
!-----------------------------------------------------------------------
cn_exp = "ORCA2" ! experience name
nn_it000 = 1 ! first time step
nn_itend = 16 ! last time step (std 5475)
nn_date0 = 20130101 ! date at nit_0000 (format yyyymmdd) used if ln_rstart=F or (ln_rstart=T and nn_rstctl=0 or 1)
nn_write = 4 ! frequency of write in the output file (modulo referenced to nn_it000)
nn_istate = 0 ! output the initial state (1) or not (0)
ln_mskland = .false. ! mask land points in NetCDF outputs
cn_exp = "BATSPIS" ! experience name
nn_date0 = 20100101 ! date at nit_0000 (format yyyymmdd) used if ln_rstart=F or (ln_rstart=T and nn_rstctl=0 or 1)
nn_it000 = 1 ! first time step
nn_itend = 26280 ! last time step (std 5475)
nn_stock = 87600 ! frequency of creation of a restart file (modulo referenced to 1)
nn_istate = 0 ! output the initial state (1) or not (0)
ln_top = .true. ! Consider (T) or bypass (F) the TOP routines when the key_top is activated
/
!-----------------------------------------------------------------------
&namdom ! time and space domain
!-----------------------------------------------------------------------
rn_Dt = 5400. ! time step for the dynamics and tracer
rn_Dt = 3600. ! time step for the dynamics and tracer
!
ln_c1d = .true. ! Single column domain (1x1pt) (T => fill namc1d)
/
!-----------------------------------------------------------------------
&namusr_def ! GYRE user defined namelist
!-----------------------------------------------------------------------
rn_bathy = 4556. ! depth in meters
/
!-----------------------------------------------------------------------
&namcfg ! parameters of the configuration (default: use namusr_def in namelist_cfg)
!-----------------------------------------------------------------------
ln_read_cfg = .true. ! (=T) read the domain configuration file
cn_domcfg = "ORCA_R2_zps_domcfg" ! domain configuration filename
!
ln_closea = .false. ! F => suppress closed seas (defined by closea_mask field)
! ! from the bathymetry at runtime.
/
!-----------------------------------------------------------------------
&namtile ! parameters of the tiling
......@@ -50,14 +54,38 @@
!-----------------------------------------------------------------------
! ! =T read T-S fields for:
ln_tsd_init = .true. ! ocean initialisation
ln_tsd_dmp = .true. ! T-S restoring (see namtra_dmp)
cn_dir = './' ! root directory for the T-S data location
cn_dir = './BATS/' ! 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 = 'InitTS_l75_BATS' , -1. ,'temp', .false. , .true., 'yearly' , '' , '' , ''
sn_sal = 'InitTS_l75_BATS' , -1. ,'salt', .false. , .true., 'yearly' , '' , '' , ''
/
!-----------------------------------------------------------------------
&namc1d ! 1D configuration options ("key_c1d" default: PAPA station)
!-----------------------------------------------------------------------
rn_lat1d = 31.5 ! Column latitude
rn_lon1d = -64. ! Column longitude
/
!-----------------------------------------------------------------------
&namc1d_dyndmp ! U & V newtonian damping ("key_c1d" default: OFF)
!-----------------------------------------------------------------------
ln_dyndmp = .false. ! add a damping term (T) or not (F)
/
!-----------------------------------------------------------------------
&namc1d_uvd ! data: U & V currents ("key_c1d" default: OFF)
!-----------------------------------------------------------------------
! ! =T read U-V fields for:
ln_uvd_init = .false. ! ocean initialisation
ln_uvd_dyndmp = .false. ! U-V restoring
cn_dir = './BATS' ! root directory for the U-V 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 = 'data_1m_potential_temperature_nomask', -1. ,'votemper', .true. , .true. , 'yearly' , '' , '' , ''
sn_sal = 'data_1m_salinity_nomask' , -1. ,'vosaline', .true. , .true. , 'yearly' , '' , '' , ''
sn_ucur = 'ucurrent' , -1. ,'u_current', .false. , .true. , 'monthly' , '' , 'Ume' , ''
sn_vcur = 'vcurrent' , -1. ,'v_current', .false. , .true. , 'monthly' , '' , 'Vme' , ''
/
!!======================================================================
!! *** Surface Boundary Condition namelists *** !!
......@@ -82,67 +110,32 @@
&namsbc ! Surface Boundary Condition manager (default: NO selection)
!-----------------------------------------------------------------------
nn_fsbc = 1 ! frequency of SBC module call
! (also = the frequency of sea-ice & iceberg model call)
! Type of air-sea fluxes
ln_blk = .false. ! Bulk formulation (T => fill namsbc_blk )
ln_abl = .true. ! ABL formulation (T => fill namsbc_abl )
! Sea-ice :
nn_ice = 2 ! =0 no ice boundary condition
! ! =1 use observed ice-cover ( => fill namsbc_iif )
! ! =2 or 3 for SI3 and CICE, respectively
! Misc. options of sbc :
ln_blk = .true. ! user defined formulation (T => check usrdef_sbc)
ln_traqsr = .true. ! Light penetration in the ocean (T => fill namtra_qsr)
ln_ssr = .true. ! Sea Surface Restoring on T and/or S (T => fill namsbc_ssr)
ln_dm2dc = .true. ! daily mean to diurnal cycle on short wave
ln_rnf = .true. ! runoffs (T => fill namsbc_rnf)
nn_fwb = 2 ! FreshWater Budget:
! ! =2 annual global mean of e-p-r set to zero
ln_wave = .false. ! 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 = .false. ! Read 2D Surf Stokes Drift & Computation of 3D stokes drift (T => ln_wave=.true. & fill namsbc_wave)
nn_sdrift = 0 ! 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_tauw = .false. ! Activate ocean stress components from wave model
ln_stcor = .false. ! Activate Stokes Coriolis term (T => ln_wave=.true. & ln_sdw=.true. & fill namsbc_wave)
/
!-----------------------------------------------------------------------
&namsbc_blk ! namsbc_blk generic Bulk formula (ln_blk =T)
!-----------------------------------------------------------------------
! ! bulk algorithm :
ln_NCAR = .true. ! "NCAR" algorithm (Large and Yeager 2008)
!
cn_dir = './' ! root directory for the bulk data location
ln_NCAR = .true. ! "NCAR" algorithm (Large and Yeager 2008)
cn_dir = './BATS/' ! root directory for the bulk 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_wndi = 'uwnd_drwnlnd_ERAI_L25Z10_GLOBAL_F128R_ana1d', 24., 'uwnd' , .false. , .false. , 'monthly' , 'weights_ERAI3D_F128_2_ORCA2_bicubic' , 'U10' , ''
sn_wndj = 'vwnd_drwnlnd_ERAI_L25Z10_GLOBAL_F128R_ana1d', 24., 'vwnd' , .false. , .false. , 'monthly' , 'weights_ERAI3D_F128_2_ORCA2_bicubic' , 'V10' , ''
sn_tair = 'tair_drwnlnd_ERAI_L25Z10_GLOBAL_F128R_ana1d', 24., 'tair' , .false. , .false. , 'monthly' , 'weights_ERAI3D_F128_2_ORCA2_bilinear' , '' , ''
sn_humi = 'humi_drwnlnd_ERAI_L25Z10_GLOBAL_F128R_ana1d', 24., 'humi' , .false. , .false. , 'monthly' , 'weights_ERAI3D_F128_2_ORCA2_bilinear' , '' , ''
sn_qsr = 'ncar_rad.15JUNE2009_fill' , 24., 'SWDN_MOD', .false. , .true. , 'yearly' , 'weights_core_orca2_bilinear_noc.nc' , '' , ''
sn_qlw = 'ncar_rad.15JUNE2009_fill' , 24., 'LWDN_MOD', .false. , .true. , 'yearly' , 'weights_core_orca2_bilinear_noc.nc' , '' , ''
sn_prec = 'ncar_precip.15JUNE2009_fill' , -1., 'PRC_MOD1', .false. , .true. , 'yearly' , 'weights_core_orca2_bilinear_noc.nc' , '' , ''
sn_snow = 'ncar_precip.15JUNE2009_fill' , -1., 'SNOW' , .false. , .true. , 'yearly' , 'weights_core_orca2_bilinear_noc.nc' , '' , ''
sn_slp = 'slp.15JUNE2009_fill' , 6., 'SLP' , .false. , .true. , 'yearly' , 'weights_core_orca2_bilinear_noc.nc' , '' , ''
sn_hpgi = 'uhpg_drwnlnd_ERAI_L25Z10_GLOBAL_F128R_ana1d', 24., 'uhpg' , .false. , .false. , 'monthly' , 'weights_ERAI3D_F128_2_ORCA2_bicubic' , 'UG' , ''
sn_hpgj = 'vhpg_drwnlnd_ERAI_L25Z10_GLOBAL_F128R_ana1d', 24., 'vhpg' , .false. , .false. , 'monthly' , 'weights_ERAI3D_F128_2_ORCA2_bicubic' , 'VG' , ''
sn_wndi = 'CORE2_NY_Forcings_6h_BATS.nc', 6. , 'U_10_MOD', .false. , .true. , 'yearly' , '' , '' , ''
sn_wndj = 'CORE2_NY_Forcings_6h_BATS.nc', 6. , 'V_10_MOD', .false. , .true. , 'yearly' , '' , '' , ''
sn_qsr = 'CORE2_NY_Forcings_1d_BATS.nc', 24. , 'SWDN_MOD', .false. , .true. , 'yearly' , '' , '' , ''
sn_qlw = 'CORE2_NY_Forcings_1d_BATS.nc', 24. , 'LWDN_MOD', .false. , .true. , 'yearly' , '' , '' , ''
sn_tair = 'CORE2_NY_Forcings_6h_BATS.nc', 6. , 'T_10_MOD', .false. , .true. , 'yearly' , '' , '' , ''
sn_humi = 'CORE2_NY_Forcings_6h_BATS.nc', 6. , 'Q_10_MOD', .false. , .true. , 'yearly' , '' , '' , ''
sn_prec = 'CORE2_NY_Forcings_1m_BATS.nc', -1. , 'PRC_MOD1', .false. , .true. , 'yearly' , '' , '' , ''
sn_snow = 'CORE2_NY_Forcings_1m_BATS.nc', -1. , 'SNOW' , .false. , .true. , 'yearly' , '' , '' , ''
sn_slp = 'CORE2_NY_Forcings_6h_BATS.nc', 6. , 'SLP' , .false. , .true. , 'yearly' , '' , '' , ''
/
!-----------------------------------------------------------------------
&namsbc_abl ! Atmospheric Boundary Layer formulation (ln_abl = T)
!-----------------------------------------------------------------------
cn_dir = './' ! root directory for the location of the ABL grid file
cn_dom = 'dom_cfg_abl_L25Z10.nc'
ln_hpgls_frc = .true.
ln_geos_winds = .false.
nn_dyn_restore = 1
rn_ldyn_min = 7.5 ! magnitude of the nudging on ABL dynamics at the bottom of the ABL [hour]
rn_ldyn_max = 1.5 ! magnitude of the nudging on ABL dynamics at the top of the ABL [hour]
rn_ltra_min = 7.5 ! magnitude of the nudging on ABL tracers at the bottom of the ABL [hour]
rn_ltra_max = 1.5 ! magnitude of the nudging on ABL tracers at the top of the ABL [hour]
/
!-----------------------------------------------------------------------
&namtra_qsr ! penetrative solar radiation (ln_traqsr =T)
......@@ -152,37 +145,19 @@
!
nn_chldta = 1 ! RGB : Chl data (=1) or cst value (=0)
cn_dir = './' ! root directory for the chlorophyl data location
cn_dir = './BATS/' ! root directory for the chlorophyl 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_chl ='chlorophyll' , -1. , 'CHLA' , .true. , .true. , 'yearly' , '' , '' , ''
sn_chl ='CHLA_BATS' , -1. , 'CHLA' , .true. , .true. , 'yearly' , '' , '' , ''
/
!-----------------------------------------------------------------------
&namsbc_ssr ! surface boundary condition : sea surface restoring (ln_ssr =T)
!-----------------------------------------------------------------------
nn_sssr = 2 ! add a damping term to the surface freshwater flux
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_rnf ! runoffs (ln_rnf =T)
!-----------------------------------------------------------------------
ln_rnf_mouth = .true. ! 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
cn_dir = './' ! root directory for the location of the runoff files
!___________!_____________!___________________!___________!_____________!_________!___________!__________!__________!_______________!
! ! 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_core_monthly', -1. , 'sorunoff', .true. , .true. , 'yearly' , '' , '' , ''
sn_cnf = 'runoff_core_monthly', 0. , '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' , '' , '' , ''
/
!-----------------------------------------------------------------------
&namsbc_wave ! External fields from wave model (ln_wave=T)
......@@ -206,15 +181,11 @@
!-----------------------------------------------------------------------
&namlbc ! lateral momentum boundary condition (default: NO selection)
!-----------------------------------------------------------------------
rn_shlat = 2. ! no slip
rn_shlat = 0. ! no slip
/
!-----------------------------------------------------------------------
&namagrif ! AGRIF zoom ("key_agrif")
!-----------------------------------------------------------------------
ln_spc_dyn = .true. ! use 0 as special value for dynamics
rn_sponge_tra = 2880. ! coefficient for tracer sponge layer [m2/s]
rn_sponge_dyn = 2880. ! coefficient for dynamics sponge layer [m2/s]
ln_chk_bathy = .false. ! =T check the parent bathymetry
/
!!======================================================================
!! *** Top/Bottom boundary condition *** !!
......@@ -229,28 +200,15 @@
!-----------------------------------------------------------------------
&namdrg ! top/bottom drag coefficient (default: NO selection)
!-----------------------------------------------------------------------
ln_lin = .true. ! linear drag: Cd = Cd0 Uc0
ln_non_lin = .true. ! linear drag: Cd = Cd0 Uc0
/
!-----------------------------------------------------------------------
&nambbc ! bottom temperature boundary condition (default: OFF)
!-----------------------------------------------------------------------
ln_trabbc = .true. ! Apply a geothermal heating at the ocean bottom
nn_geoflx = 2 ! geothermal heat flux: = 2 read variable flux [mW/m2]
cn_dir = './' ! root directory for the geothermal 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_qgh ='geothermal_heating.nc' , -12. , 'heatflow', .false. , .true. , 'yearly' , '' , '' , ''
/
!-----------------------------------------------------------------------
&nambbl ! bottom boundary layer scheme (default: OFF)
!-----------------------------------------------------------------------
ln_trabbl = .true. ! Bottom Boundary Layer parameterisation flag
nn_bbl_ldf = 1 ! diffusive bbl (=1) or not (=0)
nn_bbl_adv = 0 ! advective bbl (=1/2) or not (=0)
rn_ahtbbl = 1000. ! lateral mixing coefficient in the bbl [m2/s]
rn_gambbl = 10. ! advective bbl coefficient [s]
/
!!======================================================================
!! Tracer (T-S) namelists !!
......@@ -266,50 +224,29 @@
!-----------------------------------------------------------------------
&nameos ! ocean Equation Of Seawater (default: NO selection)
!-----------------------------------------------------------------------
ln_eos80 = .true. ! = Use EOS80
ln_teos10 = .true. ! = Use TEOS10
/
!-----------------------------------------------------------------------
&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
ln_traadv_OFF = .true. ! linear dynamics (no momentum advection)
/
!-----------------------------------------------------------------------
&namtra_ldf ! lateral diffusion scheme for tracers (default: NO selection)
!-----------------------------------------------------------------------
ln_traldf_lap = .true. ! laplacian operator
ln_traldf_iso = .true. ! iso-neutral (Standard operator)
ln_traldf_msc = .true. ! Method of Stabilizing Correction (both operators)
! ! Coefficients:
nn_aht_ijk_t = 20 ! space/time variation of eddy coef
! ! = 20 aht = 1/2 Ud. max(e1,e2)
rn_Ud = 0.018 ! 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)
ln_traldf_OFF = .true. ! No explicit diffusion
/
!-----------------------------------------------------------------------
&namtra_mle ! mixed layer eddy parametrisation (Fox-Kemper) (default: OFF)
!-----------------------------------------------------------------------
ln_mle = .true. ! (T) use the Mixed Layer Eddy (MLE) parameterisation
/
!-----------------------------------------------------------------------
&namtra_eiv ! eddy induced velocity param. (default: OFF)
!-----------------------------------------------------------------------
ln_ldfeiv = .true. ! use eddy induced velocity parameterization
! ! Coefficients:
nn_aei_ijk_t = 21 ! space/time variation of the eiv coeficient
! ! = 21 F(i,j,t) =Treguier et al. JPO 1997 formulation
! ! time invariant coefficients: aei0 = 1/2 Ue*Le
rn_Ue = 0.03 ! 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)
!
ln_ldfeiv_dia =.true. ! diagnose eiv stream function and velocities
/
!-----------------------------------------------------------------------
&namtra_dmp ! tracer: T & S newtonian damping (default: OFF)
!-----------------------------------------------------------------------
ln_tradmp = .true. ! add a damping term (using resto.nc coef.)
nn_zdmp = 0 ! vertical shape =0 damping throughout the water column
/
!!======================================================================
!! *** Dynamics namelists *** !!
......@@ -326,14 +263,12 @@
!-----------------------------------------------------------------------
&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_OFF = .true. ! linear dynamics (no momentum advection)
/
!-----------------------------------------------------------------------
&namdyn_vor ! Vorticity / Coriolis scheme (default: NO selection)
!-----------------------------------------------------------------------
ln_dynvor_een = .true. ! energy & enstrophy scheme
nn_een_e3f = 0 ! =0 e3f = mean masked e3t divided by 4
ln_dynvor_ene = .true. ! energy & enstrophy scheme
/
!-----------------------------------------------------------------------
&namdyn_hpg ! Hydrostatic pressure gradient option (default: NO selection)
......@@ -343,14 +278,11 @@
!-----------------------------------------------------------------------
&namdyn_spg ! surface pressure gradient (default: NO selection)
!-----------------------------------------------------------------------
ln_dynspg_ts = .true. ! split-explicit free surface
/
!-----------------------------------------------------------------------
&namdyn_ldf ! lateral diffusion on momentum (default: NO selection)
!-----------------------------------------------------------------------
ln_dynldf_lap = .true. ! laplacian operator
ln_dynldf_lev = .true. ! iso-level
nn_ahm_ijk_t = -30 ! =-30 3D coeff. read in eddy_diffusivity_3D.nc
ln_dynldf_OFF = .true. ! No operator (i.e. no explicit diffusion)
/
!!======================================================================
!! vertical physics namelists !!
......@@ -367,52 +299,24 @@
&namzdf ! vertical physics manager (default: NO selection)
!-----------------------------------------------------------------------
ln_zdftke = .true. ! Turbulent Kinetic Energy closure (T => fill namzdf_tke)
ln_zdfevd = .true. ! Enhanced Vertical Diffusion scheme
nn_evdm = 0 ! evd apply on tracer (=0) or on tracer and momentum (=1)
rn_evd = 100. ! evd mixing coefficient [m2/s]
ln_zdfddm = .true. ! double diffusive mixing
rn_avts = 1.e-4 ! maximum avs (vertical mixing on salinity)
rn_hsbfr = 1.6 ! heat/salt buoyancy flux ratio
ln_zdfiwm = .true. ! internal wave-induced mixing (T => fill namzdf_iwm)
! ! Coefficients
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)
nn_avb = 0 ! profile for background avt & avm (=1) or not (=0)
nn_havtb = 1 ! horizontal shape for avtb (=1) or not (=0)
/
!-----------------------------------------------------------------------
&namzdf_tke ! turbulent eddy kinetic dependent vertical diffusion (ln_zdftke =T)
!-----------------------------------------------------------------------
nn_mxl = 3 ! mixing length: = 0 bounded by the distance to surface and bottom
! ! = 1 bounded by the local vertical scale factor
! ! = 2 first vertical derivative of mixing length bounded by 1
! ! = 3 as =2 with distinct dissipative an mixing length scale
nn_etau = 1 ! 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)
rn_eice = 0 ! below sea ice: =0 ON ; =4 OFF when ice fraction > 1/4
/
!-----------------------------------------------------------------------
&namzdf_iwm ! internal wave-driven mixing parameterization (ln_zdfiwm =T)
!-----------------------------------------------------------------------
nn_zpyc = 2 ! pycnocline-intensified dissipation scales as N (=1) or N^2 (=2)
ln_mevar = .true. ! variable (T) or constant (F) mixing efficiency
ln_tsdiff = .true. ! account for differential T/S mixing (T) or not (F)
/
!!======================================================================
!! *** Diagnostics namelists *** !!
!! !!
!! namtrd dynamics and/or tracer trends (default: OFF)
!! namhsb Heat and salt budgets (default: OFF)
!! namdiu Cool skin and warm layer models (default: OFF)
!! namdiu Cool skin and warm layer models (default: OFF)
!! namflo float parameters (default: OFF)
!! nam_diaharm Harmonic analysis of tidal constituents (default: OFF)
!! nam_diadct transports through some sections (default: OFF)
!! nam_diatmb Top Middle Bottom Output (default: OFF)
!! nam_dia25h 25h Mean Output (default: OFF)
!! namnc4 netcdf4 chunking and compression settings ("key_netcdf4")
!! namnc4 netcdf4 chunking and compression settings
!!======================================================================
!
!!======================================================================
......
......@@ -5,6 +5,7 @@
!-----------------------------------------------------------------------
&nampisext ! air-sea exchange
!-----------------------------------------------------------------------
atcco2 = 280. ! Constant value atmospheric pCO2 - ln_co2int = F
/
!-----------------------------------------------------------------------
&nampisatm ! Atmospheric prrssure
......@@ -13,10 +14,17 @@
!-----------------------------------------------------------------------
&nampisbio ! biological parameters
!-----------------------------------------------------------------------
nrdttrc = 1 ! time step frequency for biology
wsbio = 2. ! POC sinking speed
wsbio2 = 50. ! Big particles sinking speed
/
!-----------------------------------------------------------------------
&namp4zlim ! parameters for nutrient limitations for PISCES std - ln_p4z
!-----------------------------------------------------------------------
concnno3 = 1.e-6 ! Nitrate half saturation of nanophytoplankton
concdno3 = 3.E-6 ! Nitrate half saturation for diatoms
concnnh4 = 1.E-6 ! NH4 half saturation for phyto
concdnh4 = 3.E-6 ! NH4 half saturation for diatoms
/
!-----------------------------------------------------------------------
&namp5zlim ! parameters for nutrient limitations PISCES QUOTA - ln_p5z
......@@ -29,10 +37,18 @@
!-----------------------------------------------------------------------
&nampisopt ! parameters for optics
!-----------------------------------------------------------------------
sn_par = 'par_fr_gewex_clim_BATS.nc' , 24. , 'fr_par' , .true. , .true. , 'yearly' , '' , '' , ''
cn_dir = './BATS/' ! root directory for the location of the dynamical files
ln_varpar = .true. ! boolean for PAR variable
parlux = 0.43 ! Fraction of shortwave as PAR
/
!-----------------------------------------------------------------------
&namp4zprod ! parameters for phytoplankton growth for PISCES std - ln_p4z
!-----------------------------------------------------------------------
pislopen = 2.0 ! P-I slope
pisloped = 2.0 ! P-I slope for diatoms
fecnm = 60E-6 ! Maximum Fe/C in nanophytoplankton
fecdm = 60E-6 ! Maximum Fe/C in diatoms
/
!-----------------------------------------------------------------------
&namp5zprod ! parameters for phytoplankton growth for PISCES quota- ln_p5z
......@@ -49,6 +65,7 @@
!-----------------------------------------------------------------------
&namp4zmes ! parameters for mesozooplankton for PISCES std - ln_p4z
!-----------------------------------------------------------------------
grazrat2 = 0.5 ! maximal mesozoo grazing rate
/
!-----------------------------------------------------------------------
&namp5zmes ! parameters for mesozooplankton
......@@ -57,6 +74,7 @@
!-----------------------------------------------------------------------
&namp4zzoo ! parameters for microzooplankton for PISCES std - ln_p4z
!-----------------------------------------------------------------------
grazrat = 2.0 ! maximal zoo grazing rate
/
!-----------------------------------------------------------------------
&namp5zzoo ! parameters for microzooplankton
......@@ -65,6 +83,7 @@
!-----------------------------------------------------------------------
&nampisfer ! parameters for iron chemistry
!-----------------------------------------------------------------------
xlam1 = 0.02 ! scavenging rate of Iron by biogenic particles
/
!-----------------------------------------------------------------------
&nampisrem ! parameters for remineralization
......@@ -81,10 +100,13 @@
!-----------------------------------------------------------------------
&nampisbc ! parameters for inputs deposition
!-----------------------------------------------------------------------
sn_dust = 'dust.orca.new' , -1 , 'dust' , .true. , .true. , 'yearly' , '' , '' , ''
ln_ironsed = .true. ! boolean for Fe input from sediments
ln_ironice = .true. ! boolean for Fe input from sea ice
ln_hydrofe = .true. ! boolean for from hydrothermal vents
! ! 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_dust = 'DustNew_BATS' , -1 , 'dust' , .true. , .true. , 'yearly' , '' , '' , ''
sn_ironsed = 'pmarge_etopo_BATS', -12. , 'bathy' , .false. , .true. , 'yearly' , '' , '' , ''
!
cn_dir = './BATS/' ! root directory for the location of the dynamical files
ln_ironsed = .true. ! boolean for Fe input from sediments
/
!-----------------------------------------------------------------------
&nampissed ! parameters for sediments mobilization
......@@ -101,7 +123,7 @@
!-----------------------------------------------------------------------
&nampisdmp ! Damping
!-----------------------------------------------------------------------
nn_pisdmp = 5840 ! Frequency of Relaxation
ln_pisdmp = .false. ! Relaxation for some tracers to a mean value
/
!-----------------------------------------------------------------------
&nampismass ! Mass conservation
......
../../SHARED/namelist_pisces_ref
\ No newline at end of file
../../SHARED/namelist_ref
\ No newline at end of file
!!>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>
!! NEMO/TOP1 : Configuration namelist : used to overwrite defaults values defined in SHARED/namelist_top_ref
!>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>
!-----------------------------------------------------------------------
&namtrc_run ! run information
!-----------------------------------------------------------------------
/
!-----------------------------------------------------------------------
&namtrc ! tracers definition
!-----------------------------------------------------------------------
jp_bgc = 24
!
ln_pisces = .true.
ln_my_trc = .false.
ln_age = .false.
ln_cfc11 = .false.
ln_cfc12 = .false.
ln_c14 = .false.
!
ln_trcdta = .true. ! Initialisation from data input file (T) or not (F)
ln_trcbc = .true. ! Enables Boundary conditions
! ! ! ! ! !
! ! name ! title of the field ! units ! init ! sbc ! cbc ! obc ! ais
sn_tracer(1) = 'DIC ' , 'Dissolved inorganic Concentration ', 'mol-C/L' , .true. , .false., .false. , .false. , .false.
sn_tracer(2) = 'Alkalini' , 'Total Alkalinity Concentration ', 'eq/L ' , .true. , .false., .false. , .false. , .false.
sn_tracer(3) = 'O2 ' , 'Dissolved Oxygen Concentration ', 'mol-C/L' , .true. , .false., .false., .false. , .false.
sn_tracer(4) = 'CaCO3 ' , 'Calcite Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(5) = 'PO4 ' , 'Phosphate Concentration ', 'mol-C/L' , .true. , .true. , .false. , .false. , .false.
sn_tracer(6) = 'POC ' , 'Small organic carbon Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(7) = 'Si ' , 'Silicate Concentration ', 'mol-C/L' , .true. , .true. , .false. , .false. , .false.
sn_tracer(8) = 'PHY ' , 'Nanophytoplankton Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(9) = 'ZOO ' , 'Microzooplankton Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(10) = 'DOC ' , 'Dissolved organic Concentration ', 'mol-C/L' , .true. , .false., .false. , .false. , .false.
sn_tracer(11) = 'PHY2 ' , 'Diatoms Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(12) = 'ZOO2 ' , 'Mesozooplankton Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(13) = 'DSi ' , 'Diatoms Silicate Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(14) = 'Fer ' , 'Dissolved Iron Concentration ', 'mol-C/L' , .true. , .true. , .false. , .false. , .true.
sn_tracer(15) = 'BFe ' , 'Big iron particles Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(16) = 'GOC ' , 'Big organic carbon Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(17) = 'SFe ' , 'Small iron particles Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(18) = 'DFe ' , 'Diatoms iron Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(19) = 'GSi ' , 'Sinking biogenic Silicate Concentration', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(20) = 'NFe ' , 'Nano iron Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(21) = 'NCHL ' , 'Nano chlorophyl Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(22) = 'DCHL ' , 'Diatoms chlorophyl Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
sn_tracer(23) = 'NO3 ' , 'Nitrates Concentration ', 'mol-C/L' , .true. , .true. , .false. , .false. , .false.
sn_tracer(24) = 'NH4 ' , 'Ammonium Concentration ', 'mol-C/L' , .false. , .false., .false., .false. , .false.
/
!-----------------------------------------------------------------------
&namage ! AGE
!-----------------------------------------------------------------------
/
!-----------------------------------------------------------------------
&namtrc_dta ! Initialisation from data input file
!-----------------------------------------------------------------------
! ! 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_trcdta(1) = 'Glodapv2.1_annual_l75_BATS.nc', -12. , 'TDIC' , .false. , .true. , 'yearly' , '' , '' , ''
sn_trcdta(2) = 'Glodapv2.1_annual_l75_BATS.nc', -12. , 'Alkalini', .false. , .true. , 'yearly' , '' , '' , ''
sn_trcdta(3) = 'WOA2009_monthly_l75_BATS.nc' , -1. , 'O2' , .true. , .true. , 'yearly' , '' , '' , ''
sn_trcdta(5) = 'WOA2009_monthly_l75_BATS.nc' , -1. , 'PO4' , .true. , .true. , 'yearly' , '' , '' , ''
sn_trcdta(7) = 'WOA2009_monthly_l75_BATS.nc' , -1. , 'Si' , .true. , .true. , 'yearly' , '' , '' , ''
sn_trcdta(10) = 'PISCES_monthly_l75_BATS.nc' , -1. , 'DOC' , .true. , .true. , 'yearly' , '' , '' , ''
sn_trcdta(14) = 'PISCES_monthly_l75_BATS.nc' , -1. , 'Fer' , .true. , .true. , 'yearly' , '' , '' , ''
sn_trcdta(23) = 'WOA2009_monthly_l75_BATS.nc' , -1. , 'NO3' , .true. , .true. , 'yearly' , '' , '' , ''
!
cn_dir = './BATS/' ! root directory for the location of the data files
!
rn_trfac(1) = 1.0e-06 ! multiplicative factor
rn_trfac(2) = 1.0e-06 ! - - - -
rn_trfac(3) = 44.6e-06 ! - - - -
rn_trfac(5) = 117.0e-06 ! - - - -
rn_trfac(7) = 1.0e-06 ! - - - -
rn_trfac(10) = 1.0e-06 ! - - - -
rn_trfac(14) = 1.0e-06 ! - - - -
rn_trfac(23) = 7.3125e-06 ! - - - -
/
!-----------------------------------------------------------------------
&namtrc_adv ! advection scheme for passive tracer (default: NO selection)
!-----------------------------------------------------------------------
ln_trcadv_OFF = .true. ! No advection
/
!-----------------------------------------------------------------------
&namtrc_ldf ! lateral diffusion scheme for passive tracer (default: NO selection)
!-----------------------------------------------------------------------
ln_trcldf_OFF = .true. ! No lateral diffusion
/
!-----------------------------------------------------------------------
&namtrc_rad ! treatment of negative concentrations
!-----------------------------------------------------------------------
/
!-----------------------------------------------------------------------
&namtrc_snk ! sedimentation of particles
!-----------------------------------------------------------------------
/
!-----------------------------------------------------------------------
&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 !
!-----------------------------------------------------------------------
&namtrc_dmp ! passive tracer newtonian damping
!-----------------------------------------------------------------------
/
!-----------------------------------------------------------------------
&namtrc_ice ! Representation of sea ice growth & melt effects
!-----------------------------------------------------------------------
/
!-----------------------------------------------------------------------
&namtrc_trd ! diagnostics on tracer trends ('key_trdtrc')
!----------------------------------------------------------------------
/
!----------------------------------------------------------------------
&namtrc_bc ! data for boundary conditions
!-----------------------------------------------------------------------
! ! 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_trcsbc(5) = 'DustNew_BATS' , -1 , 'dustpo4' , .true. , .true. , 'yearly' , '' , '' , ''
sn_trcsbc(7) = 'DustNew_BATS' , -1 , 'dustsi' , .true. , .true. , 'yearly' , '' , '' , ''
sn_trcsbc(14) = 'DustNew_BATS' , -1 , 'dustfer' , .true. , .true. , 'yearly' , '' , '' , ''
sn_trcsbc(23) = 'Ndep_BATS' , -12 , 'ndep2' , .false. , .true. , 'yearly' , '' , '' , ''
rn_trsfac(5) = 3.774194e-03 ! ( 1E-3 / 31. * 117 )
rn_trsfac(7) = 9.572954e-03 ! ( 0.269 / 28.1 )
rn_trsfac(14) = 6.2667860e-04 ! ( 0.035 / 55.85 )
rn_trsfac(23) = 5.2232143e-01 ! ( From kgN m-2 s-1 to molC l-1 ====> zfact = 7.3125/14 )
rn_sbc_time = 1. ! Time scaling factor for SBC and CBC data (seconds in a day)
/
!----------------------------------------------------------------------
&namtrc_bdy ! Setup of tracer boundary conditions
!-----------------------------------------------------------------------
/
!-----------------------------------------------------------------------
&namtrc_ais ! Representation of Antarctic Ice Sheet tracers supply
!-----------------------------------------------------------------------
/
../../SHARED/namelist_top_ref
\ No newline at end of file
../../SHARED/namelist_trc_ref
\ No newline at end of file
../../SHARED/axis_def_nemo.xml
\ No newline at end of file
<!--
==============================================================================================
NEMO context
==============================================================================================
-->
<context id="nemo">
<variable_definition>
<!-- Year/Month/Day of time origin for NetCDF files; defaults to 1800-01-01 -->
<variable id="ref_year" type="int"> 1900 </variable>
<variable id="ref_month" type="int"> 01 </variable>
<variable id="ref_day" type="int"> 01 </variable>
<variable id="rho0" type="float" > 1026.0 </variable>
<variable id="cpocean" type="float" > 3991.86795711963 </variable>
<variable id="convSpsu" type="float" > 0.99530670233846 </variable>
<variable id="rhoic" type="float" > 917.0 </variable>
<variable id="rhosn" type="float" > 330.0 </variable>
<variable id="missval" type="float" > 1.e20 </variable>
</variable_definition>
<!-- Fields definition -->
<field_definition src="./field_def_nemo-oce.xml"/> <!-- NEMO ocean dynamics -->
<field_definition src="./field_def_nemo-ice.xml"/> <!-- NEMO sea-ice model -->
<!-- Files definition -->
<file_definition src="./file_def_nemo-oce.xml"/> <!-- NEMO ocean dynamics -->
<file_definition src="./file_def_nemo-ice.xml"/> <!-- NEMO sea-ice model -->
<!-- Axis definition -->
<axis_definition src="./axis_def_nemo.xml"/>
<!-- Domain definition -->
<domain_definition src="./domain_def_nemo.xml"/>
<!-- Grids definition -->
<grid_definition src="./grid_def_nemo.xml"/>
</context>
../../SHARED/domain_def_nemo.xml
\ No newline at end of file
../../SHARED/field_def_nemo-ice.xml
\ No newline at end of file
../../SHARED/field_def_nemo-oce.xml
\ No newline at end of file
......@@ -11,8 +11,8 @@
<file_definition type="one_file" name="@expname@_@freq@_@startdate@_@enddate@" sync_freq="1mo" min_digits="4">
<file_group id="5d" output_freq="5d" output_level="10" enabled=".TRUE."> <!-- 5d files -->
<file id="file21" name_suffix="_icemod" description="ice variables" enabled=".true." >
<file_group id="ice_5d" output_freq="5d" output_level="10" enabled=".TRUE."> <!-- 5d files -->
<file id="file101" name_suffix="_icemod" description="ice variables" enabled=".true." >
<!-- ice mask -->
<field field_ref="icemask" name="simsk" />
......@@ -89,7 +89,7 @@
</file>
<file id="file22" name_suffix="_SBC_scalar" description="scalar variables" enabled=".true." >
<file id="file102" name_suffix="_SBC_scalar" description="scalar variables" enabled=".true." >
<!-- global contents -->
<field field_ref="ibgvol_tot" name="ibgvol_tot" />
<field field_ref="sbgvol_tot" name="sbgvol_tot" />
......@@ -116,17 +116,17 @@
</file_group>
<file_group id="1ts" output_freq="1ts" output_level="10" enabled=".TRUE."/> <!-- 1 time step files -->
<file_group id="1h" output_freq="1h" output_level="10" enabled=".TRUE."/> <!-- 1h files -->
<file_group id="2h" output_freq="2h" output_level="10" enabled=".TRUE."/> <!-- 2h files -->
<file_group id="3h" output_freq="3h" output_level="10" enabled=".TRUE."/> <!-- 3h files -->
<file_group id="4h" output_freq="4h" output_level="10" enabled=".TRUE."/> <!-- 4h files -->
<file_group id="6h" output_freq="6h" output_level="10" enabled=".TRUE."/> <!-- 6h files -->
<file_group id="ice_1ts" output_freq="1ts" output_level="10" enabled=".TRUE."/> <!-- 1 time step files -->
<file_group id="ice_1h" output_freq="1h" output_level="10" enabled=".TRUE."/> <!-- 1h files -->
<file_group id="ice_2h" output_freq="2h" output_level="10" enabled=".TRUE."/> <!-- 2h files -->
<file_group id="ice_3h" output_freq="3h" output_level="10" enabled=".TRUE."/> <!-- 3h files -->
<file_group id="ice_4h" output_freq="4h" output_level="10" enabled=".TRUE."/> <!-- 4h files -->
<file_group id="ice_6h" output_freq="6h" output_level="10" enabled=".TRUE."/> <!-- 6h files -->
<file_group id="1m" output_freq="1mo" output_level="10" enabled=".TRUE."> <!-- real monthly files -->
<file_group id="ice_1m" output_freq="1mo" output_level="10" enabled=".TRUE."> <!-- real monthly files -->
<!-- To compute transport through straits : need to read ice mask at ice iteration at freq_offset = 1mo - nn_fsbc
<file id="file23" name_suffix="_strait_ice" description="transport variables through straits" >
<file id="file103" name_suffix="_strait_ice" description="transport variables through straits" >
<field field_ref="strait_mifl" name="simassacrossline" freq_offset="1mo-4ts" />
<field field_ref="strait_msfl" name="snmassacrossline" freq_offset="1mo-4ts" />
<field field_ref="strait_arfl" name="siareaacrossline" freq_offset="1mo-4ts" />
......@@ -135,14 +135,14 @@
</file_group>
<file_group id="2m" output_freq="2mo" output_level="10" enabled=".TRUE."/> <!-- real 2m files -->
<file_group id="3m" output_freq="3mo" output_level="10" enabled=".TRUE."/> <!-- real 3m files -->
<file_group id="4m" output_freq="4mo" output_level="10" enabled=".TRUE."/> <!-- real 4m files -->
<file_group id="6m" output_freq="6mo" output_level="10" enabled=".TRUE."/> <!-- real 6m files -->
<file_group id="1y" output_freq="1y" output_level="10" enabled=".TRUE."/> <!-- real yearly files -->
<file_group id="2y" output_freq="2y" output_level="10" enabled=".TRUE."/> <!-- real 2y files -->
<file_group id="5y" output_freq="5y" output_level="10" enabled=".TRUE."/> <!-- real 5y files -->
<file_group id="10y" output_freq="10y" output_level="10" enabled=".TRUE."/> <!-- real 10y files -->
<file_group id="ice_2m" output_freq="2mo" output_level="10" enabled=".TRUE."/> <!-- real 2m files -->
<file_group id="ice_3m" output_freq="3mo" output_level="10" enabled=".TRUE."/> <!-- real 3m files -->
<file_group id="ice_4m" output_freq="4mo" output_level="10" enabled=".TRUE."/> <!-- real 4m files -->
<file_group id="ice_6m" output_freq="6mo" output_level="10" enabled=".TRUE."/> <!-- real 6m files -->
<file_group id="ice_1y" output_freq="1y" output_level="10" enabled=".TRUE."/> <!-- real yearly files -->
<file_group id="ice_2y" output_freq="2y" output_level="10" enabled=".TRUE."/> <!-- real 2y files -->
<file_group id="ice_5y" output_freq="5y" output_level="10" enabled=".TRUE."/> <!-- real 5y files -->
<file_group id="ice_10y" output_freq="10y" output_level="10" enabled=".TRUE."/> <!-- real 10y files -->
<!-- To compute transport through straits : need to read ice mask at ice iteration at freq_offset = - nn_fsbc + 1
<file id="maskMFO" name="maskMFO" enabled="true" mode="read" output_freq="1mo" cyclic="true" >
......
......@@ -3,7 +3,7 @@
<file_definition type="one_file" name="@expname@_@freq@_@startdate@_@enddate@" sync_freq="1mo" min_digits="4">
<file_group id="1h" output_freq="1h" output_level="10" enabled=".TRUE."> <!-- 1h files -->
<file_group id="oce_1h" output_freq="1h" output_level="10" enabled=".TRUE."> <!-- 1h files -->
<file id="file1" name_suffix="_gridT" description="ocean T grid variables" compression_level="3" >
<field field_ref="t_skin" name="t_skin" />
......@@ -46,17 +46,17 @@
</file_group>
<file_group id="1ts" output_freq="1ts" output_level="10" enabled=".TRUE."/> <!-- 1 time step files -->
<file_group id="2h" output_freq="2h" output_level="10" enabled=".TRUE."/> <!-- 2h files -->
<file_group id="3h" output_freq="3h" output_level="10" enabled=".TRUE."/> <!-- 3h files -->
<file_group id="4h" output_freq="4h" output_level="10" enabled=".TRUE."/> <!-- 4h files -->
<file_group id="6h" output_freq="6h" output_level="10" enabled=".TRUE."/> <!-- 6h files -->
<file_group id="1d" output_freq="1d" output_level="10" enabled=".TRUE."/> <!-- 1d files -->
<file_group id="3d" output_freq="3d" output_level="10" enabled=".TRUE."/> <!-- 3d files -->
<file_group id="5d" output_freq="5d" output_level="10" enabled=".TRUE."/> <!-- 5d files -->
<file_group id="1m" output_freq="1mo" output_level="10" enabled=".TRUE."/> <!-- real monthly files -->
<file_group id="2y" output_freq="2y" output_level="10" enabled=".TRUE."/> <!-- real 2y files -->
<file_group id="5y" output_freq="5y" output_level="10" enabled=".TRUE."/> <!-- real 5y files -->
<file_group id="10y" output_freq="10y" output_level="10" enabled=".TRUE."/> <!-- real 10y files -->
<file_group id="oce_1ts" output_freq="1ts" output_level="10" enabled=".TRUE."/> <!-- 1 time step files -->
<file_group id="oce_2h" output_freq="2h" output_level="10" enabled=".TRUE."/> <!-- 2h files -->
<file_group id="oce_3h" output_freq="3h" output_level="10" enabled=".TRUE."/> <!-- 3h files -->
<file_group id="oce_4h" output_freq="4h" output_level="10" enabled=".TRUE."/> <!-- 4h files -->
<file_group id="oce_6h" output_freq="6h" output_level="10" enabled=".TRUE."/> <!-- 6h files -->
<file_group id="oce_1d" output_freq="1d" output_level="10" enabled=".TRUE."/> <!-- 1d files -->
<file_group id="oce_3d" output_freq="3d" output_level="10" enabled=".TRUE."/> <!-- 3d files -->
<file_group id="oce_5d" output_freq="5d" output_level="10" enabled=".TRUE."/> <!-- 5d files -->
<file_group id="oce_1m" output_freq="1mo" output_level="10" enabled=".TRUE."/> <!-- real monthly files -->
<file_group id="oce_2y" output_freq="2y" output_level="10" enabled=".TRUE."/> <!-- real 2y files -->
<file_group id="oce_5y" output_freq="5y" output_level="10" enabled=".TRUE."/> <!-- real 5y files -->
<file_group id="oce_10y" output_freq="10y" output_level="10" enabled=".TRUE."/> <!-- real 10y files -->
</file_definition>