Options
From WikiROMS
				
				
				Jump to navigationJump to search
				
				
CPP Options
This wikipage includes all ROMS CPP options in alphabetic order. A single long page is built to facilitate printing. Each option also has an individual page and its definition below is loaded using labeled section transclusion syntax. The following attributes have been identified to aid in the description of ROMS CPP options:
- conflict: indicates mutually exclusive options.
- parameter: important standard input parameter(s) associtated with the option.
- parent: indicates association to a main option.
- related: indicates other affiliated option(s) that may affect or not its scope.
- required: indicates other dependent option(s) that must be activated.
- routine: main files associated with the option.
- variable: important state array(s) associtated with the option.
- input: standard input file for configuring runtime parameters
| Contents | |||||||||||||||||||||||||
| A | B | C | D | E | F | G | H | I | J | K | L | M | N | O | P | Q | R | S | T | U | V | W | X | Y | Z | 
A
- A4DVAR_TOY
- Idealized data assimilation example to run 4DVar weak constraint data assimilation algorithms.
- parameter = Ninner, Nouter
- required = RBL4DVAR or R4DVAR
- related = CONVOLVE, RPM_RELAXATION
- routine = rbl4dvar_ocean.h, r4dvar_ocean.h
- input = roms.in, s4dvar.in
- AD_IMPULSE
- Option to control the forcing of the adjoint model as an intermittent impulse (on) or continuous force term (off).
- parent = ADJOINT
- routine = adsen_force.F
- AD_SENSITIVITY
- Option to run the adjoint sensitivity ocean driver ( Moore et al., 2006).
- parent = ADJOINT
- routine = adsen_ocean.h, ocean_control.F
- ADD_FSOBC
- Option to add tidal elevation to sea surface height climatology, if any, and open boundary conditions data.
- variable = ssh, zeta_east, zeta_north, zeta_south, zeta_west
- required = SSH_TIDES
- related = ZCLIMATOLOGY
- related = EAST_FSOBC, NORTH_FSOBC, SOUTH_FSOBC, WEST_FSOBC
- routine = set_tides.F
- ADD_M2OBC
- Option to add tidal currents to 2D momentum climatology, if any, and open boundary conditions data.
- variable = ubarclm, vbarclm
- variable = ubar_east, ubar_north, ubar_south, ubar_west
- variable = vbar_east, vbar_north, vbar_south, vbar_west
- required = UV_TIDES
- related = M2CLIMATOLOGY
- related = EAST_M2OBC, NORTH_M2OBC, SOUTH_M2OBC, WEST_M2OBC
- routine = set_tides.F
- ADJOINT
- Internal option to include adjoint model. It primarily declares and allocate all adjoint state variables and activates all adjoint subroutines.
- related = TANGENT
- ADJUST_STFLUX
- Option to include surface tracer flux in 4DVar state with tangent linear, representer and adjoint models.
- parameter =
- parent =
- required =
- related = ADJUST_WSTRESS
- conflict =
- routine =
- ADJUST_WSTRESS
- Option to include wind stress in 4DVar state with tangent linear, representer and adjoint models.
- parameter =
- parent =
- required =
- related = ADJUST_STFLUX
- conflict =
- routine =
- ADM_DRIVER
- Option to run the adjoint model as a standalone driver.
- related = RPM_DRIVER, TLM_DRIVER
- routine = ocean_control.F
- ADRIA02
- Option to compile and run a realistic Adriatic Sea application.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- input = floats.in, roms.in, sediment.in, stations.in
- AFT_EIGENMODES
- Option to run the adjoint finite time eigenvalues driver ( Moore et al., 2004).
- parent = ADJOINT
- related = FT_EIGENMODES
- routine = aft_ocean.h, ocean_control.F
- AIR_OCEAN
- Option to activate two-way coupling to an atmospheric model. Currently, the coupling is done with the Model Coupling Toolkit (MCT). The coupling is either sequential or concurrent and it is only available for distributed-memory configurations. If concurrent, the MPI communicator is splited into atmosphere and ocean nodes.
- conflict = WAVES_OCEAN
- routine = master.F, air_ocean.h
- input = coupling.in
- ALBEDO
- Option to compute net shortwave radiation flux using the Laevastu (1960) cloud correction to the Zillerman (1972) equation for cloudless radiation (Parkinson and Washington, 1979).
- variable = srflx
- required = ANA_SRFLUX
- related = DIURNAL_SRFLUX
- routine = analytical.F (ana_srflux)
- ANA_BIOLOGY
- Option to set biological tracers initial conditions with analytical expressions.
- variable = t(:,:,:,:,idbio(1:NBT))
- related = BIOLOGY
- routine = analytical.F (ana_biology)
- ANA_BMFLUX
- Option to set spatially varying bottom roughness with an analytical expression.
- variable =
- required = SEDIMENT
- conflict = ANA_SEDIMENT
- routine = analytical.F (ana_bmflux)
- ANA_BPFLUX
- Option to set passive tracers bottom flux with analytical expressions (usually zero, no bottom flux).
- variable = btflx(:,:,NAT+1:NT(ng))
- required = BIOLOGY, SEDIMENT
- related = ANA_BSFLUX, ANA_BTFLUX
- routine = analytical.F (ana_btflux)
- ANA_BSFLUX
- Option to set kinematic bottom salinity flux with an analytical expression (usually zero, no bottom flux).
- variable = btflx(:,:,isalt)
- required = SALINITY, SOLVE3D
- related = ANA_BPFLUX, ANA_BTFLUX
- routine = analytical.F (ana_btflux)
- ANA_BTFLUX
- Option to set kinematic bottom heat flux with an analytical expression (usually zero, no bottom flux).
- variable = btflx(:,:,itemp)
- required = SOLVE3D
- related = ANA_BPFLUX, ANA_BSFLUX
- routine = analytical.F (ana_btflux)
- ANA_CLOUD
- Option to set cloud fraction with an analytical expression.
- variable = cloud
- routine = analytical.F (ana_cloud)
- ANA_DIAG
- Option to activate the computation of any user specified diagnostics.
- routine = analytical.F (ana_diag), diag.F
- ANA_FSOBC
- Option to set free-surface open boundary conditions using analytical expressions.
- variable = zeta_east, zeta_north, zeta_south, zeta_west
- required = OBC
- routine = analytical.F (ana_fsobc)
- ANA_GRID
- Option to set application grid variables with analytical expressions. Mostly, all the idealized test problems use this option. It sets the following grid-related variables: Coriolis parameter, bathymetry, ξ- and η-direction metrics and its derivates, curvilinear grid angle, ξ- and η-direction coordinates, and spherical coordinates, if applicable.
- variable = f, h
- variable = angler, dmde , dndx, pm , pn
- variable = xp, xr, xu, xv, yp, yr, yu, yv
- variable = lonp, lonr, lonu, lonv, latp, latr, latu, latv
- routine = analytical.F (ana_grid)
- ANA_HUMIDITY
- Option to set surface air humidity (moisture) with an analytical expression. There are three types of humidity: i) absolute humidity is the density of water vapor, ii) specific humidity is the ratio of the mass of water vapor to the mass of moist air containing the vapor (g/kg), and iii) relative humidity is the ratio of the actual mixing ratio to saturation mixing ratio of the air at a given temperature and pressure (percentage).
- variable = Hair
- required = ALBEDO, BULK_FLUXES, ECOSIM
- routine = analytical.F (ana_humid)
- ANA_INITIAL
- Option to set initial conditions for free-surface, momentum, and tracers with analytical expressions. Mostly, all the idealized test problems use this option.
- variable = zeta, ubar, vbar
- variable = u, v, t
- conflict = INI_FILE
- routine = analytical.F (ana_initial)
- ANA_M2CLIMA
- Option to set 2D momentum climatology with analytical expressions.
- variable = ubarclm, vbarclm
- required = M2CLIMATOLOGY
- related = M2CLM_NUDGING, UV_TIDES
- routine = analytical.F (ana_m2clima)
- ANA_M2OBC
- Option to set 2D momentum open boundary conditions using analytical expressions.
- variable = ubar_east, ubar_north, ubar_south, ubar_west
- variable = vbar_east, vbar_north, vbar_south, vbar_west
- required = OBC
- routine = analytical.F (ana_m2obc)
- ANA_M3CLIMA
- Option to set 3D momentum climatology with analytical expressions.
- variable = uclm, vclm
- parent = SOLVE3D
- required = M3CLIMATOLOGY
- related = M3CLM_NUDGING
- routine = analytical.F (ana_m3clima)
- ANA_M3OBC
- Option to set 3D momentum open boundary conditions using analytical expressions.
- variable = u_east, u_north, u_south, u_west
- variable = v_east, v_north, v_south, v_west
- required = OBC
- routine = analytical.F (ana_m3obc)
- ANA_MASK
- Option to set land/sea masking using the analytical set-up. It is used in few idealized test problems. The mask has a value of zero over land and unity over water.
- variables = pmask, rmask, umask, vmask
- routine = analytical.F (ana_mask)
- ANA_PAIR
- Option to set surface air pressure with an analytical expression.
- variable = Pair
- required = BULK_FLUXES, ECOSIM
- routine = analytical.F (ana_pair)
- ANA_PASSIVE
- Option to set inert, passive tracers initial conditions with analytical expressions.
- variable = t(:,:,:,:,inert(1:NPT))
- parent = SOLVE3D
- required = T_PASSIVE
- routine = analytical.F (ana_passive)
- ANA_PERTURB
- Option to perturb tangent linear and adjoint state initial conditions at specified spatial (i,j,k) location. This is used to determine the correctness of the tangent linear and adjoint models by computing the inner product at the specified location. This inner product must be symmetric within roundoff (A - AT = 0).
- parameter = user(1:8)
- parent = ADJOINT, TANGENT
- required = SANITY_CHECK
- related = INNER_PRODUCT
- routine = analytical.F (ana_perturb)
- ANA_PSOURCE
- Option to set point sources and sinks with analytical expressions. Usually, river runoff are represented as a point source.
- variable = Isrc, Jsrc, Lsrc, Dsrc
- variable = Qbar, Qshape, Qsrc, Tsrc
- required = Q_PSOURCE, TS_PSOURCE, UV_PSOURCE
- routine = analytical.F (ana_psource)
- ANA_RAIN
- Option to set rain fall rate with an analytical expression.
- variable = rain
- required = BULK_FLUXES
- related = EMINUSP
- routine = analytical.F (ana_rain)
- ANA_SEDIMENT
- Option to set cohesive and non-cohesive sediment initial conditions with analytical expressions. It also initializes sediment bed layer properties (thickness, age, porosity), sediment fraction and mass of each size class in each bed layer, and exposed sediment layer properties (mean grain diameter, mean grain density, mean settling velocity, mean critical erosion stress, ripple length and height, bed wave excursion amplitude, and several bottom roughnesses).
- variable = t(:,:,:,:,idsed(1:NST))
- variable = bed, bed_frac, bed_mass, bottom
- parent = SOLVE3D
- required = SEDIMENT
- related = BBL_MODEL, SED_BIODIFF
- routine = analytical.F (ana_sediment)
- ANA_SMFLUX
- Option to set kinematic, surface momentum flux boundary condition (wind stress) with analytical expressions.
- variable = sustr, svstr
- routine = analytical.F (ana_smflux)
- ANA_SPFLUX
- Option to set passive tracers surface flux with analytical expressions (usually zero, no flux).
- variable = stflx(:,:,NAT+1:NT(ng))
- related = BIOLOGY, SEDIMENT
- routine = analytical.F (ana_stflux)
- ANA_SPINNING
- Option to set time-variable rotation force as the sum of Coriolis and centripetal accelerations. This option is used in polar coordinates (annulus grid) applications.
- variable = f, fomn
- related = LAB_CANYON
- routine = analytical.F (ana_spinning)
- ANA_SRFLUX
- Option to set kinematic, surface solar shortwave radiation flux with an analytical expression.
- variable = srflx
- related = ALBEDO, DIURNAL_SRFLUX
- routine = analytical.F (ana_srflux)
- ANA_SSFLUX
- Option to set kinematic surface freshwater flux (E-P) using an analytical expression.
- variable = stflx(:,:,isalt)
- parent = SOLVE3D
- related = ANA_SPFLUX, ANA_STFLUX
- conflict = EMINUSP
- routine = analytical.F (ana_stflux)
- ANA_SSH
- Option to set sea surface height climatology with an analytical expression.
- variable = ssh
- required = ZCLIMATOLOGY
- routine = analytical.F (ana_ssh)
- ANA_SSS
- Option to set sea surface salinity with an analytical expression.
- variable = sss
- required = SALINITY
- related = SCORRECTION, SRELAXATION
- routine = analytical.F (ana_sss)
- ANA_SST
- Option to set sea surface temperature with an analytical expression. It also sets surface net heat flux sensitivity to sea surface temperature. Both fields are used for surface net heat flux correction.
- variable = dqdt, sst
- related = QCORRECTION
- routine = analytical.F (ana_sst), set_vbc.F
- ANA_STFLUX
- Option to set kinematic surface net flux of tracers using analytical expressions.
- variable = stflx(:,:,1:NT)
- parent = SOLVE3D
- related = ANA_SPFLUX, ANA_SSFLUX
- conflict =
- routine = analytical.F (ana_stflux)
- ANA_TAIR
- Option to set surface air temperature with an analytical expression
- variable = Tair
- parent = SOLVE3D
- required = ALBEDO, BULK_FLUXES, ECOSIM
- related = ANA_SRFLUX
- routine = analytical.F (ana_tair)
- ANA_TCLIMA
- Option to set tracer climatology with analytical expressions.
- variable = tclm
- parent = SOLVE3D
- required = TCLIMATOLOGY
- related = TCLM_NUDGING
- routine = analytical.F (ana_tclima)
- ANA_TOBC
- Option to set tracers open boundary conditions using analytical expressions.
- variable = t_east, t_north, t_south, t_west
- required = OBC
- routine = analytical.F (ana_tobc)
- ANA_VMIX
- Option to set vertical mixing coefficients for momentum and tracers with analytical expressions.
- variable = Akt(:,:,:,1:NAT), Akv
- parent = SOLVE3D
- conflict = BVF_MIXING, GLS_MIXING, LMD_MIXING, MY25_MIXING
- routine = analytical.F (ana_vmix)
- ANA_WINDS
- Option to set surface wind vector components with analytical expressions.
- variable = Uwind, Vwind
- required = BULK_FLUXES, ECOSIM
- routine = analytical.F (ana_winds)
- ANA_WWAVE
- Option to set wind-induced wave fields with analytical expressions. It currently, sets values for wave direction, height, length, top and bottom periods, and dissipation.
- variable = Dwave, Hwave, Lwave, Pwave_top, Pwave_bot, wave_dissip
- required = BBL_MODEL
- related = WAVES_HEIGHT, WAVES_LENGTH, WAVES_TOP_PERIOD, WAVES_BOT_PERIOD
- related = TKE_WAVEDISS
- routine = analytical.F (ana_wwave)
- ASSIMILATION
- Internal option defined when any of the optimal interpolation assimilation options is activated.
- related = ASSIMILATION_SSH, ASSIMILATION_SST, ASSIMILATION_T, ASSIMILATION_UV, ASSIMILATION_UVsur
- conflict = NUDGING, I4DVAR, S4DVAR, RBL4DVAR, R4DVAR
- routine = globaldefs.h
- ASSIMILATION_SSH
- Option to assimilate sea surface height observations (altimetry) using optimal interpolation.
- variable = EdatSSH, EobsSSH, SSHdat, SSHobs
- parent = ASSIMILATION
- related = ASSIMILATION_SST, ASSIMILATION_T, ASSIMILATION_UV, ASSIMILATION_UVsur
- conflict = NUDGING_SSH
- routine = oi_update.F
- ASSIMILATION_SST
- Option to assimilate sea surface temperature observations using optimal interpolation.
- variable = EdatSST, EobsSST, SSTdat, SSTobs
- parent = ASSIMILATION
- related = ASSIMILATION_SSH, ASSIMILATION_T, ASSIMILATION_UV, ASSIMILATION_UVsur
- conflict = NUDGING_SST
- routine = oi_update.F
- ASSIMILATION_T
- Option to assimilate tracer-type observations (temperature, salinity) using optimal interpolation.
- variable = EdatT, EobsT, Tdat, Tobs
- parent = ASSIMILATION
- related = ASSIMILATION_SSH, ASSIMILATION_SST, ASSIMILATION_UV, ASSIMILATION_UVsur
- conflict = NUDGING_T
- routine = oi_update.F
- ASSIMILATION_UV
- Option to assimilate 3D momentum (u,v) observations using optimal interpolation.
- variable = EdatUV, EobsUV, UVdat, UVobs
- parent = ASSIMILATION
- related = ASSIMILATION_SSH, ASSIMILATION_SST, ASSIMILATION_T, ASSIMILATION_UVsur
- conflict = NUDGING_UV
- routine = oi_update.F
- ASSIMILATION_UVsur
- Option to assimilate surface momentum (u,v) observations (CODAR) using optimal interpolation.
- variable = EdatVsur, EobsVsur, Usurdat, Usur, Vsurdat, Vsur
- parent = ASSIMILATION
- related = ASSIMILATION_SSH, ASSIMILATION_SST, ASSIMILATION_T, ASSIMILATION_UV
- conflict = NUDGING_UVsur
- routine = oi_update.F
- ASSUMED_SHAPE
- Internal option to declare all global arrays as assumed-shape where their size, bounds, and shape are associated with pointers. Imported arrays with dummy arguments that takes the shape of the actual argument passes to it. If not activated, all the arrays are of explicit-shape. In some computers the explicit-shape arrays slow down performance because the arrays are copied when passed as arguments.
- routine = globaldefs.h
- ATM_PRESS
- Option to impose atmospheric pressure onto sea surface. If SOLVE3D is activated the pressure is imposed on the 3D pressure gradient equations (*prsgrd*.h, i.e. prsgrd31.h). Otherwise, it is imposed on the 2D pressure gradient equations found in the step2d_LF_AM3.h routines.
- parameter =
- parent =
- required = SOLVE3D
- related = DJ_GRADPS, PJ_GRADP, PJ_GRADPQ2, PJ_GRADPQ4, SOLVE3D, WJ_GRADP
- conflict =
- routine = ad_prsgrd.F, prsgrd.F, rp_prsgrd.F, tl_prsgrd.F, ad_step2d_LF_AM3.h, step2d_LF_AM3.h, rp_step2d_LF_AM3.h, tl_step2d_LF_AM3.h
- AVERAGES
- Option to write out time-averaged fields into output NetCDF file.
- parameter = nAVG, ndefAVG, ntsAVG
- related = AVERAGES_AKS, AVERAGES_AKT, AVERAGES_AKV, AVERAGES_BEDLOAD, AVERAGES_FLUXES, AVERAGES_NEARSHORE, AVERAGES_QUADRATIC
- routine = def_avg.F, set_avg.F, wrt_AVG.F
- AVERAGES_AKS (REMOVED)
- This option was removed in revision 462. Option to write out time-averaged vertical diffusion of salinity into output NetCDF file. Use this option when any of the vertical mixing parameterizations is activated.
- parameter = nAVG, ndefAVG, ntsAVG
- parent = AVERAGES
- required = AVERAGES
- related = AVERAGES_AKT, AVERAGES_AKV, AVERAGES_BEDLOAD, AVERAGES_FLUXES, AVERAGES_NEARSHORE, AVERAGES_QUADRATIC
- routine = def_avg.F, set_avg.F, wrt_AVG.F
- AVERAGES_AKT (REMOVED)
- This option was removed in revision 462. Option to write out time-averaged vertical diffusion of temperature into output NetCDF file. Use this option when any of the vertical mixing parameterizations is activated.
- parameter = nAVG, ndefAVG, ntsAVG
- parent = AVERAGES
- required = AVERAGES
- related = AVERAGES_AKS, AVERAGES_AKV, AVERAGES_BEDLOAD, AVERAGES_FLUXES, AVERAGES_NEARSHORE, AVERAGES_QUADRATIC
- routine = def_avg.F, set_avg.F, wrt_AVG.F
- AVERAGES_AKV (REMOVED)
- This option was removed in revision 462. Option to write out time-averaged vertical viscosity into output NetCDF file. Use this option when any of the vertical mixing parameterizations is activated.
- parameter = nAVG, ndefAVG, ntsAVG
- parent = AVERAGES
- required = AVERAGES
- related = AVERAGES_AKS, AVERAGES_AKT, AVERAGES_BEDLOAD, AVERAGES_FLUXES, AVERAGES_NEARSHORE, AVERAGES_QUADRATIC
- routine = def_avg.F, set_avg.F, wrt_AVG.F
- AVERAGES_BEDLOAD (REMOVED)
- This option was removed in revision 462. Option to write out time-averaged bed load components into output NetCDF file.
- parameter = nAVG, ndefAVG, ntsAVG
- parent = AVERAGES
- required = AVERAGES, BEDLOAD, SEDIMENT
- related = AVERAGES_AKS, AVERAGES_AKT, AVERAGES_AKV, AVERAGES_FLUXES, AVERAGES_NEARSHORE, AVERAGES_QUADRATIC
- routine = def_avg.F, set_avg.F, wrt_AVG.F
- AVERAGES_DETIDE
- Option to write out time-averaged detided feilds into output NetCDF file.
- parameter = nAVG, ndefAVG, ntsAVG
- parent = AVERAGES
- required = AVERAGES
- related =
- routine = def_avg.F, set_avg.F, wrt_AVG.F
- AVERAGES_FLUXES (REMOVED)
- This option was removed in revision 462. Option to write out time-averaged surface momentum stress and several fields associated with surface heat and freshwater fluxes.
- parameter = nAVG, ndefAVG, ntsAVG
- parent = AVERAGES
- required = AVERAGES
- related = AVERAGES_AKS, AVERAGES_AKT, AVERAGES_AKV, AVERAGES_BEDLOAD, AVERAGES_NEARSHORE, AVERAGES_QUADRATIC, BULK_FLUXES
- routine = def_avg.F, set_avg.F, wrt_AVG.F
- AVERAGES_NEARSHORE (REMOVED)
- This option was removed in revision 462. Option to write out time-averaged nearshore stresses variables.
- parameter = nAVG, ndefAVG, ntsAVG
- parent = AVERAGES
- required = AVERAGES, NEARSHORE_MELLOR
- related = AVERAGES_AKS, AVERAGES_AKT, AVERAGES_AKV, AVERAGES_BEDLOAD, AVERAGES_FLUXES, AVERAGES_QUADRATIC
- routine = def_avg.F, set_avg.F, wrt_AVG.F
- AVERAGES_QUADRATIC (REMOVED)
- This option was removed in revision 462. Option to write out time-averaged variables needed to compute eddy fluxes. These quadratic variables include <H u / n>, <H v / m>, <H u T / n>, <H v T / m>, <T T>, <u T>, <v T>, <u u>, <v v>, <ubar ubar>, <vbar vbar>, and <zeta zeta>.
- parameter = nAVG, ndefAVG, ntsAVG
- parent = AVERAGES
- required = AVERAGES
- related = AVERAGES_AKS, AVERAGES_AKT, AVERAGES_AKV, AVERAGES_BEDLOAD, AVERAGES_FLUXES, AVERAGES_NEARSHORE
- routine = def_avg.F, set_avg.F, wrt_AVG.F
B
- BACKGROUND
- Internal option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- BALANCE_OPERATOR
- Option to enable error covariance multivariate balance term in the tangent linear, representer and adjoint models.
- parameter =
- parent =
- required = ADJOINT, REPRESENTER, TANGENT
- related =
- conflict =
- routine =
- BASIN
- Options to compile and run the Big Bad Basin example.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in
- BEDLOAD
- Internal option to
- parameter =
- parent =
- required = SEDIMENT and BEDLOAD_MPM or BEDLOAD_SOULSBY
- related = AVERAGES_BEDLOAD], BEDLOAD_MPM, BEDLOAD_SOULSBY
- conflict =
- routine = sed_bedload.F
- BEDLOAD_MPM
- Option to activate Meyer-Peter-Mueller bed load in the sediment transport model.
- parameter =
- parent =
- required = SEDIMENT
- related = AVERAGES_BEDLOAD], BEDLOAD_SOULSBY
- conflict = BEDLOAD_SOULSBY
- routine = sed_bedload.F
- BEDLOAD_SOULSBY
- Option to activate Soulsby wave/current bed load in the sediment transport model.
- parameter =
- parent =
- required =
- related = SEDIMENT
- related = AVERAGES_BEDLOAD], BEDLOAD_MPM
- conflict = BEDLOAD_MPM
- routine = sed_bedload.F
- BENCHMARK
- Option to compile and run the benchmark tests. The benchmark comes in 3 sizes that can be selected at runtime.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in (ocean_benchmark1, 2 & 3)
- BIO_FENNEL
- Option to activate Fennel et al. ecosystem model (Fennel et al., 2009; Fennel et al., 2006). This model is loosely based on the model by Fasham et al. (1990) but it differs in many respects. The detailed equations of the nitrogen cycling component are given in Fennel et al., (2006) Nitrogen is the fundamental elemental currency in this model. This model was adapted from a code written originally by John Moisan and Emanule DiLorenzo.
- related = ANA_BIOLOGY, ANA_BPFLUX, ANA_SPFLUX, BIO_SEDIMENT, CARBON, DENITRIFICATION, DIAGNOSTICS_BIO, OXYGEN, TALK_PROGNOSTIC
- conflict = ECOSIM, NEMURO, NPZD_FRANKS, NPZD_IRON, NPZD_POWELL
- routine = fennel.h
- input = bioFennel.in
- BIO_SEDIMENT
- Option to restore fallen particulate material to the nutrient pool in the Fennel model.
- parent = BIO_FENNEL
- routine = fennel.h
- BIO_TOY
- Option to compile and run the one-dimensional (vertical) biology toy.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in
- BIOLOGY
- Internal option defined when any of the biological models is activated.
- related = BIO_FENNEL, ECOSIM, NEMURO, NPZD_FRANKS, NPZD_POWELL
- routine = biology.F
- BL_TEST
- Option to compile and run the boundary layers test.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in, stations.in
- BODYFORCE
- Option to apply stresses as body forces.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- BULK_FLUXES
- Option to use bulk fluxes computation for surface fluxes formulation using atmospheric boundary layer.
- parameter =
- parent =
- required =
- related = COOL_SKIN, EMINUSP, LONGWAVE, LONGWAVE_OUT, NL_BULK_FLUXES
- conflict =
- routine =
- BVF_MIXING
- Option to use Brunt-Vaisala frequency mixing for vertical turbulent mixing scheme of momentum and tracers.
- parameter =
- parent =
- required =
- related =
- conflict = GLS_MIXING, LMD_MIXING, MY25_MIXING
- routine = bvf_mix.F
C
- CANUTO_A
- Option to use Canuto A-stability function formulation for the Generic Length Scale closure.
- parameter =
- parent = GLS_MIXING
- required = GLS_MIXING
- related = CANUTO_B, KANTHA_CLAYSON
- conflict = CANUTO_B, KANTHA_CLAYSON
- routine = gls_corstep.F
- CANUTO_B
- Option to use Canuto B-stability function formulation for the Generic Length Scale closure.
- parameter =
- parent = GLS_MIXING
- required = GLS_MIXING
- related = CANUTO_A, KANTHA_CLAYSON
- conflict = CANUTO_A, KANTHA_CLAYSON
- routine = gls_corstep.F
- CANYON
- Option to compile and run the coastal form stress canyon test.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in (_canyon2d and _canyon3d)
- CARBON
- Option to include carbon constituents in the Fennel biological model. Currently, four carbon-based tracer are added to include large detritus (iLDeC), small detritus (iSDeC), total inorganic carbon (iTIC_), and total alkalinity (iTAlk).
- parent = BIO_FENNEL
- required = OXYGEN
- routine = fennel.h
- CELERITY_WRITE
- Option to write radiation celerity in forward file when running tangent linear, representer and adjoint models.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = mod_boundary.F
- CHANNEL_NECK
- Option to compile and run the idealized channel with constriction test.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in (_channel_neck1 _channel_neck3)
- CHARNOK
- Option to use Charnok surface roughness from wind stress for the Generic Length Scale closure.
- parameter =
- parent = GLS_MIXING
- required = GLS_MIXING
- related =
- conflict =
- routine = gls_corstep.F
- CHECKPOINTING
- Internal switch to activate checkpointing switch for generalized stability theory (GST) analysis.
- parameter =
- parent =
- required = PROPAGATOR
- related =
- conflict =
- routine =
- CLIMA_TS_MIX
- Option to use if diffusion of tracer perturbation (t-tclm) is needed for horizontal mixing of tracers.
- parameter =
- parent =
- required =
- related = DIFF_GRID, MIX_S_TS, MIX_GEO_TS, MIX_ISO_TS
- conflict =
- routine =
- CLOUDS
- Internal option indicating that cloud data is needed.
- required = ALBEDO, ECOSIM, LONGWAVE
- related = BULK_FLUXES, ANA_SRFLUX
- routine = globaldefs.h
- COARE_OOST
- Option to use Oost et al. (2002) relation for wave roughness formulation in bulk fluxes.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- COARE_TAYLOR_YELLAND
- Option to use Taylor and Yelland (2001) relation for wave roughness formulation in bulk fluxes.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- CONVOLUTION
- Option to use the adjoint convolution driver.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- CONVOLVE
- Option to use convolving solution with diffusion operators in the tangent linear, representer and adjoint models.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- COOL_SKIN
- Option to use cool skin correction for surface fluxes formulation using atmospheric boundary layer.
- parameter =
- parent =
- required =
- related = BULK_FLUXES
- conflict =
- routine = ad_bulk_fluxes.F, bulk_fluxes.F, rp_bulk_fluxes.F, tl_bulk_flux.F
- CORRELATION
- Option to use background-error correlation model driver.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- COSINE2
- Internal switch to activate the cosine-squared shaped filter.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- COUPLING_TEST
- Option to compile and run the two-way atmosphere-ocean coupling test.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in
- CRAIG_BANNER
- Option to use Craig and Banner wave breaking surface flux for the Generic Length Scales closure.
- parameter =
- parent = GLS_MIXING
- required = GLS_MIXING
- related =
- conflict =
- routine =
- CURVGRID
- Option to indicate the ROMS grid coordinates are curvilinear.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
D
- DAMEE_4
- Option to Compile and run the 3/4° north Atlantic DAMEE application
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in
- DATALESS_LOOPS
- Option to test convergence of Picard iterations with the tangent linear, representer and adjoint models.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- DEBUGGING
- Option to avoid writing current date and CPP options to NetCDF file headers. This is used to compare serial and parallel solutions where the UNIX command "diff" is used between NetCDF files. It will only tell us whether the binary files are different or not. Finding the parallel bug is a completely different story.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- DEEPWATER_WAVES
- Option to use deep water waves approximation for wave roughness formulation in bulk fluxes.
- parameter =
- parent = BULK_FLUXES
- required = BULK_FLUXES
- related = COARE_TAYLOR_YELLAND, COARE_OOST
- conflict = COARE_TAYLOR_YELLAND, COARE_OOST
- routine = bulk_flux.F
- DEFLATE
- Option to set compression for NetCDF-4/HDF5 output files.
- parameter =
- parent = NETCDF4
- required = NETCDF4
- related =
- conflict =
- routine =
- DENITRIFICATION
- Option to include denitrification processes in the Fennel biological model.
- parent = BIO_FENNEL
- routine = fennel.h
- DIAGNOSTICS
- Internal option to compute and write balance term diagnostics for tracers and momentum.
- related = DIAGNOSTICS_BIO, DIAGNOSTICS_TS, DIAGNOSTICS_UV
- routine = set_diags.F, wrt_diags.F
- DIAGNOSTICS_BIO
- Option to compute and write biological diagnostic terms in the Fennel model.
- parent = BIO_FENNEL
- related = DIAGNOSTICS_TS, DIAGNOSTICS_UV
- routine = fennel.h, wrt_diags.F
- DIAGNOSTICS_TS
- Option to compute and write diagnostic terms for tracer equations balances.
- related = DIAGNOSTICS_BIO, DIAGNOSTICS_UV
- routine = set_diags.F, step3d_t.F, wrt_diags.F
- DIAGNOSTICS_UV
- Option to compute and write diagnostic terms for momentum equations balances.
- related = DIAGNOSTICS_BIO, DIAGNOSTICS_TS
- routine = set_diags.F, step2d.F, step3d_t.F, wrt_diags.F
- DIFF_GRID
- Option to scale diffusion coefficients by grid size for horizontal mixing of tracers.
- parameter =
- parent =
- required =
- related = CLIMA_TS_MIX, MIX_S_TS, MIX_GEO_TS, MIX_ISO_TS
- conflict =
- routine =
- DIURNAL_SRFLUX
- Option to impose shortwave radiation local diurnal cycle for shortwave radiation. Input shortwave radiation data computed from averaged data (with snapshots greater than or equal to 24 hours) can be modulated by the local diurnal cycle which is a function of longitude, latitude and day of the year.
- variable = srflux
- parent =
- required = ANA_SRFLUX
- related = ALBEDO
- conflict =
- routine = analytical.F (ana_srflux)
- DISTRIBUTE
- Internal switch for compiling the model to run in parallel using distributed memory (MPI).
- variable =
- parent =
- required =
- related =
- conflict =
- routine =
- DJ_GRADPS
- Option to use splines density Jacobian (Shchepetkin, 2000) for pressure gradient algorithm.
- parameter =
- parent =
- required = SOLVE3D
- related = ATM_PRESS, PJ_GRADP, PJ_GRADPQ2, PJ_GRADPQ4, WJ_GRADP
- conflict = PJ_GRADP, PJ_GRADPQ2, PJ_GRADPQ4, WJ_GRADP
- routine = ad_prsgrd.F, prsgrd.F, rp_prsgrd.F, tl_prsgrd.F
- DOUBLE_GYRE
- Option to compile and run the idealized Double-gyre example.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in
- DOUBLE_PRECISION
- Internal switch to enable double precision variables. This switch is on by default.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = globaldefs.h
E
- EAST_FSCLAMPED
- Option to use free-surface clamped condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_FSCLAMPED, SOUTH_FSCLAMPED, WEST_FSCLAMPED
- conflict = EW_PERIODIC, EAST_FSCHAPMAN, EAST_FSGRADIENT, EAST_FSNUDGING, EAST_FSRADIATION, EASTERN_WALL
- routine = zetabc.F
- EAST_FSCHAPMAN
- Option to use free-surface Chapman condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_FSCHAPMAN, SOUTH_FSCHAPMAN, WEST_FSCHAPMAN
- conflict = EW_PERIODIC, EAST_FSCLAMPED, EAST_FSGRADIENT, EAST_FSNUDGING, EAST_FSRADIATION, EASTERN_WALL
- routine = zetabc.F
- EAST_FSGRADIENT
- Option to use free-surface gradient condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_FSGRADIENT, SOUTH_FSGRADIENT, WEST_FSGRADIENT
- conflict = EW_PERIODIC, EAST_FSCLAMPED, EAST_FSCHAPMAN, EAST_FSNUDGING, EAST_FSRADIATION, EASTERN_WALL
- routine = zetabc.F
- EAST_FSNUDGING
- Option to use free-surface passive/active nudging term for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_FSNUDGING, SOUTH_FSNUDGING, WEST_FSNUDGING
- conflict = EW_PERIODIC, EAST_FSCLAMPED, EAST_FSCHAPMAN, EAST_FSGRADIENT, EASTERN_WALL
- routine = zetabc.F
- EAST_FSRADIATION
- Option to use free-surface radiation condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_FSRADIATION, SOUTH_FSRADIATION, WEST_FSRADIATION
- conflict = EW_PERIODIC, EAST_FSCLAMPED, EAST_FSCHAPMAN, EAST_FSGRADIENT, EASTERN_WALL
- routine = zetabc.F
- EAST_KGRADIENT
- Option to use TKE fields gradient condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_KGRADIENT, SOUTH_KGRADIENT, WEST_KGRADIENT
- conflict = EW_PERIODIC, EAST_KRADIATION, EASTERN_WALL
- routine = tkebc_im.F
- EAST_KRADIATION
- Option to use TKE fields radiation condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_KRADIATION, SOUTH_KRADIATION, WEST_KRADIATION
- conflict = EW_PERIODIC, EAST_KGRADIENT, EASTERN_WALL
- routine = tkebc_im.F
- EAST_M2CLAMPED
- Option to use 2D momentum clamped condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_M2CLAMPED, SOUTH_M2CLAMPED, WEST_M2CLAMPED
- conflict = EW_PERIODIC, EAST_M2FLATHER, EAST_M2GRADIENT, EAST_M2NUDGING, EAST_M2RADIATION, EAST_M2REDUCED, EASTERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- EAST_M2FLATHER
- Option to use 2D momentum Flather condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_M2FLATHER, SOUTH_M2FLATHER, WEST_M2FLATHER
- conflict = EW_PERIODIC, EAST_M2CLAMPED, EAST_M2GRADIENT, EAST_M2NUDGING, EAST_M2RADIATION, EAST_M2REDUCED, EASTERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- EAST_M2GRADIENT
- Option to use 2D momentum gradient condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_M2GRADIENT, SOUTH_M2GRADIENT, WEST_M2GRADIENT
- conflict = EW_PERIODIC, EAST_M2CLAMPED, EAST_M2FLATHER, EAST_M2NUDGING, EAST_M2RADIATION, EAST_M2REDUCED, EASTERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- EAST_M2NUDGING
- Option to use 2D momentum passive/active nudging term for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_M2NUDGING, SOUTH_M2NUDGING, WEST_M2NUDGING
- conflict = EW_PERIODIC, EAST_M2CLAMPED, EAST_M2FLATHER, EAST_M2GRADIENT, EAST_M2REDUCED, EASTERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- EAST_M2RADIATION
- Option to use 2D momentum radiation condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_M2RADIATION, SOUTH_M2RADIATION, WEST_M2RADIATION
- conflict = EW_PERIODIC, EAST_M2CLAMPED, EAST_M2FLATHER, EAST_M2GRADIENT, EAST_M2REDUCED, EASTERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- EAST_M2REDUCED
- Option to use 2D momentum reduced-physics for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_M2REDUCED, SOUTH_M2REDUCED, WEST_M2REDUCED
- conflict = EW_PERIODIC, EAST_M2CLAMPED, EAST_M2FLATHER, EAST_M2GRADIENT, EAST_M2NUDGING, EAST_M2RADIATION, EASTERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- EAST_M3CLAMPED
- Option to use 3D momentum clamped condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_M3CLAMPED, SOUTH_M3CLAMPED, WEST_M3CLAMPED
- conflict = EW_PERIODIC, EAST_M3GRADIENT, EAST_M3NUDGING, EAST_M3RADIATION, EASTERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- EAST_M3GRADIENT
- Option to use 3D momentum gradient condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_M3GRADIENT, SOUTH_M3GRADIENT, WEST_M3GRADIENT
- conflict = EW_PERIODIC, EAST_M3CLAMPED, EAST_M3NUDGING, EAST_M3RADIATION, EASTERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- EAST_M3NUDGING
- Option to use 3D momentum passive/active nudging term for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_M3NUDGING, SOUTH_M3NUDGING, WEST_M3NUDGING
- conflict = EW_PERIODIC, EAST_M3CLAMPED, EAST_M3GRADIENT, EASTERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- EAST_M3RADIATION
- Option to use 3D momentum radiation condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_M3RADIATION, SOUTH_M3RADIATION, WEST_M3RADIATION
- conflict = EW_PERIODIC, EAST_M3CLAMPED, EAST_M3GRADIENT, EASTERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- EAST_TCLAMPED
- Option to use tracer clamped condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_TCLAMPED, SOUTH_TCLAMPED, WEST_TCLAMPED
- conflict = EW_PERIODIC, EAST_TGRADIENT, EAST_TNUDGING, EAST_TRADIATION, EASTERN_WALL
- routine = t3dbc_im.F
- EAST_TGRADIENT
- Option to use tracer gradient condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_TGRADIENT, SOUTH_TGRADIENT, WEST_TGRADIENT
- conflict = EW_PERIODIC, EAST_TCLAMPED, EAST_TNUDGING, EAST_TRADIATION, EASTERN_WALL
- routine = t3dbc_im.F
- EAST_TNUDGING
- Option to use tracer passive/active nudging term for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_TNUDGING, SOUTH_TNUDGING, WEST_TNUDGING
- conflict = EW_PERIODIC, EAST_TCLAMPED, EAST_TGRADIENT, EASTERN_WALL
- routine = t3dbc_im.F
- EAST_TRADIATION
- Option to use tracer radiation condition for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_TRADIATION, SOUTH_TRADIATION, WEST_TRADIATION
- conflict = EW_PERIODIC, EAST_TCLAMPED, EAST_TGRADIENT, EASTERN_WALL
- routine = t3dbc_im.F
- EAST_VOLCONS
- Option to use Southern edge mass conservation enforcement for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_VOLCONS, SOUTH_VOLCONS, WEST_VOLCONS
- conflict = EW_PERIODIC, EASTERN_WALL
- routine = obc_volcons.F
- EASTERN_WALL
- Option to use Southern edge closed wall for the eastern open boundary condition.
- parameter =
- parent =
- required =
- related = NORTH_WALL, SOUTH_WALL, WEST_WALL
- conflict = EW_PERIODIC, EAST_FSCLAMPED, EAST_FSCHAPMAN, EAST_FSGRADIENT, EAST_FSNUDGING, EAST_FSRADIATION, EAST_KGRADIENT, EAST_KRADIATION, EAST_M2CLAMPED, EAST_M2FLATHER, EAST_M2GRADIENT, EAST_M2NUDGING, EAST_M2RADIATION, EAST_M2REDUCED, EAST_M3CLAMPED, EAST_M3GRADIENT, EAST_M3NUDGING, EAST_M3RADIATION, EAST_TCLAMPED, EAST_TGRADIENT, EAST_TNUDGING, EAST_TRADIATION, EAST_VOLCONS
- routine = t3dbc_im.F, tkebc_im.F, u2dbc_im.F, u3dbc_im.F, v2dbc_im.F, v3dbc_im.F, zetabc.F
- ECOSIM
- Option to activate Bio-optical EcoSim (Bissett et al., 1999a, b) model.
- related = ANA_BIOLOGY, ANA_BPFLUX, ANA_SPFLUX
- conflict = BIO_FENNEL, NEMURO, NPZD_FRANKS, NPZD_IRON, NPZD_POWELL
- routine = ecosim.h
- input = ecosim.in
- EMINUSP
- Option to compute E-P for surface fluxes formulation using atmospheric boundary layer.
- parameter =
- parent =
- required =
- related = BULK_FLUXES
- conflict =
- routine = ad_bulk_fluxes.F, bulk_fluxes.F, rp_bulk_fluxes.F, tl_bulk_fluxes.F
- ENSEMBLE
- Option to use ensemble prediction driver.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- ESMF_COUPLING
- Internal switch to use Earth System Modeling Framework (ESMF) for coupling.
- parameter =
- parent =
- required =
- related = ESMF_LIB, MCT_LIB, MODEL_COUPLING
- conflict =
- routine = mod_coupler.F
- ESMF_LIB
- Option to use Earth System Modeling Framework (ESMF) library for coupling.
- parameter =
- parent =
- required =
- related = ESMF_COUPLING, MCT_LIB, MODEL_COUPLING
- conflict = MCT_LIB
- routine = mod_coupler.F
- ESTUARY_TEST
- Option to compile and run the test estuary for sediment.
- parameter = MyAppCPP
- parent =
- required = SEDIMENT
- related = SEDIMENT
- conflict =
- routine =
- input = roms.in, sediment.in
- EW_PERIODIC
- Option to use East-West periodic boundary conditions.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
F
- FLOAT_OYSTER
- Option to activate oyster model behavior in Langrangian drifters.
- parameter =
- parent = FLOATS
- required = FLOATS
- related = FLOATS
- conflict =
- routine =
- FLOAT_STICKY
- Option to reflect or stick floats that hit the surface or bottom in Langrangian drifters.
- parameter =
- parent = FLOATS
- required = FLOATS
- related = FLOATS
- conflict =
- routine =
- FLOAT_VWALK
- Option to use vertical random walk for Langrangian drifters.
- parameter =
- parent = FLOATS
- required = FLOATS
- related = FLOATS
- conflict =
- routine =
- FLOATS
- Option to activate simulated Lagrangian drifters.
- parameter =
- parent =
- required =
- related = FLOAT_VWALK, VWALK_FORWARD
- conflict =
- routine =
- FLT_TEST
- Option to compile and run float tracking example.
- parameter = MyAppCPP
- parent =
- required = FLOATS
- related = FLOATS
- conflict =
- routine =
- input = floats.in, roms.in (_flt_test2d and _flt_test3d)
- FORCING_SV
- Option to use forcing singular vectors driver.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- FORWARD_MIXING
- Option to enable processing forward vertical mixing coefficient for the tangent linear, representer and adjoint models.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- FORWARD_READ
- Option to enable reading in forward solution, basic state for the tangent linear, representer and adjoint models.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- FORWARD_RHS
- Option to enable processing forward right-hand-side terms for the tangent linear, representer and adjoint models.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- FORWARD_WRITE
- Option to enable writing out forward solution, basic state for the tangent linear model.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- FSOBC_REDUCED
- Option to use SSH data and reduced physics conditions for the computation of the pressure gradient term in Flather or reduced physics boundary conditions (*_M2FLATHER, *_M2REDUCED).
- parameter =
- parent =
- required = SSH_TIDES
- related = SSH_TIDES, ADD_FSOBC
- conflict =
- routine = ad_u2dbc_im.F, ad_v2dbc.im.F, rp_u2dbc_im.F, rp_v2dbc_im.F, tl_u2dbc_im.F, tl_v2dbc_im.F, u2dbc_im.F, v2dbc_im.F
- FT_EIGENMODES
- Option to use the finite time eigenmodes driver: normal modes.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = ad_def_his.F, tl_def_his.F
- FULL_GRID
- Option for processing the full grid range (interior and boundary points) of the state vector in variational data assimilation and generalized stability theory (GST) analysis. Otherwise, only interior points are processed.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = packing.F
G
- GLS_MIXING
- Option to activate Generic Length Scale vertical mixing parameterization (Warner et al., 2005) for vertical turbulent mixing of momentum and tracers.
- related = CANUTO_A, CANUTO_B, CHARNOK, CRAIG_BANNER, KANTHA_CLAYSON, K_C2ADVECTION, K_C4ADVECTION, N2S2_HORAVG, ZOS_HSIG, TKE_WAVEDISS
- conflict = BVF_MIXING, MY25_MIXING, LMD_MIXING
- routine = gls_corstep.F, gls_prestep.F, roms.in
- GRAV_ADJ
- Option to compile and run the gravitational adjustment example.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in
H
- HDF5 (formerly NETCDF4)
- Option to create NetCDF-4/HDF5 format files for input/output. This option was named NETCDF4 prior to revision 459.
- parameter =
- parent =
- required =
- related = DEFLATE
- conflict =
- routine = mod_netcdf.F
- HOLLING_GRAZING
- Option to use Holling-type s-shaped curve grazing (implicit) for the Nemuro lower trophic level ecosystem model.
- parameter =
- parent = NEMURO
- required = NEMURO
- related = IVLEV_EXPLICIT
- conflict = IVLEV_EXPLICIT
- routine = nemuro.h
I
- I4DVAR (Formerly IS4DVAR)
- Option to enable the incremental 4D variational (I4DVar), stong contraint, primal formulation data assimilation driver.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = i4dvar_ocean.h
- I4DVAR_ANA_SENSITIVITY (Formerly IS4DVAR_SENSITIVITY)
- Option to activate the observation impact and sensitivity driver which quantifies the impact that each observation has on the 4DVAR data assimilation system. By measuring the sensitivity of the data assimilation system to each observation, we can determine the degree to which each observation contributes to the uncertainty in the circulation estimate. This analysis can help us to determine the type of measurements that need to be made, where to observe, and when.
- required = ADJOINT, NONLINEAR, TANGENT
- related = I4DVAR, LANCZOS
- routine = obs_sen_i4dvar_analysis.h
- ICESHELF
- Option to include ice shelf cavities in the model configuration.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- IMPACT_INNER
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- IMPLICIT_VCONV
- Option to use the implicit vertical convolution algorithm for the tangent linear and adjoint models.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = ad_conv_3d.F, ad_conv_bry3d.F, conv_3d.F, conv_bry3d.F, tl_conv_3d.F, tl_conv_bry3d.F
- IMPULSE
- Option to process adjoint impulse forcing for the adjoint model.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- INLET_TEST
- Option to compile and run the test inlet application.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in, sediment.in
- INLINE_2DIO
- Option to process 3D data by levels (2D slabs) to reduce memory needs in distributed-memory configurations. This option is convenient for large problems on nodes with limited memory.
- parameter =
- parent =
- required = SOLVE3D
- related =
- conflict =
- routine = nf_fread3d.F, nf_fwrite3d.F
- INNER_PRODUCT
- Option to enable tangent linear and adjoint inner product check.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = pert_ocean.h
- IRON_LIMIT
- Option to impose iron limitation on phytoplankton growth in the NPZD iron (Fiechter et al. 2009) model.
- parameter =
- parent = NPZD_IRON
- required = NPZD_IRON
- related = IRON_RELAX, NPZD_IRON
- conflict =
- routine = biology.F, npzd_iron.h
- IRON_RELAX
- Option to allow nudging of iron over the shelf, in the NPZD iron (Fiechter et al. 2009) model.
- parameter =
- parent = NPZD_IRON
- required = NPZD_IRON
- related = IRON_LIMIT, NPZD_IRON
- conflict =
- routine = biology.F, npzd_iron.h
- IS4DVAR OBSOLETE - Renamed to I4DVAR in SVN revision 1022
- Option to enable the incremental 4d variational (IS4DVar) data assimilation driver.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = is4dvar_ocean.h
- IS4DVAR_SENSITIVITY OBSOLETE - Renamed to I4DVAR_ANA_SENSITIVITY in SVN revision 1022
- Option to activate the observation sensitivity driver which quantifies the impact that each observation has on the 4DVAR data assimilation system. By measuring the sensitivity of the data assimilation system to each observation, we can determine the degree to which each observation contributes to the uncertainty in the circulation estimate. This analysis can help us to determine the type of measurements that need to be made, where to observe, and when.
- required = ADJOINT, NONLINEAR, TANGENT
- related = IS4DVAR, LANCZOS
- routine = obs_sen_is4dvar.h
- IVLEV_EXPLICIT
- Option to use Ivlev explicit grazing algorithm for the Nemuro lower trophic level ecosystem model.
- parameter =
- parent = NEMURO
- required = NEMURO
- related = HOLLING_GRAZING
- conflict = HOLLING_GRAZING
- routine = nemuro.h
J
K
- KANTHA_CLAYSON
- Option to use the Kantha and Clayson (1994) stability function for the Generic Length Scale or Mellor/Yamada level 2.5 closure.
- parameter =
- parent = GLS_MIXING or MY25_MIXING
- required = GLS_MIXING or MY25_MIXING
- related = CANUTO_A, CANUTO_B
- conflict = CANUTO_A, CANUTO_B
- routine = gls_corstep.F, my25_corstep.F
- KELVIN
- Option to compile and run the Kelvin wave test.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in
- K_C2ADVECTION
- Option to use 2nd-order centered advection for the Generic Length Scale or Mellor/Yamada level 2.5 closure.
- parameter =
- parent = GLS_MIXING or MY25_MIXING
- required = GLS_MIXING or MY25_MIXING
- related = [K_C4ADVECTION]]
- conflict = [K_C4ADVECTION]]
- routine = gls_corstep.F, gls_prestep.F, my25_corstep.F, my25_prestep.F
- K_C4ADVECTION
- Option to use 4th-order centered advection for the Generic Length Scale or Mellor/Yamada level 2.5 closure.
- parameter =
- parent = GLS_MIXING or MY25_MIXING
- required = GLS_MIXING or MY25_MIXING
- related = K_C2ADVECTION
- conflict = K_C2ADVECTION
- routine = gls_corstep.F, gls_prestep.F, my25_corstep.F, my25_prestep.F
L
- LAB_CANYON
- Option to compile and run the lab canyon polar coordinates example.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in
- LAKE_JERSEY
- Option to compile and run the lake Jersey sediment test case. Configurations found on the Nesting Examples page.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine = roms.in, sediment.in
- LAKE_SIGNELL
- Option to compile and run the lake Signell sediment test case.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine = floats.in, roms.in, sediment.in
- LMD_BKPP
- Option to use bottom boundary layer KPP mixing for the Large et al. (1994) K-profile parameterization mixing.
- parameter =
- parent = LMD_MIXING
- required = LMD_MIXING
- related = LMD_CONVEC, LMD_DDMIX, LMD_NONLOCAL, LMD_RIMIX, LMD_SHAPIRO, LMD_SKPP
- conflict =
- routine = lmd_bkpp.F, lmd_vmix.F
- LMD_CONVEC
- Option to add convective mixing due to shear instability for the Large et al. (1994) K-profile parameterization mixing.
- parameter =
- parent = LMD_MIXING
- required = LMD_MIXING
- related = LMD_BKPP, LMD_DDMIX, LMD_NONLOCAL, LMD_RIMIX, LMD_SHAPIRO, LMD_SKPP
- conflict =
- routine = lmd_vmix.F
- LMD_DDMIX
- Option to add double-diffusive mixing for the Large et al. (1994) K-profile parameterization mixing.
- parameter =
- parent = LMD_MIXING
- required = LMD_MIXING
- related = LMD_BKPP, LMD_CONVEC, LMD_NONLOCAL, LMD_RIMIX, LMD_SHAPIRO, LMD_SKPP
- conflict =
- routine = lmd_vmix.F
- LMD_MIXING
- Option to activate Large et al. (1994) interior closure for vertical turbulent mixing of momentum and tracers.
- parameter =
- parent =
- required =
- related = LMD_BKPP, LMD_CONVEC, LMD_DDMIX, LMD_NONLOCAL, LMD_RIMIX, LMD_SHAPIRO, LMD_SKPP
- conflict = BVF_MIXING, GLS_MIXING, MY25_MIXING
- routine = ad_main3d.F, lmd_vmix.F, main3d.F, rp_main3d.F, tl_main3d.F
- LMD_NONLOCAL
- Option to use nonlocal transport for the Large et al. (1994) K-profile parameterization mixing.
- parameter =
- parent = LMD_MIXING
- required = LMD_MIXING
- related = LMD_BKPP, LMD_CONVEC, LMD_DDMIX, LMD_RIMIX, LMD_SHAPIRO, LMD_SKPP
- conflict =
- routine = ad_pre_step3d.F, lmd_skpp.F, rp_pre_step3d.F, tl_pre_step3d.F
- LMD_RIMIX
- Option to add diffusivity due to shear instability for the Large et al. (1994) K-profile parameterization mixing.
- parameter =
- parent = LMD_MIXING
- required = LMD_MIXING
- related = LMD_BKPP, LMD_CONVEC, LMD_DDMIX, LMD_NONLOCAL, LMD_SHAPIRO, LMD_SKPP
- conflict =
- routine = lmd_vmix.F
- LMD_SHAPIRO
- Option to use Shapiro filtering boundary layer depth for the Large et al. (1994) K-profile parameterization mixing.
- parameter =
- parent = LMD_MIXING
- required = LMD_MIXING
- related = LMD_BKPP, LMD_CONVEC, LMD_DDMIX, LMD_NONLOCAL, LMD_RIMIX, LMD_SKPP
- conflict =
- routine = lmd_bkpp.F, lmd_skpp.F
- LMD_SKPP
- Option to use surface boundary layer KPP mixing for the Large et al. (1994) K-profile parameterization mixing.
- parameter =
- parent = LMD_MIXING
- required = LMD_MIXING
- related = LMD_BKPP, LMD_CONVEC, LMD_DDMIX, LMD_NONLOCAL, LMD_RIMIX, LMD_SHAPIRO
- conflict =
- routine = ad_lmd_swfrac.F, lmd_skpp.F, lmd_swfrac.F, rp_lmd_swfrac.F, tl_lmd_swfrac.F
- LMD_TEST
- Option to compile and run the test for LMD and KPP.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in, stations.in
- LONGWAVE
- Option to compute the net long-wave radiation internally using the Beriland (1952) equation as a function of air temperature, sea surface temperature, relative humidity, and cloud fraction.
- parameter =
- parent = BULK_FLUXES
- required = BULK_FLUXES
- related = LOGWAVE_OUT
- conflict = LONGWAVE_OUT
- routine = ad_bulk_flux.F, bulk_flux.F, rp_bulk_flux.F, tl_bulk_flux.F
- LONGWAVE_OUT
- Option to provide (read) long-wave downwelling radiation only and then add outgoing long-wave radiation as a function of the model sea surface temperature.
- parameter =
- parent = BULK_FLUXES
- required = BULK_FLUXES
- related = LONGWAVE
- conflict = LONGWAVE
- routine = ad_bulk_flux.F, bulk_flux.F, rp_bulk_flux.F, tl_bulk_flux.F
M
- M2CLIMATOLOGY
- DEPRICATED in favor of Lm2CLM logical switches to facilitate nesting.
 Option to read and process 2D momentum climatology fields.
- parameter =
- parent =
- required =
- related = ANA_M2CLIMA, M2CLM_NUDGING, UV_TIDES
- conflict =
- routine = ad_step2d_LF_AM3.h, set_tides.F, step2d_LF_AM3.h, rp_step2d_LF_AM3.h, tl_step2d_LF_AM3.h
- M2CLM_NUDGING
- DEPRICATED in favor of LnudgeM2CLM logical switches to facilitate nesting.
 Option to use nudging of 2D momentum climatology data (primarily in sponge areas).
- parameter =
- parent =
- required =
- related = M2CLIMATOLOGY, ANA_M2CLIMA, UV_TIDES
- conflict =
- routine = ad_step2d_LF_AM3.h, step2d_LF_AM3.h, rp_step2d_LF_AM3.h, tl_step2d_LF_AM3.h
- M3CLIMATOLOGY
- DEPRICATED in favor of Lm3CLM logical switches to facilitate nesting.
 Option to read and process 3D momentum climatology fields.
- parameter =
- parent =
- required =
- related = ANA_M3CLIMA, M3CLM_NUDGING
- conflict =
- routine =
- M3CLM_NUDGING
- DEPRICATED in favor of LnudgeM3CLM logical switches to facilitate nesting.
 Option to use nudging of 3D momentum climatology data (primarily in sponge areas).
- parameter =
- parent =
- required =
- related = M3CLIMATOLOGY, ANA_M3CLIMA
- conflict =
- routine =
- MASKING
- Option to use land/sea masking.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- MAX_SLOPE
- Internal switch to set a maximum density slope in isopycnic diffusion.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- MB_BBL
- Option to use Meinte Blaas bottom boundary layer closure.
- parameter =
- parent =
- required = BBL_MODEL
- related = MB_CALC_UB, MB_CALC_ZNOT, MB_Z0BIO, MB_Z0BL, MB_Z0RIP
- conflict = SG_BBL, SSW_BBL
- routine =
- MB_CALC_UB
- Option to use if computing bottom orbital velocity internally for Meinte Blass bottom boundary layer closure
- parameter =
- parent = MB_BBL
- required = BBL_MODEL, MB_BBL
- related = MB_CALC_ZNOT, MB_Z0BIO, MB_Z0BL, MB_Z0RIP
- conflict =
- routine = mb_bbl.h
- MB_CALC_ZNOT
- Option to use if computing bottom roughness internally for Meinte Blass bottom boundary layer closure.
- parameter =
- parent = MB_BBL
- required = BBL_MODEL, MB_BBL
- related = MB_CALC_UB, MB_Z0BIO, MB_Z0BL, MB_Z0RIP
- conflict =
- routine = mb_bbl.h
- MB_ZOBIO
- Option to use biogenic bedform roughness for ripples for Meinte Blass bottom boundary layer closure.
- parameter =
- parent = MB_BBL
- required = BBL_MODEL, MB_BBL
- related = MB_CALC_UB, MB_CALC_ZNOT, MB_Z0BL, MB_Z0RIP
- conflict =
- routine = mb_bbl.h
- MB_Z0BL
- Option to use bedload roughness for ripples for Meinte Blass bottom boundary layer closure.
- parameter =
- parent = MB_BBL
- required = BBL_MODEL, MB_BBL, MB_ZORIP
- related = MB_CALC_UB, MB_CALC_ZNOT, MB_Z0BIO, MB_Z0RIP
- conflict =
- routine = mb_bbl.h
- MB_Z0RIP
- Option to use bedform roughness for ripples for Meinte Blass bottom boundary layer closure.
- parameter =
- parent = MB_BBL
- required = BBL_MODEL, MB_BBL, MB_ZOBL
- related = MB_CALC_UB, MB_CALC_ZNOT, MB_Z0BIO, MB_Z0BL
- conflict =
- routine = mb_bbl.h
- MCT_LIB
- Option to use the Model Coupling Toolkit (MCT) library for coupling.
- parameter =
- parent =
- required =
- related = ESMF_COUPLING, ESMF_LIB, MODEL_COUPLING
- conflict = ESMF_COUPLING, ESMF_LIB
- routine = mod_coupler.F
- MIN_STRAT
- Internal switch to set a minimum density stratification in isopycnic diffusion.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- MIX_GEO_TS
- Option to use if mixing on geopotential (constant Z) surfaces for horizontal mixing of tracers.
- parameter =
- parent =
- required =
- related = MIX_GEO_UV, MIX_ISO_TS, MIX_S_TS, MIX_S_UV
- conflict = MIX_ISO_TS, MIX_S_TS
- routine = ad_t3dmix.F, hmixing.F, rp_t3dmix.F, t3dmix.F, tl_t3dmix.F
- MIX_GEO_UV
- Option to use if mixing on geopotential (constant Z) surfaces for horizontal mixing of momentum.
- parameter =
- parent =
- required =
- related = MIX_GEO_TS, MIX_ISO_TS, MIX_S_TS, MIX_S_UV
- conflict = MIX_S_UV
- routine = ad_uv3dmix.F, hmixing.F, rp_uv3dmix.F, tl_uv3dmix.F, uv3dmix.F
- MIX_ISO_TS
- Option to use if mixing on epineutral (constant RHO) surfaces for horizontal mixing of tracers.
- parameter =
- parent =
- required =
- related = MIX_GEO_TS, MIX_GEO_UV, MIX_S_TS, MIX_S_UV
- conflict = MIX_GEO_TS, MIX_S_TS
- routine = ad_t3dmix.F, rp_t3dmix.F, t3dmix.F, tl_t3dmix.F
- MIX_S_TS
- Option to use if mixing along constant S-surfaces for horizontal mixing of tracers.
- parameter =
- parent =
- required =
- related = MIX_GEO_TS, MIX_GEO_UV, MIX_ISO_TS, MIX_S_UV
- conflict = MIX_GEO_TS, MIX_ISO_TS
- routine = ad_t3dmix.F, rp_t3dmix.F, t3dmix.F, tl_t3dmix.F
- MIX_S_UV
- Option to use if mixing along constant S-surfaces for horizontal mixing of momentum.
- parameter =
- parent =
- required =
- related = MIX_GEO_TS, MIX_GEO_UV, MIX_ISO_TS, MIX_S_TS
- conflict = MIX_GEO_UV
- routine = ad_uv3dmix.F, rp_uv3dmix.F, tl_uv3dmix.F, uv3dmix.F
- MPI
- Internal switch to configure the model to run in distributed memory (MPI).
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- MULTIPLE_TLM
- Option to use multiple TLM (Tangent Linear Model) history files in 4DVAR.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- MY25_MIXING
- Option to activate Mellor/Yamada Level-2.5 closure for vertical turbulent mixing of momentum and tracers.
- parameter =
- parent =
- required =
- related = K_C2ADVECTION, K_C4ADVECTION, KANTHA_CLAYSON, N2S2_HORAVG
- conflict = BVF_MIXING, GLS_MIXING, LMD_MIXING
- routine = my25_corstep.F, my25_prestep.F
N
- N2S2_HORAVG
- Option to use horizontal smoothing of buoyancy/shear for the Generic Length Scale of Mellor/Yamada level 2.5 closure
- parameter =
- parent = GLS_MIXING or MY25_MIXING
- required = GLS_MIXING or MY25_MIXING
- related =
- conflict =
- routine = gls_corstep.F, my25_corstep.F
- NEARSHORE_MELLOR
- Option to activate radiation stress terms for near-shore and shallow water models.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- NEMURO
- Option to activate NEMURO model.
- related = ANA_BIOLOGY, ANA_BPFLUX, ANA_SPFLUX
- conflict = BIO_FENNEL, ECOSIM, NPZD_FRANKS, NPZD_IRON, NPZD_POWELL
- routine = nemuro.h
- input = nemuro.in
- NESTING
- Option to enable ROMS grid nesting capabilities.
- parameter =
- parent =
- required =
- related = ONE_WAY
- conflict =
- routine = nesting.F
- NETCDF4 (RENAMED)
- Option to create NetCDF-4/HDF5 format files for input/output. This option was renamed to HDF5 in revision 459.
- parameter =
- parent =
- required =
- related = DEFLATE
- conflict =
- routine = mod_netcdf.F
- NJ_BIGHT
- Option to compile and run NJ_BIGHT realistic application.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine =
- input = roms.in
- NL_BULK_FLUXES
- Option to handle the reading of surface fluxes (E-P) computed by the nonlinear model in the representer model. This option can be also used in the nonlinear model when BULK_FLUXES is not defined to read such surface salinity flux if needed.
- parameter =
- parent =
- required = BULK_FLUXES
- related = COOL_SKIN, EMINUS, LONGWAVE, LONGWAVE_OUT
- conflict =
- routine =
- NLM_OUTER
- Option to use nonlinear model as basic stat in outer loop with tangent linear, representer and adjoint models.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- NO_READ_GHOST
- Option to not include ghost points during read/scatter (I/O).
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = nf_fread2d.F, nf_fread3d.F, nf_fread4d.F
- NO_WRITE_GRID
- Option to not write grid arrays.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = wrt_info.F
- NONLINEAR
- Internal switch to include the nonlinear model in compilation.
- parameter =
- parent =
- required =
- related = ADJOINT, REPRESENTER, TANGENT
- conflict =
- routine =
- NONLIN_EOS
- Option to use the nonlinear equation of state for tracers.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = ad_rho_eos.F, rho_eos.F, rp_rho_eos.F, tl_rho_eos.F
- NORTH_FSCLAMPED
- Option to use free-surface clamped condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSCLAMPED, SOUTH_FSCLAMPED, WEST_FSCLAMPED
- conflict = NS_PERIODIC, NORTH_FSCHAPMAN, NORTH_FSGRADIENT, NORTH_FSNUDGING, NORTH_FSRADIATION, NORTHERN_WALL
- routine = zetabc.F
- NORTH_FSCHAPMAN
- Option to use free-surface Chapman condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSCHAPMAN, SOUTH_FSCHAPMAN, WEST_FSCHAPMAN
- conflict = NS_PERIODIC, NORTH_FSCLAMPED, NORTH_FSGRADIENT, NORTH_FSNUDGING, NORTH_FSRADIATION, NORTHERN_WALL
- routine = zetabc.F
- NORTH_FSGRADIENT
- Option to use free-surface gradient condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSGRADIENT, SOUTH_FSGRADIENT, WEST_FSGRADIENT
- conflict = NS_PERIODIC, NORTH_FSCLAMPED, NORTH_FSCHAPMAN, NORTH_FSNUDGING, NORTH_FSRADIATION, NORTHERN_WALL
- routine = zetabc.F
- NORTH_FSNUDGING
- Option to use free-surface passive/active nudging term for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSNUDGING, SOUTH_FSNUDGING, WEST_FSNUDGING
- conflict = NS_PERIODIC, NORTH_FSCLAMPED, NORTH_FSCHAPMAN, NORTH_FSGRADIENT, NORTHERN_WALL
- routine = zetabc.F
- NORTH_FSRADIATION
- Option to use free-surface radiation condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSRADIATION, SOUTH_FSRADIATION, WEST_FSRADIATION
- conflict = NS_PERIODIC, NORTH_FSCLAMPED, NORTH_FSCHAPMAN, NORTH_FSGRADIENT, NORTHERN_WALL
- routine = zetabc.F
- NORTH_KGRADIENT
- Option to use TKE fields gradient condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_KGRADIENT, SOUTH_KGRADIENT, WEST_KGRADIENT
- conflict = NS_PERIODIC, NORTH_KRADIATION, NORTHERN_WALL
- routine = tkebc_im.F
- NORTH_KRADIATION
- Option to use TKE fields radiation condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_KRADIATION, SOUTH_KRADIATION, WEST_KRADIATION
- conflict = NS_PERIODIC, NORTH_KGRADIENT, NORTHERN_WALL
- routine = tkebc_im.F
- NORTH_M2CLAMPED
- Option to use 2D momentum clamped condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2CLAMPED, SOUTH_M2CLAMPED, WEST_M2CLAMPED
- conflict = NS_PERIODIC, NORTH_M2FLATHER, NORTH_M2GRADIENT, NORTH_M2NUDGING, NORTH_M2RADIATION, NORTH_M2REDUCED, NORTHERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- NORTH_M2FLATHER
- Option to use 2D momentum Flather condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2FLATHER, SOUTH_M2FLATHER, WEST_M2FLATHER
- conflict = NS_PERIODIC, NORTH_M2CLAMPED, NORTH_M2GRADIENT, NORTH_M2NUDGING, NORTH_M2RADIATION, NORTH_M2REDUCED, NORTHERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- NORTH_M2GRADIENT
- Option to use 2D momentum gradient condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2GRADIENT, SOUTH_M2GRADIENT, WEST_M2GRADIENT
- conflict = NS_PERIODIC, NORTH_M2CLAMPED, NORTH_M2FLATHER, NORTH_M2NUDGING, NORTH_M2RADIATION, NORTH_M2REDUCED, NORTHERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- NORTH_M2NUDGING
- Option to use 2D momentum passive/active nudging term for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2NUDGING, SOUTH_M2NUDGING, WEST_M2NUDGING
- conflict = NS_PERIODIC, NORTH_M2CLAMPED, NORTH_M2FLATHER, NORTH_M2GRADIENT, NORTH_M2REDUCED, NORTHERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- NORTH_M2RADIATION
- Option to use 2D momentum radiation condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2RADIATION, SOUTH_M2RADIATION, WEST_M2RADIATION
- conflict = NS_PERIODIC, NORTH_M2CLAMPED, NORTH_M2FLATHER, NORTH_M2GRADIENT, NORTH_M2REDUCED, NORTHERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- NORTH_M2REDUCED
- Option to use 2D momentum reduced-physics for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2REDUCED, SOUTH_M2REDUCED, WEST_M2REDUCED
- conflict = NS_PERIODIC, NORTH_M2CLAMPED, NORTH_M2FLATHER, NORTH_M2GRADIENT, NORTH_M2NUDGING, NORTH_M2RADIATION, NORTHERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- NORTH_M3CLAMPED
- Option to use 3D momentum clamped condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M3CLAMPED, SOUTH_M3CLAMPED, WEST_M3CLAMPED
- conflict = NS_PERIODIC, NORTH_M3GRADIENT, NORTH_M3NUDGING, NORTH_M3RADIATION, NORTHERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- NORTH_M3GRADIENT
- Option to use 3D momentum gradient condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M3GRADIENT, SOUTH_M3GRADIENT, WEST_M3GRADIENT
- conflict = NS_PERIODIC, NORTH_M3CLAMPED, NORTH_M3NUDGING, NORTH_M3RADIATION, NORTHERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- NORTH_M3NUDGING
- Option to use 3D momentum passive/active nudging term for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M3NUDGING, SOUTH_M3NUDGING, WEST_M3NUDGING
- conflict = NS_PERIODIC, NORTH_M3CLAMPED, NORTH_M3GRADIENT, NORTHERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- NORTH_M3RADIATION
- Option to use 3D momentum radiation condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M3RADIATION, SOUTH_M3RADIATION, WEST_M3RADIATION
- conflict = NS_PERIODIC, NORTH_M3CLAMPED, NORTH_M3GRADIENT, NORTHERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- NORTH_TCLAMPED
- Option to use tracer clamped condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_TCLAMPED, SOUTH_TCLAMPED, WEST_TCLAMPED
- conflict = NS_PERIODIC, NORTH_TGRADIENT, NORTH_TNUDGING, NORTH_TRADIATION, NORTHERN_WALL
- routine = t3dbc_im.F
- NORTH_TGRADIENT
- Option to use tracer gradient condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_TGRADIENT, SOUTH_TGRADIENT, WEST_TGRADIENT
- conflict = NS_PERIODIC, NORTH_TCLAMPED, NORTH_TNUDGING, NORTH_TRADIATION, NORTHERN_WALL
- routine = t3dbc_im.F
- NORTH_TNUDGING
- Option to use tracer passive/active nudging term for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_TNUDGING, SOUTH_TNUDGING, WEST_TNUDGING
- conflict = NS_PERIODIC, NORTH_TCLAMPED, NORTH_TGRADIENT, NORTHERN_WALL
- routine = t3dbc_im.F
- NORTH_TRADIATION
- Option to use tracer radiation condition for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_TRADIATION, SOUTH_TRADIATION, WEST_TRADIATION
- conflict = NS_PERIODIC, NORTH_TCLAMPED, NORTH_TGRADIENT, NORTHERN_WALL
- routine = t3dbc_im.F
- NORTH_VOLCONS
- Option to use Southern edge mass conservation enforcement for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_VOLCONS, SOUTH_VOLCONS, WEST_VOLCONS
- conflict = NS_PERIODIC, NORTHERN_WALL
- routine = obc_volcons.F
- NORTHERN_WALL
- Option to use Southern edge closed wall for the northern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_WALL, SOUTH_WALL, WEST_WALL
- conflict = NS_PERIODIC, NORTH_FSCLAMPED, NORTH_FSCHAPMAN, NORTH_FSGRADIENT, NORTH_FSNUDGING, NORTH_FSRADIATION, NORTH_KGRADIENT, NORTH_KRADIATION, NORTH_M2CLAMPED, NORTH_M2FLATHER, NORTH_M2GRADIENT, NORTH_M2NUDGING, NORTH_M2RADIATION, NORTH_M2REDUCED, NORTH_M3CLAMPED, NORTH_M3GRADIENT, NORTH_M3NUDGING, NORTH_M3RADIATION, NORTH_TCLAMPED, NORTH_TGRADIENT, NORTH_TNUDGING, NORTH_TRADIATION, NORTH_VOLCONS
- routine = t3dbc_im.F, tkebc_im.F, u2dbc_im.F, u3dbc_im.F, v2dbc_im.F, v3dbc_im.F, zetabc.F
- NPZD_FRANKS
- Option to activate Franks et al. (1986) NPZD biological model.
- related = ANA_BIOLOGY, ANA_BPFLUX, ANA_SPFLUX
- conflict = BIO_FENNEL, ECOSIM, NEMURO, NPZD_IRON, NPZD_POWELL
- routine = npzd_Franks.h
- input = npzd_Franks.in
- NPZD_IRON
- Option to activate Fiechter et al. (2009) iron NPZD biological model.
- related = ANA_BIOLOGY, ANA_BPFLUX, ANA_SPFLUX
- conflict = BIO_FENNEL, ECOSIM, NEMURO, NPZD_FRANKS, NPZD_POWELL
- routine = npzd_iron.h
- input = npzd_iron.in
- NPZD_POWELL
- Option to activate Powell et al. (2006) NPZD biological model.
- related = ANA_BIOLOGY, ANA_BPFLUX, ANA_SPFLUX
- conflict = BIO_FENNEL, ECOSIM, NEMURO, NPZD_FRANKS, NPZD_IRON
- routine = npzd_Powell.h
- input = npzd_Powell.in
- NS_PERIODIC
- Option to use North_South periodic boundary conditions.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- NUDGING_SSH
- Option to nudge sea surface height observations (altimetry).
- parameter =
- parent =
- required =
- related = NUDGING_SSH, NUDGING_SST, NUDGING_T, NUDGING_UV, NUDGING_UVsur
- conflict = ASSIMILATION_SSH
- routine =
- NUDGING_SST
- Option to nudge sea surface temperature observations.
- parameter =
- parent =
- required =
- related = NUDGING_SSH, NUDGING_T, NUDGING_UV, NUDGING_UVsur
- conflict = ASSIMILATION_SST
- routine =
- NUDGING_T
- Option to nudge tracer-type observations (temperature and salinity).
- parameter =
- parent =
- required =
- related = NUDGING_SSH, NUDGING_SST, NUDGING_UV, NUDGING_UVsur
- conflict = ASSIMILATION_T
- routine =
- NUDGING_UV
- Option to nudge horizontal current observations.
- parameter =
- parent =
- required =
- related = NUDGING_SSH, NUDGING_SST, NUDGING_T, NUDGING_UVsur
- conflict = ASSIMILATION_UV
- routine =
- NUDGING_UVsur
- Option to nudge surface current observations.
- parameter =
- parent =
- required =
- related = NUDGING_SSH, NUDGING_SST, NUDGING_T, NUDGING_UV
- conflict = ASSIMILATION_UVsur
- routine =
O
- OBC
- Internal option indicating open boundary conditions.
- related = EAST_FSOBC, EAST_M2OBC, EAST_M3OBC, EAST_TOBC
- related = WEST_FSOBC, WEST_M2OBC, WEST_M3OBC, WEST_TOBC
- related = NORTH_FSOBC, NORTH_M2OBC, NORTH_M3OBC, NORTH_TOBC
- related = SOUTH_FSOBC, SOUTH_M2OBC, SOUTH_M3OBC, SOUTH_TOBC
- routine = globaldefs.h
- OBS_IMPACT
- Option to to compute the observation impact to RBL4DVAR_ANA_SENSITIVITY, R4DVAR_ANA_SENSITIVITY, and I4DVAR_ANA_SENSITIVITY algorithms.
- parameter =
- parent =
- required = RBL4DVAR_ANA_SENSITIVITY, R4DVAR_ANA_SENSITIVITY, or I4DVAR_ANA_SENSITIVITY
- related = OBS_IMPACT_SPLIT
- conflict =
- routine =
- OBS_IMPACT_SPLIT
- Option to compute the contributions due to initial conditions, surface forcing, and boundary conditions. This option needs to be used with OBS_IMPACT and RBL4DVAR_ANA_SENSITIVITY or R4DVAR_ANA_SENSITIVITY.
- parameter =
- parent =
- required = OBS_IMPACT and RBL4DVAR_ANA_SENSITIVITY or R4DVAR_ANA_SENSITIVITY
- related = OBS_IMPACT
- conflict =
- routine =
- OBS_SPACE
- Option to compute the forecast error metrics in observation space.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = ad_htobs.F, def_info.F, globaldefs.h, mod_fourdvar.F, mod_iounits.F, obs_sen_rbl4dvar_forecast.h, read_asspar.F, read_phypar.F
- OBSERVATIONS
- Internal switch to process observations in tangent linear, representer and adjoint models.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- OCMIP_OXYGEN_SC
- Option to use the Keeling et al. (1998) formulae for the Schmit number to model O2 gas exchange. If deactivated, the formulation of Wanninkhof (1992) is used instead.
- parent = BIO_FENNEL
- required = OXYGEN
- routine = fennel.h
- ONE_WAY
- Option to activate One-way grid nesting in refinement grids instead of the default two way nesting.
- parent = NESTING
- required = NESTING
- routine = nesting.F
- OPT_OBSERVATIONS
- Option to use the optimal observations driver.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- OPT_PERTURBATION
- Option to use the optimal perturbations driver, singular vectors.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- OUT_DOUBLE
- Option to write double precision output fields to output NetCDF files.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = mod_netcdf.F
- OVERFLOW
- Option to compile and run the gravitational/overflow example.
- parameter = MyAppCPP
- parent =
- required =
- related =
- conflict =
- routine = roms.in
- OXYGEN
- Option to include oxygen dynamics in the Fennel biological model. Currently, an additional tracer is added for dissolved oxygen concentration (iOxyg).
- parent = BIO_FENNEL
- routine = fennel.h
- _OPENMP
- Internal switch to activate OpenMP (shared memory) for parallel runs.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
P
- PERFECT_RESTART
- Option to include perfect restart variables in the restart output NetCDF file.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- PARALLEL_IO
- Option to use parallel I/O via HDF5 or pnetcdf libraries.
- parameter =
- parent =
- required = HDF5 or PNETCDF
- related = HDF5, PNETCDF
- conflict =
- routine = mod_netcdf.F
- PICARD_TEST
- Option to use representer tangent linear model test driver.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- PJ_GRADP
- Option to use finite volume pressure Jacobian (Lin, 1997) for pressure gradient algorithm.
- parameter =
- parent =
- required = SOLVE3D
- related = ATM_PRESS, DJ_GRADPS, PJ_GRADPQ2, PJ_GRADPQ4, WJ_GRADP
- conflict = DJ_GRADPS, PJ_GRADPQ2, PJ_GRADPQ4, WJ_GRADP
- routine = ad_prsgrd.F, prsgrd.F, rp_prsgrd.F, tl_prsgrd.F
- PJ_GRADPQ2
- Option to use quadratic 2 pressure Jacobian (Shchepetkin, 2000) for pressure gradient algorithm.
- parameter =
- parent =
- required = SOLVE3D
- related = ATM_PRESS, DJ_GRADPS, PJ_GRADP, PJ_GRADPQ4, WJ_GRADP
- conflict = DJ_GRADPS, PJ_GRADP, PJ_GRADPQ4, WJ_GRADP
- routine = ad_prsgrd.F, prsgrd.F, rp_prsgrd.F, tl_prsgrd.F
- PJ_GRADPQ4
- Option to use quadratic 4 pressure Jacobian (Shchepetkin, 2000) for pressure gradient algorithm.
- parameter =
- parent =
- required = SOLVE3D
- related = ATM_PRESS, DJ_GRADPS, PJ_GRADP, PJ_GRADPQ2, WJ_GRADP
- conflict = DJ_GRADPS, PJ_GRADP, PJ_GRADPQ2, WJ_GRADP
- routine = ad_prsgrd.F, prsgrd.F, rp_prsgrd.F, tl_prsgrd.F
- PNETCDF
- Option to use parallel I/O with pnetcdf (classic format).
- parameter =
- parent =
- required = PARALLEL_IO
- related =
- conflict = HDF5
- routine = mod_netcdf.F
- POSTERIOR_EOFS
- Option to include the dominant EOFs of the posterior (analysis) error covariance matrix, Ea, for the estimated initial conditions. These EOFs contain information about the patterns of largest uncertainty in the 4DVAR estimate.
- parameter =
- parent =
- required =
- related = POSTERIOR_ERROR_F POSTERIOR_ERROR_I
- conflict =
- routine =
- POSTERIOR_ERROR_F
- Option to compute the final assimilation time-window posterior error covariance matrix for the RBL4DVAR and R4DVAR algorithms. This represents the diagonal elements of the full error analysis covariance matrix. These should be compared to the background error variances (squared standard deviations) for each variable which are specified in the STDnameI, STDnameI, STDnameB, STDnameF input NetCDF files. The analysis error covariance are written to a new NetCDF file (ERRname) which is specified in s4dvar.in. Currently, the analysis error is only possible for a single outer loop, Nouter=1.
 This option must never be run at the same time as POSTERIOR_ERROR_I. If the POSTERIOR_EOFS option is defined, the EOFS of the analysis error covariance matrix are also computed along with the trace estimate. They are saved in the HSSname output NetCDF file.
- parameter =
- parent =
- required =
- related = POSTERIOR_EOFS
- conflict = POSTERIOR_ERROR_I
- routine =
- POSTERIOR_ERROR_I
- Option to compute the initial assimilation time-window posterior error covariance matrix for the RBL4DVAR and R4DVAR algorithms. This represents the diagonal elements of the full error analysis covariance matrix. These should be compared to the background error variances (squared standard deviations) for each variable which are specified in the STDnameI, STDnameI, STDnameB, STDnameF input NetCDF files. The analysis error covariance are written to a new NetCDF file (ERRname) which is specified in s4dvar.in. Currently, the analysis error is only possible for a single outer loop, Nouter=1.
 This option must never be run at the same time as POSTERIOR_ERROR_F. If the POSTERIOR_EOFS option is defined, the EOFS of the analysis error covariance matrix are also computed along with the trace estimate. They are saved in the HSSname output NetCDF file.
- parameter =
- parent =
- required =
- related = POSTERIOR_EOFS
- conflict = POSTERIOR_ERROR_F
- routine =
- POWER_LAW
- Internal switch to use power law time-averaging filter for barotropic fields.
- parameter =
- parent =
- required = SOLVE3D
- related =
- conflict =
- routine =
- PROFILE
- Option to use time profiling.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- PSEUDOSPECTRA
- Option to use pseudospectra of tangent linear resolvant driver.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
Q
- QCORRECTION
- Option to use net heat flux correction for tracers.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = ad_set_vbc.F, rp_set_vbc.F, set_vbc.F, tl_set_vbc.F
- Q_PSOURCE (OBSOLETE as of revision 701)
- Option to activate/deactivate point sources/sinks of momentum. This option is used to specify the mass transport in the vertical, such as precipitation or groundwater discharge.
- variable = Dsrc(1:Nsrc), Qsrc(1:Nsrc,k)
- related = ANA_PSOURCE, TS_PSOURCE
- confict =
- routine = step2d.F, step3d_uv.F
R
- R_SYMMETRY
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- R4DVAR (Formerly W4DVAR)
- Option to activate indirect Representers 4D-Var; strong/weak constraint, dual formulation. This algorithm is no longer developed due to its instability in multiple outer loops in applications with high Rossby number. It is keep for instructional usage. We do not recommend to be used in realistic applications. Use instead the RBL4D-Var algorithm, which has a more efficient minimization RBLanczos solver.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = r4dvar_ocean.h
- R4DVAR_ANA_SENSITIVITY (Formerly W4DVAR_SENSITIVITY)
- Option to activate R4D-Var Analysis Observation Impact and Observations Sensitivity.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = obs_sen_r4dvar_analysis.h
- RADIATION_2D
- Option to use tangential phase speed in radiation open boundary conditions.
- parameter =
- parent =
- required =
- related = EAST_FSRADIATION, EAST_KRADIATION, EAST_M2RADIATION, EAST_M3RADIATION, EAST_TRADIATION, NORTH_FSRADIATION, NORTH_KRADIATION, NORTH_M2RADIATION, NORTH_M3RADIATION, NORTH_TRADIATIONSOUTH_FSRADIATION, SOUTH_KRADIATION, SOUTH_M2RADIATION, SOUTH_M3RADIATION, SOUTH_TRADIATIONWEST_FSRADIATION, WEST_KRADIATION, WEST_M2RADIATION, WEST_M3RADIATION, WEST_TRADIATION
- conflict =
- routine =
- RAMP_TIDES
- Option to ramp (over one day) tidal forcing at open boundaries.
- parameter =
- parent =
- required =
- related = SSH_TIDES, UV_TIDES
- conflict =
- routine =
- RBL4DVAR (Formerly W4DPSAS)
- Option to activate Restricted B-preconditioned Lanczos 4D-Var; strong/weak constraint, dual formulation. This driver has evolved throught the years and it is no longer a PSAS algorithm. See Gürol et al. (2014) for full description of the RBLanczos methodology.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = rbl4dvar_ocean.h
- RBL4DVAR_FCT_SENSITIVITY (Formerly W4DPSAS_FCT_SENSITIVITY)
- Option to activate RBL4D-Var Forecast Observation Impact and Observations Sensitivity.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = ad_htobs.F, ad_rpcg_lanczos.F, ceckdefs.F, def_info.F, def_ini.F, def_mod.F, get_state.F, globaldefs.h, mod_iounits.F, mod_fourdvar.F, obs_sen_rbl4dvar_forecast.h, read_asspar.F, read_phypar.F, rpcg_lanczos.F, tl_rpcg_lanczos.F, wrt_info.F
- RBL4DVAR_ANA_SENSITIVITY (Formerly W4DPSAS_SENSITIVITY)
- Option to activate RBL4D-Var analysis observation impact and observations sensitivity.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = obs_sen_rbl4dvar_analysis.h
- READ_WATER
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- REFDIF_COUPLING
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- RI_HORAVG
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- RI_VERAVG
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- RIVERPLUME1
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- RIVERPLUME2
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- RHO_SURF
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- RPM_DRIVER
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- RPM_RELAXATION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- RST_SINGLE
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
S
- SALINITY
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SANITY_CHECK
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SCORRECTION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SEAMOUNT
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SEDIMENT
- Option to activate cohesive and non-cohesive sediment model (Warner et al., 2006).
- related = ANA_BPFLUX, ANA_SEDIMENT, ANA_SPFLUX
- related = BEDLOAD, RIVER_SEDIMENT, SED_DENS, SED_MORPH, SUSPLOAD
- routine = sediment.F, sediment.in
- SED_DENS
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SED_MORPH
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SED_TEST1
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SED_TOY
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SG_BBL
- Option to use Styles and Glenn (2000) bottom boundary layer closure.
- parameter =
- parent =
- required = BBL_MODEL
- related = SG_CALC_UB, SG_CALC_ZNOT, SG_LOGINT
- conflict =
- routine = sg_bbl.h
- SG_CALC_UB
- Option to use if computing bottom orbital velocity internally for Styles and Glenn (2000) bottom boundary layer closure.
- parameter =
- parent = SG_BBL
- required = BBL_MODEL, SG_BBL
- related = SG_CALC_ZNOT, SG_LOGINT
- conflict =
- routine = sg_bbl.h
- SG_CALC_ZNOT
- Option to use if computing bottom roughness internally for Styles and Glenn (2000) bottom boundary layer closure.
- parameter =
- parent = SG_BBL
- required = BBL_MODEL, SG_BBL
- related = SG_CALC_UB, SG_LOGINT
- conflict =
- routine = sg_bbl.h
- SG_LOGINT
- Option to use logarithmic interpolation of (Ur,Vr) for Styles and Glenn (2000) bottom boundary layer closure.
- parameter =
- parent = SG_BBL
- required = BBL_MODEL, SG_BBL
- related = SG_CALC_UB, SG_CALC_ZNOT
- conflict =
- routine = sg_bbl.h
- SHOREFACE
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SO_SEMI
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SO_SEMI_WHITE
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SO_TRACE
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SOLAR_SOURCE
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SOLITON
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SOLVE3D
- Option to activate/deactivate 3D model configuration. If activated, ROMS solves 3D (baroclinic) primitive equations. If deactivated, ROMS solves vertically-integrated, shallow water (barotropic) equations.
- routine = main2d.F, main3d.F
- SOUTH_FSCLAMPED
- Option to use free-surface clamped condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSCLAMPED, NORTH_FSCLAMPED, WEST_FSCLAMPED
- conflict = NS_PERIODIC, SOUTH_FSCHAPMAN, SOUTH_FSGRADIENT, SOUTH_FSNUDGING, SOUTH_FSRADIATION, SOUTHERN_WALL
- routine = zetabc.F
- SOUTH_FSCHAPMAN
- Option to use free-surface Chapman condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSCHAPMAN, NORTH_FSCHAPMAN, WEST_FSCHAPMAN
- conflict = NS_PERIODIC, SOUTH_FSCLAMPED, SOUTH_FSGRADIENT, SOUTH_FSNUDGING, SOUTH_FSRADIATION, SOUTHERN_WALL
- routine = zetabc.F
- SOUTH_FSGRADIENT
- Option to use free-surface gradient condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSGRADIENT, NORTH_FSGRADIENT, WEST_FSGRADIENT
- conflict = NS_PERIODIC, SOUTH_FSCLAMPED, SOUTH_FSCHAPMAN, SOUTH_FSNUDGING, SOUTH_FSRADIATION, SOUTHERN_WALL
- routine = zetabc.F
- SOUTH_FSNUDGING
- Option to use free-surface passive/active nudging term for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSNUDGING, NORTH_FSNUDGING, WEST_FSNUDGING
- conflict = NS_PERIODIC, SOUTH_FSCLAMPED, SOUTH_FSCHAPMAN, SOUTH_FSGRADIENT, SOUTHERN_WALL
- routine = zetabc.F
- SOUTH_FSRADIATION
- Option to use free-surface radiation condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSRADIATION, NORTH_FSRADIATION, WEST_FSRADIATION
- conflict = NS_PERIODIC, SOUTH_FSCLAMPED, SOUTH_FSCHAPMAN, SOUTH_FSGRADIENT, SOUTHERN_WALL
- routine = zetabc.F
- SOUTH_KGRADIENT
- Option to use TKE fields gradient condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_KGRADIENT, NORTH_KGRADIENT, WEST_KGRADIENT
- conflict = NS_PERIODIC, SOUTH_KRADIATION, SOUTHERN_WALL
- routine = tkebc_im.F
- SOUTH_KRADIATION
- Option to use TKE fields radiation condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_KRADIATION, NORTH_KRADIATION, WEST_KRADIATION
- conflict = NS_PERIODIC, SOUTH_KGRADIENT, SOUTHERN_WALL
- routine = tkebc_im.F
- SOUTH_M2CLAMPED
- Option to use 2D momentum clamped condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2CLAMPED, NORTH_M2CLAMPED, WEST_M2CLAMPED
- conflict = NS_PERIODIC, SOUTH_M2FLATHER, SOUTH_M2GRADIENT, SOUTH_M2NUDGING, SOUTH_M2RADIATION, SOUTH_M2REDUCED, SOUTHERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- SOUTH_M2FLATHER
- Option to use 2D momentum Flather condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2FLATHER, NORTH_M2FLATHER, WEST_M2FLATHER
- conflict = NS_PERIODIC, SOUTH_M2CLAMPED, SOUTH_M2GRADIENT, SOUTH_M2NUDGING, SOUTH_M2RADIATION, SOUTH_M2REDUCED, SOUTHERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- SOUTH_M2GRADIENT
- Option to use 2D momentum gradient condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2GRADIENT, NORTH_M2GRADIENT, WEST_M2GRADIENT
- conflict = NS_PERIODIC, SOUTH_M2CLAMPED, SOUTH_M2FLATHER, SOUTH_M2NUDGING, SOUTH_M2RADIATION, SOUTH_M2REDUCED, SOUTHERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- SOUTH_M2NUDGING
- Option to use 2D momentum passive/active nudging term for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2NUDGING, NORTH_M2NUDGING, WEST_M2NUDGING
- conflict = NS_PERIODIC, SOUTH_M2CLAMPED, SOUTH_M2FLATHER, SOUTH_M2GRADIENT, SOUTH_M2REDUCED, SOUTHERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- SOUTH_M2RADIATION
- Option to use 2D momentum radiation condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2RADIATION, NORTH_M2RADIATION, WEST_M2RADIATION
- conflict = NS_PERIODIC, SOUTH_M2CLAMPED, SOUTH_M2FLATHER, SOUTH_M2GRADIENT, SOUTH_M2REDUCED, SOUTHERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- SOUTH_M2REDUCED
- Option to use 2D momentum reduced-physics for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2REDUCED, NORTH_M2REDUCED, WEST_M2REDUCED
- conflict = NS_PERIODIC, SOUTH_M2CLAMPED, SOUTH_M2FLATHER, SOUTH_M2GRADIENT, SOUTH_M2NUDGING, SOUTH_M2RADIATION, SOUTHERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- SOUTH_M3CLAMPED
- Option to use 3D momentum clamped condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M3CLAMPED, NORTH_M3CLAMPED, WEST_M3CLAMPED
- conflict = NS_PERIODIC, SOUTH_M3GRADIENT, SOUTH_M3NUDGING, SOUTH_M3RADIATION, SOUTHERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- SOUTH_M3GRADIENT
- Option to use 3D momentum gradient condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M3GRADIENT, NORTH_M3GRADIENT, WEST_M3GRADIENT
- conflict = NS_PERIODIC, SOUTH_M3CLAMPED, SOUTH_M3NUDGING, SOUTH_M3RADIATION, SOUTHERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- SOUTH_M3NUDGING
- Option to use 3D momentum passive/active nudging term for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M3NUDGING, NORTH_M3NUDGING, WEST_M3NUDGING
- conflict = NS_PERIODIC, SOUTH_M3CLAMPED, SOUTH_M3GRADIENT, SOUTHERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- SOUTH_M3RADIATION
- Option to use 3D momentum radiation condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M3RADIATION, NORTH_M3RADIATION, WEST_M3RADIATION
- conflict = NS_PERIODIC, SOUTH_M3CLAMPED, SOUTH_M3GRADIENT, SOUTHERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- SOUTH_TCLAMPED
- Option to use tracer clamped condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_TCLAMPED, NORTH_TCLAMPED, WEST_TCLAMPED
- conflict = NS_PERIODIC, SOUTH_TGRADIENT, SOUTH_TNUDGING, SOUTH_TRADIATION, SOUTHERN_WALL
- routine = t3dbc_im.F
- SOUTH_TGRADIENT
- Option to use tracer gradient condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_TGRADIENT, NORTH_TGRADIENT, WEST_TGRADIENT
- conflict = NS_PERIODIC, SOUTH_TCLAMPED, SOUTH_TNUDGING, SOUTH_TRADIATION, SOUTHERN_WALL
- routine = t3dbc_im.F
- SOUTH_TNUDGING
- Option to use tracer passive/active nudging term for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_TNUDGING, NORTH_TNUDGING, WEST_TNUDGING
- conflict = NS_PERIODIC, SOUTH_TCLAMPED, SOUTH_TGRADIENT, SOUTHERN_WALL
- routine = t3dbc_im.F
- SOUTH_TRADIATION
- Option to use tracer radiation condition for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_TRADIATION, NORTH_TRADIATION, WEST_TRADIATION
- conflict = NS_PERIODIC, SOUTH_TCLAMPED, SOUTH_TGRADIENT, SOUTHERN_WALL
- routine = t3dbc_im.F
- SOUTH_VOLCONS
- Option to use Southern edge mass conservation enforcement for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_VOLCONS, NORTH_VOLCONS, WEST_VOLCONS
- conflict = NS_PERIODIC, SOUTHERN_WALL
- routine = obc_volcons.F
- SOUTHERN_WALL
- Option to use Southern edge closed wall for the southern open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_WALL, NORTH_WALL, WEST_WALL
- conflict = NS_PERIODIC, SOUTH_FSCLAMPED, SOUTH_FSCHAPMAN, SOUTH_FSGRADIENT, SOUTH_FSNUDGING, SOUTH_FSRADIATION, SOUTH_KGRADIENT, SOUTH_KRADIATION, SOUTH_M2CLAMPED, SOUTH_M2FLATHER, SOUTH_M2GRADIENT, SOUTH_M2NUDGING, SOUTH_M2RADIATION, SOUTH_M2REDUCED, SOUTH_M3CLAMPED, SOUTH_M3GRADIENT, SOUTH_M3NUDGING, SOUTH_M3RADIATION, SOUTH_TCLAMPED, SOUTH_TGRADIENT, SOUTH_TNUDGING, SOUTH_TRADIATION, SOUTH_VOLCONS
- routine = t3dbc_im.F, tkebc_im.F, u2dbc_im.F, u3dbc_im.F, v2dbc_im.F, v3dbc_im.F, zetabc.F
- SPLINES
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SPLINES_VCONV
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SPHERICAL
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SPONGE
- DEPRICATED in favor of LuvSponge and LtracerSponge logical switches to facilitate nesting.
 Option to impose a sponge layer near the lateral boundary. Used in areas of enhanced viscosity/diffusion.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SRELAXATION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SSH_TIDES
- Option to impose tidal elevation for tidal forcing at the open boundaries.
- parameter =
- parent =
- required =
- related = ADD_FSOBC, FSOBC_REDUCED, RAMP_TIDES
- conflict =
- routine =
- SSW_BBL
- Option to use the Sherwood/Signell/Warner bottom boundary layer closure.
- parameter =
- parent =
- required = BBL_MODEL
- related = SSW_CALC_UB, SSW_CALC_ZNOT, SSW_FORM_DRAG_COR, SSW_LOGINT, SSW_ZOBIO, SSW_ZOBL, SSW_ZORIP
- conflict = SG_BBL, MB_BBL
- routine = bbl.F, ssw_bbl.h
- SSW_CALC_UB
- Option to compute bottom orbital velocity internally for the Sherwood/Signell/Warner bottom boundary layer closure.
- parameter =
- parent = SSW_BBL
- required = BBL_MODEL, SSW_BBL
- related = SSW_CALC_ZNOT, SSW_FORM_DRAG_COR, SSW_LOGINT, SSW_ZOBIO, SSW_ZOBL, SSW_ZORIP
- conflict =
- routine = ssw_bbl.h
- SSW_CALC_ZNOT
- Option to compute bottom roughness internally for the Sherwood/Signell/Warner bottom boundary layer closure.
- parameter =
- parent = SSW_BBL
- required = BBL_MODEL, SSW_BBL
- related = SSW_CALC_UB, SSW_FORM_DRAG_COR, SSW_LOGINT, SSW_ZOBIO, SSW_ZOBL, SSW_ZORIP
- conflict =
- routine = ssw_bbl.h
- SSW_FORM_DRAG_COR
- Option to activate form drag coefficient for the Sherwood/Signell/Warner bottom boundary layer closure.
- parameter =
- parent = SSW_BBL
- required = BBL_MODEL, SSW_BBL
- related = SSW_CALC_UB, SSW_CALC_ZNOT, SSW_LOGINT, SSW_ZOBIO, SSW_ZOBL, SSW_ZORIP
- conflict =
- routine = ssw_bbl.h
- SSW_LOGINT
- Option to use logarithmic interpolation of (Ur,Vr) for the Sherwood/Signell/Warner bottom boundary layer closure.
- parameter =
- parent = SSW_BBL
- required = BBL_MODEL, SSW_BBL
- related = SSW_CALC_UB, SSW_CALC_ZNOT, SSW_FORM_DRAG_COR, SSW_ZOBIO, SSW_ZOBL, SSW_ZORIP
- conflict =
- routine = ssw_bbl.h
- SSW_ZOBIO
- Option to use biogenic bedform roughness from ripples for the Sherwood/Signell/Warner bottom boundary layer closure.
- parameter =
- parent = SSW_BBL
- required = BBL_MODEL, SSW_BBL
- related = SSW_CALC_UB, SSW_CALC_ZNOT, SSW_FORM_DRAG_COR, SSW_LOGINT, SSW_ZOBL, SSW_ZORIP
- conflict =
- routine = ssw_bbl.h
- SSW_ZOBL
- Option to use bedload roughness for ripples for the Sherwood/Signell/Warner bottom boundary layer closure.
- parameter =
- parent = SSW_BBL
- required = BBL_MODEL, SSW_BBL
- related = SSW_CALC_UB, SSW_CALC_ZNOT, SSW_FORM_DRAG_COR, SSW_LOGINT, SSW_ZOBIO, SSW_ZORIP
- conflict =
- routine = ssw_bbl.h
- SSW_ZORIP
- Option to use bedform roughness from ripples for the Sherwood/Signell/Warner bottom boundary layer closure.
- parameter =
- parent = SSW_BBL
- required = BBL_MODEL, SSW_BBL
- related = SSW_CALC_UB, SSW_CALC_ZNOT, SSW_FORM_DRAG_COR, SSW_LOGINT, SSW_ZOBIO, SSW_ZOBL
- conflict =
- routine = ssw_bbl.h
- STATIONS
- Option to activate writing out station data
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = stations.in
- STATIONS_CGRID
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- STOCHASTIC_OPT
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SUBOBJECT_DEALLOCATION
- Option to de-allocate each pointer variable within a structure object individually. This option is mostly to maintain backwards compatibility with older versions of Fortran compilers that don't contain the Fortran 2003 standards. If your compiler is Fortran 2003 capable, we do not recommend activating this option. See Trac ticket #897 for more details.
- routines = mod_average.F, mod_bbl.F, mod_boundary.F, mod_clima.F, mod_coupling.F, mod_diags.F, mod_floats.F, mod_forces.F, mod_grid.F, mod_mixing.F, mod_nesting.F, mod_ocean.F, mod_param.F, mod_scalars.F, mod_sedbed_mod.h, mod_sources.F, mod_storage.F, and mod_tides.F
- SUSPLOAD
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- SWAN_COUPLING
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
T
- T_PASSIVE
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TALK_NONCONSERV
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TALK_PROGNOSTIC
- Option to activate prognostic computation of alkalinity.
- parent = BIO_FENNEL
- required = CARBON
- routine = fennel.h
- TANGENT
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TCLIMATOLOGY
- DEPRICATED in favor of LtracerCLM logical switches to facilitate nesting.
 Option to read and process tracers in climatology fields.
- parameter =
- parent =
- required =
- related = ANA_TCLIMA, TCLM_NUDGING
- conflict =
- routine =
- TCLM_NUDGING
- Option to use nudging for tracer climatology data (primarily in sponge areas).
- parameter =
- parent =
- required =
- related = ANA_TCLIMA, TCLIMATOLOGY
- conflict =
- routine =
- TEST_CHAN
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TEST_HEAD
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- THREE_GHOST
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TKE_DIF2
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TKE_DIF4
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TKE_WAVEDISS
- Option to use wave breaking surface flux from wave amplitude for the Generic Length-Scale closure (Warner et al., 2005).
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TL_R4DVAR (Formerly TL_W4DVAR)
- Option to activate tangent linearization of the R4D-Var data assimilation system.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = tl_r4dvar_ocean.h
- TL_RBL4DVAR (Formerly TL_W4DPSAS)
- Option to activate tangent linearization of the RBL4D-Var data assimilation system.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = tl_rbl4dvar_ocean.h
- TL_W4DPSAS OBSOLETE - Renamed to TL_RBL4DVAR in SVN revision 1022
- Option to activate tangent linearization of the W4DPSAS data assimilation system.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = tl_w4dpsas_ocean.h
- TL_W4DVAR OBSOLETE - Renamed to TL_R4DVAR in SVN revision 1022
- Option to activate tangent linearization of the W4DVAR data assimilation system.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = tl_w4dvar_ocean.h
- TLM_CHECK
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TLM_DRIVER
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_A4HADVECTION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_A4VADVECTION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_C2HADVECTION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_C2VADVECTION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_C4HADVECTION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_C4VADVECTION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_DIF2
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_DIF4
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_FIXED
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_MPDATA
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_PSOURCE (OBSOLETE as of revision 701)
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_SMAGORINSKY
- Option to
- parameter =
- parent =
- required =
- related = UV_SMAGORINSKY
- conflict =
- routine =
- TS_SVADVECTION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- TS_U3ADV_SPLIT
- Option to
- parameter =
- parent =
- required =
- related = UV_U3ADV_SPLIT
- conflict =
- routine =
- TS_U3HADVECTION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
U
- UPWELLING
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- UV_ADV
- Option to activate/deactivate horizontal and vertical advection of momentum. If no additional options are specified, the default is to discretize the horizontal momentum with a third-order upstream bias advection scheme with velocity dependent hyper-viscosity and the vertical momentum with a fourth-order, centered differences scheme. Since there is some implicit viscosity associated with the default discretization, the user may avoid adding an explicity vicosity to the solution to suppress excisive smoothing.
- routine = step2d.F, rhs3d.F
- UV_BAROCLINIC
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- UV_COR
- Option to activate/deactivate Coriolis acceleration term in momentum equations.
- routine = step2d.F, rhs3d.F
- UV_C2ADVECTION
- Option to use second-order, centered, finite differences in advection of momentum.
- parent = UV_ADV
- conflit = UV_C4ADVECTION
- UV_C4ADVECTION
- Option to use fourth-order, centered, finite differences in advection of momentum.
- parent = UV_ADV
- conflit = UV_C2ADVECTION
- UV_LDRAG
- Option to activate/deactivate linear bottom friction of momentum.
- parameter = rdrg(ng)
- confict = BBL_MODEL, UV_LOGDRAG, UV_QDRAG
- routine = set_vbc.F
- UV_LOGDRAG
- Option to activate/deactivate logarithmic bottom friction of momentum.
- parameter = Zob(ng)
- required = SOLVE3D
- confict = BBL_MODEL, UV_LDRAG, UV_QDRAG
- routine = set_vbc.F
- UV_PSOURCE (OBSOLETE as of revision 701)
- Option to activate/deactivate point sources/sinks of momentum. This option is used to specify the mass transport in river runoff.
- variable = Dsrc(1:Nsrc), Qsrc(1:Nsrc,k)
- related = ANA_PSOURCE, TS_PSOURCE
- confict = BBL_MODEL, UV_LOGDRAG, UV_QDRAG
- routine = step2d.F, step3d_uv.F
- UV_QDRAG
- Option to activate/deactivate quadratic bottom friction of momentum.
- parameter = rdrg2(ng)
- confict = BBL_MODEL, UV_LDRAG, UV_LOGDRAG
- routine = set_vbc.F
- UV_SADVECTION
- Option to use conservative, parabolic splines discretization of momentum vertical advection. This scheme requires high vertical resolution so it is recommended to use this option in shallow, coastal applications.
- parent = UV_ADV
- conflit = UV_C2ADVECTION, UV_C4ADVECTION
- UV_SMAGORINSKY
- Option to use Smagorinsky-like viscosity.
- related = TS_SMAGORINSKY
- routine = hmixing.F
- UV_TIDES
- Option to impose tidal currents for tidal forcing at open boundaries.
- parameter =
- parent =
- required =
- related = ADD_M2OBC, RAMP_TIDES
- conflict =
- routine =
- UV_U3ADV_SPLIT
- Option to use 3rd-order upstream split momentum advection. This can be used to correct for the spurious mixing of the advection operator in terrain-following coordinates. If this is the case, the advection operator is split in advective and viscosity components and several internal flags are activated in globaldefs.h. Notice that horizontal and vertical advection of momentum is 4th-order centered plus biharmonic viscosity to correct for spurious mixing. The total time-dependent horizontal mixing coefficient are computed in hmixing.F.
- related = TS_U3ADV_SPLIT
- routine = hmixing.F
- UV_U3HADVECTION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- UV_VIS2
- Option to activate/deactivate horizontal, harmonic viscosity of momentum. The hamonic mixing of momentum can be applied along terrain-following or geopotential levels. In ROMS, the viscosity is derived from the horizontal divergence of the deviatory stress tensor (Wajsowicz, 1993).
- parameter = visc2(ng)
- variable = visc2_p(:,:), visc2_r(:,:)
- required = MIX_S_UV, MIX_GEO_UV
- related = VISC_GRID
- routine = uv3dmix2_s.h, uv3dmix2_geo.h, uv3dmix.F
- UV_VIS4
- Option to activate/deactivate horizontal, biharmonic viscosity of momentum. The bihamonic mixing of momentum can be applied along terrain-following or geopotential levels. In ROMS, the viscosity is derived from the horizontal divergence of the deviatory stress tensor (Wajsowicz, 1993).
- parameter = visc4(ng)
- variable = visc4_p(:,:), visc4_r(:,:)
- required = MIX_S_UV, MIX_GEO_UV
- related = VISC_GRID
- routine = uv3dmix4_s.h, uv3dmix4_geo.h, uv3dmix.F
V
- VAR_RHO_2D
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- VCONVOLUTION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- VERIFICATION
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- VISC_GRID
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- VWALK_FORWARD
- Option to activate the old forward step vertical random walk computation.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
W
- W4DPSAS OBSOLETE - Renamed to RBL4DVAR in SVN revision 1022
- Option to Option to activate Lanczos 4D-Var, strong/weak constraint, dual formulation.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = w4dpsas_ocean.h
- W4DPSAS_FCT_SENSITIVITY OBSOLETE - Renamed to RBL4DVAR_FCT_SENSITIVITY in SVN revision 1022
- Option to activate the observation impact driver for the forecast cycles.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = ad_htobs.F, ad_rpcg_lanczos.F, ceckdefs.F, def_info.F, def_ini.F, def_mod.F, get_state.F, globaldefs.h, mod_iounits.F, mod_fourdvar.F, obs_sen_w4dpsas_forecast.h, read_asspar.F, read_phypar.F, rpcg_lanczos.F, tl_rpcg_lanczos.F, wrt_info.F
- W4DPSAS_SENSITIVITY OBSOLETE - Renamed to RBL4DVAR_ANA_SENSITIVITY in SVN revision 1022
- Option to activate Lanczos 4D-Var, strong/weak constraint, dual formulation analysis of observation impact and observations sensitivity.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = obs_sen_w4dpsas.h
- W4DVAR OBSOLETE - Renamed to R4DVAR in SVN revision 1022
- Option to activate indirect Representers 4D-Var, strong/weak constraint, dual formulation. This algorithm is no longer developed due to its instability in multiple outer loops in applications with high Rossby number. It is keep for instructional usage. We do not recommend to be used in realistic applications. Use instead the RBL4D-Var algorithm, which has a more efficient minimization RBLanczos solver.
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = w4dvar_ocean.h
- W4DVAR_SENSITIVITY OBSOLETE - Renamed to R4DVAR_ANA_SENSITIVITY in SVN revision 1022
- Option to activate R4D-Var Analysis Observation Impact and Observations Sensitivity
- parameter =
- parent =
- required =
- related =
- conflict =
- routine = obs_sen_w4dvar.h
- WEAK_CONSTRAINT
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- WEDDELL
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- WEST_FSCLAMPED
- Option to use free-surface clamped condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSCLAMPED, NORTH_FSCLAMPED, SOUTH_FSCLAMPED
- conflict = EW_PERIODIC, WEST_FSCHAPMAN, WEST_FSGRADIENT, WEST_FSNUDGING, WEST_FSRADIATION, WESTERN_WALL
- routine = zetabc.F
- WEST_FSCHAPMAN
- Option to use free-surface Chapman condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSCHAPMAN, NORTH_FSCHAPMAN, SOUTH_FSCHAPMAN
- conflict = EW_PERIODIC, WEST_FSCLAMPED, WEST_FSGRADIENT, WEST_FSNUDGING, WEST_FSRADIATION, WESTERN_WALL
- routine = zetabc.F
- WEST_FSGRADIENT
- Option to use free-surface gradient condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSGRADIENT, NORTH_FSGRADIENT, SOUTH_FSGRADIENT
- conflict = EW_PERIODIC, WEST_FSCLAMPED, WEST_FSCHAPMAN, WEST_FSNUDGING, WEST_FSRADIATION, WESTERN_WALL
- routine = zetabc.F
- WEST_FSNUDGING
- Option to use free-surface passive/active nudging term for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSNUDGING, NORTH_FSNUDGING, SOUTH_FSNUDGING
- conflict = EW_PERIODIC, WEST_FSCLAMPED, WEST_FSCHAPMAN, WEST_FSGRADIENT, WESTERN_WALL
- routine = zetabc.F
- WEST_FSRADIATION
- Option to use free-surface radiation condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_FSRADIATION, NORTH_FSRADIATION, SOUTH_FSRADIATION
- conflict = EW_PERIODIC, WEST_FSCLAMPED, WEST_FSCHAPMAN, WEST_FSGRADIENT, WESTERN_WALL
- routine = zetabc.F
- WEST_KGRADIENT
- Option to use TKE fields gradient condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_KGRADIENT, NORTH_KGRADIENT, SOUTH_KGRADIENT
- conflict = EW_PERIODIC, WEST_KRADIATION, WESTERN_WALL
- routine = tkebc_im.F
- WEST_KRADIATION
- Option to use TKE fields radiation condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_KRADIATION, NORTH_KRADIATION, SOUTH_KRADIATION
- conflict = EW_PERIODIC, WEST_KGRADIENT, WESTERN_WALL
- routine = tkebc_im.F
- WEST_M2CLAMPED
- Option to use 2D momentum clamped condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2CLAMPED, NORTH_M2CLAMPED, SOUTH_M2CLAMPED
- conflict = EW_PERIODIC, WEST_M2FLATHER, WEST_M2GRADIENT, WEST_M2NUDGING, WEST_M2RADIATION, WEST_M2REDUCED, WESTERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- WEST_M2FLATHER
- Option to use 2D momentum Flather condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2FLATHER, NORTH_M2FLATHER, SOUTH_M2FLATHER
- conflict = EW_PERIODIC, WEST_M2CLAMPED, WEST_M2GRADIENT, WEST_M2NUDGING, WEST_M2RADIATION, WEST_M2REDUCED, WESTERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- WEST_M2GRADIENT
- Option to use 2D momentum gradient condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2GRADIENT, NORTH_M2GRADIENT, SOUTH_M2GRADIENT
- conflict = EW_PERIODIC, WEST_M2CLAMPED, WEST_M2FLATHER, WEST_M2NUDGING, WEST_M2RADIATION, WEST_M2REDUCED, WESTERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- WEST_M2NUDGING
- Option to use 2D momentum passive/active nudging term for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2NUDGING, NORTH_M2NUDGING, SOUTH_M2NUDGING
- conflict = EW_PERIODIC, WEST_M2CLAMPED, WEST_M2FLATHER, WEST_M2GRADIENT, WEST_M2REDUCED, WESTERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- WEST_M2RADIATION
- Option to use 2D momentum radiation condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2RADIATION, NORTH_M2RADIATION, SOUTH_M2RADIATION
- conflict = EW_PERIODIC, WEST_M2CLAMPED, WEST_M2FLATHER, WEST_M2GRADIENT, WEST_M2REDUCED, WESTERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- WEST_M2REDUCED
- Option to use 2D momentum reduced-physics for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M2REDUCED, NORTH_M2REDUCED, SOUTH_M2REDUCED
- conflict = EW_PERIODIC, WEST_M2CLAMPED, WEST_M2FLATHER, WEST_M2GRADIENT, WEST_M2NUDGING, WEST_M2RADIATION, WESTERN_WALL
- routine = u2dbc_im.F, v2dbc_im.F
- WEST_M3CLAMPED
- Option to use 3D momentum clamped condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M3CLAMPED, NORTH_M3CLAMPED, SOUTH_M3CLAMPED
- conflict = EW_PERIODIC, WEST_M3GRADIENT, WEST_M3NUDGING, WEST_M3RADIATION, WESTERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- WEST_M3GRADIENT
- Option to use 3D momentum gradient condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M3GRADIENT, NORTH_M3GRADIENT, SOUTH_M3GRADIENT
- conflict = EW_PERIODIC, WEST_M3CLAMPED, WEST_M3NUDGING, WEST_M3RADIATION, WESTERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- WEST_M3NUDGING
- Option to use 3D momentum passive/active nudging term for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M3NUDGING, NORTH_M3NUDGING, SOUTH_M3NUDGING
- conflict = EW_PERIODIC, WEST_M3CLAMPED, WEST_M3GRADIENT, WESTERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- WEST_M3RADIATION
- Option to use 3D momentum radiation condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_M3RADIATION, NORTH_M3RADIATION, SOUTH_M3RADIATION
- conflict = EW_PERIODIC, WEST_M3CLAMPED, WEST_M3GRADIENT, WESTERN_WALL
- routine = u3dbc_im.F, v3dbc_im.F
- WEST_TCLAMPED
- Option to use tracer clamped condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_TCLAMPED, NORTH_TCLAMPED, SOUTH_TCLAMPED
- conflict = EW_PERIODIC, WEST_TGRADIENT, WEST_TNUDGING, WEST_TRADIATION, WESTERN_WALL
- routine = t3dbc_im.F
- WEST_TGRADIENT
- Option to use tracer gradient condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_TGRADIENT, NORTH_TGRADIENT, SOUTH_TGRADIENT
- conflict = EW_PERIODIC, WEST_TCLAMPED, WEST_TNUDGING, WEST_TRADIATION, WESTERN_WALL
- routine = t3dbc_im.F
- WEST_TNUDGING
- Option to use tracer passive/active nudging term for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_TNUDGING, NORTH_TNUDGING, SOUTH_TNUDGING
- conflict = EW_PERIODIC, WEST_TCLAMPED, WEST_TGRADIENT, WESTERN_WALL
- routine = t3dbc_im.F
- WEST_TRADIATION
- Option to use tracer radiation condition for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_TRADIATION, NORTH_TRADIATION, SOUTH_TRADIATION
- conflict = EW_PERIODIC, WEST_TCLAMPED, WEST_TGRADIENT, WESTERN_WALL
- routine = t3dbc_im.F
- WEST_VOLCONS
- Option to use Southern edge mass conservation enforcement for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_VOLCONS, NORTH_VOLCONS, SOUTH_VOLCONS
- conflict = EW_PERIODIC, WESTERN_WALL
- routine = obc_volcons.F
- WESTERN_WALL
- Option to use Southern edge closed wall for the western open boundary condition.
- parameter =
- parent =
- required =
- related = EAST_WALL, NORTH_WALL, SOUTH_WALL
- conflict = EW_PERIODIC, WEST_FSCLAMPED, WEST_FSCHAPMAN, WEST_FSGRADIENT, WEST_FSNUDGING, WEST_FSRADIATION, WEST_KGRADIENT, WEST_KRADIATION, WEST_M2CLAMPED, WEST_M2FLATHER, WEST_M2GRADIENT, WEST_M2NUDGING, WEST_M2RADIATION, WEST_M2REDUCED, WEST_M3CLAMPED, WEST_M3GRADIENT, WEST_M3NUDGING, WEST_M3RADIATION, WEST_TCLAMPED, WEST_TGRADIENT, WEST_TNUDGING, WEST_TRADIATION, WEST_VOLCONS
- routine = t3dbc_im.F, tkebc_im.F, u2dbc_im.F, u3dbc_im.F, v2dbc_im.F, v3dbc_im.F, zetabc.F
- WET_DRY
- Option to activate wetting and drying.
- parameter = Dcrit
- variable = rmask_wet, umask_wet, vmask_wet
- routine = step2d.F
- WINDBASIN
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- WIND_WAVES
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- WJ_GRADP
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- WRITE_WATER
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- WRF_COUPLING
- Option to
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
X
Y
Z
- ZCLIMATOLOGY
- DEPRICATED in favor of LsshCLM logical switches to facilitate nesting.
 Option to read and process SSH climatology fields.
- parameter =
- parent =
- required =
- related = ANA_SSH, SSH_TIDES, ZCLM_NUDGING
- conflict =
- routine =
- ZCLM_NUDGING
- Option to nudge SSH climatology data (primarily in sponge areas.
- parameter =
- parent =
- required =
- related = ANA_SSH, SSH_TIDES, ZCLIMATOLOGY
- conflict =
- routine =
- ZETA_ELLIPTIC
- Option to compute the balanced free-surface increment by solving an elliptical equation as in Fukomuri et al. (1998).
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
- ZOS_HSIG
- Option to use horizontal smoothing of buoyancy/shear for the Generic Length-Scale closure (Warner et al., 2005).
- parameter =
- parent =
- required =
- related =
- conflict =
- routine =
