/[MITgcm]/MITgcm/model/inc/PARAMS.h
ViewVC logotype

Annotation of /MITgcm/model/inc/PARAMS.h

Parent Directory Parent Directory | Revision Log Revision Log | View Revision Graph Revision Graph


Revision 1.49.2.2 - (hide annotations) (download)
Tue Apr 3 02:39:18 2001 UTC (23 years, 1 month ago) by adcroft
Branch: pre38
Changes since 1.49.2.1: +3 -1 lines
File MIME type: text/plain
Added usingCurvilinearGrid logical.

1 adcroft 1.49.2.2 C $Header: /u/gcmpack/models/MITgcmUV/model/inc/PARAMS.h,v 1.49.2.1 2001/04/02 16:37:20 adcroft Exp $
2 jmc 1.48 C $Name: $
3 cnh 1.1 C
4     C /==========================================================\
5     C | PARAMS.h |
6     C | o Header file defining model "parameters". |
7     C |==========================================================|
8 cnh 1.33 C | The values from the model standard input file are |
9 cnh 1.1 C | stored into the variables held here. Notes describing |
10     C | the parameters can also be found here. |
11     C \==========================================================/
12 cnh 1.13
13     C Macros for special grid options
14     #include "PARAMS_MACROS.h"
15 cnh 1.1
16     C-- Contants
17     C Useful physical values
18     Real*8 PI
19     PARAMETER ( PI = 3.14159265358979323844D0 )
20     Real*8 deg2rad
21     PARAMETER ( deg2rad = 2.D0*PI/360.D0 )
22    
23 cnh 1.7 C Symbolic values
24     C precXXXX - Used to indicate what precision to use for
25     C dumping model state.
26     INTEGER precFloat32
27 adcroft 1.36 PARAMETER ( precFloat32 = 32 )
28 cnh 1.7 INTEGER precFloat64
29 adcroft 1.36 PARAMETER ( precFloat64 = 64 )
30 cnh 1.28 C UNSET_xxx - Used to indicate variables that have not been given a value
31     Real*8 UNSET_FLOAT8
32     PARAMETER ( UNSET_FLOAT8 = 1.234567D5 )
33     Real*4 UNSET_FLOAT4
34     PARAMETER ( UNSET_FLOAT4 = 1.234567E5 )
35     _RL UNSET_RL
36     PARAMETER ( UNSET_RL = 1.234567D5 )
37     _RS UNSET_RS
38     PARAMETER ( UNSET_RS = 1.234567E5 )
39     INTEGER UNSET_I
40     PARAMETER ( UNSET_I = 123456789 )
41 cnh 1.7
42     C Checkpoint data
43     INTEGER maxNoChkptLev
44     PARAMETER ( maxNoChkptLev = 2 )
45    
46 cnh 1.1 C-- COMMON /PARM_C/ Character valued parameters used by the model.
47 cnh 1.7 C checkPtSuff - List of checkpoint file suffices
48 cnh 1.16 C bathyFile - File containing bathymetry. If not defined bathymetry
49     C is taken from inline function.
50     C hydrogThetaFile - File containing initial hydrographic data for potential
51     C temperature.
52     C hydrogSaltFile - File containing initial hydrographic data for salinity.
53     C zonalWindFile - File containing zonal wind data
54     C meridWindFile - File containing meridional wind data
55 cnh 1.18 C thetaClimFile - File containing theta climataology used
56     C in relaxation term -lambda(theta-theta*)
57     C saltClimFile - File containing salt climataology used
58     C in relaxation term -lambda(salt-salt*)
59 adcroft 1.37 C surfQfile - File containing surface heat flux
60 heimbach 1.45 C surfQswfile - File containing surface shortwave radiation
61 adcroft 1.37 C EmPmRfile - File containing surface fresh water flux
62 cnh 1.26 C buoyancyRelation - Flag used to indicate which relation to use to
63     C get buoyancy.
64 cnh 1.16 COMMON /PARM_C/ checkPtSuff,
65     & bathyFile, hydrogThetaFile, hydrogSaltFile,
66 cnh 1.18 & zonalWindFile, meridWindFile, thetaClimFile,
67 adcroft 1.37 & saltClimFile, buoyancyRelation,
68 heimbach 1.45 & EmPmRfile, surfQfile, surfQswfile,
69 adcroft 1.43 & uVelInitFile, vVelInitFile, pSurfInitFile
70 cnh 1.7 CHARACTER*(5) checkPtSuff(maxNoChkptLev)
71 cnh 1.16 CHARACTER*(MAX_LEN_FNAM) bathyFile
72     CHARACTER*(MAX_LEN_FNAM) hydrogThetaFile
73     CHARACTER*(MAX_LEN_FNAM) hydrogSaltFile
74     CHARACTER*(MAX_LEN_FNAM) zonalWindFile
75     CHARACTER*(MAX_LEN_FNAM) meridWindFile
76 cnh 1.18 CHARACTER*(MAX_LEN_FNAM) thetaClimFile
77     CHARACTER*(MAX_LEN_FNAM) saltClimFile
78 adcroft 1.37 CHARACTER*(MAX_LEN_FNAM) surfQfile
79 heimbach 1.45 CHARACTER*(MAX_LEN_FNAM) surfQswfile
80 adcroft 1.37 CHARACTER*(MAX_LEN_FNAM) EmPmRfile
81 cnh 1.26 CHARACTER*(MAX_LEN_FNAM) buoyancyRelation
82 adcroft 1.42 CHARACTER*(MAX_LEN_FNAM) uVelInitFile
83     CHARACTER*(MAX_LEN_FNAM) vVelInitFile
84 adcroft 1.43 CHARACTER*(MAX_LEN_FNAM) pSurfInitFile
85 cnh 1.7
86 cnh 1.1 C-- COMMON /PARM_I/ Integer valued parameters used by the model.
87     C cg2dMaxIters - Maximum number of iterations in the
88     C two-dimensional con. grad solver.
89     C cg2dChkResFreq - Frequency with which to check residual
90     C in con. grad solver.
91 cnh 1.33 C cg3dMaxIters - Maximum number of iterations in the
92     C three-dimensional con. grad solver.
93     C cg3dChkResFreq - Frequency with which to check residual
94     C in con. grad solver.
95 cnh 1.1 C nIter0 - Start time-step number of for this run
96     C nTimeSteps - Number of timesteps to execute
97     C numStepsPerPickup - For offline setup. Frequency of pickup
98     C of flow fields.
99 cnh 1.7 C writeStatePrec - Precision used for writing model state.
100     C writeBinaryPrec - Precision used for writing binary files
101     C readBinaryPrec - Precision used for reading binary files
102     C nCheckLev - Holds current checkpoint level
103 cnh 1.34 C nShap - "Order" of shapiro filter to apply to
104     C model prognositic fields.
105     C nShap == 1 => del2
106     C nShap == 2 => del4
107     C nShap == 3 => del6
108     C etc...
109    
110 cnh 1.1 COMMON /PARM_I/
111     & cg2dMaxIters,
112     & cg2dChkResFreq,
113 cnh 1.33 & cg3dMaxIters,
114     & cg3dChkResFreq,
115 adcroft 1.41 & nIter0, nTimeSteps, nEndIter,
116 cnh 1.7 & numStepsPerPickup,
117     & writeStatePrec, nCheckLev,
118 cnh 1.34 & writeBinaryPrec, readBinaryPrec,
119 adcroft 1.46 & nShap, zonal_filt_sinpow, zonal_filt_cospow
120 cnh 1.1 INTEGER cg2dMaxIters
121     INTEGER cg2dChkResFreq
122 cnh 1.33 INTEGER cg3dMaxIters
123     INTEGER cg3dChkResFreq
124 cnh 1.1 INTEGER nIter0
125     INTEGER nTimeSteps
126 adcroft 1.41 INTEGER nEndIter
127 cnh 1.1 INTEGER numStepsPerPickup
128 cnh 1.7 INTEGER writeStatePrec
129     INTEGER writeBinaryPrec
130     INTEGER readBinaryPrec
131     INTEGER nCheckLev
132 cnh 1.34 INTEGER nShap
133 adcroft 1.46 INTEGER zonal_filt_sinpow
134     INTEGER zonal_filt_cospow
135 cnh 1.1
136     C-- COMMON /PARM_L/ Logical valued parameters used by the model.
137     C usingCartesianGrid - If TRUE grid generation will be in a cartesian
138     C coordinate frame.
139     C usingSphericalPolarGrid - If TRUE grid generation will be in a
140     C spherical polar frame.
141 adcroft 1.36 C no_slip_sides - Impose "no-slip" at lateral boundaries.
142     C no_slip_bottom- Impose "no-slip" at bottom boundary.
143 adcroft 1.46 C staggerTimeStep - enable a Stagger time stepping T,S Rho then U,V
144 cnh 1.1 C momViscosity - Flag which turns momentum friction terms on and off.
145     C momAdvection - Flag which turns advection of momentum on and off.
146     C momForcing - Flag which turns external forcing of momentum on
147     C and off.
148 cnh 1.9 C momPressureForcing - Flag which turns pressure term in momentum equation
149     C on and off.
150 cnh 1.15 C metricTerms - Flag which turns metric terms on or off.
151     C usingSphericalPolarMTerms - If TRUE use spherical polar metric terms.
152 cnh 1.1 C useCoriolis - Flag which turns the coriolis terms on and off.
153     C tempDiffusion - Flag which turns diffusion of temperature on
154     C and off.
155     C tempAdvection - Flag which turns advection of temperature on
156     C and off.
157     C tempForcing - Flag which turns external forcing of temperature on
158     C and off.
159     C saltDiffusion - Flag which turns diffusion of salinit on
160     C and off.
161     C saltAdvection - Flag which turns advection of salinit on
162     C and off.
163     C saltForcing - Flag which turns external forcing of salinit on
164     C and off.
165 cnh 1.8 C implicitFreeSurface - Set to true to use implcit free surface
166     C rigidLid - Set to true to use rigid lid
167 cnh 1.10 C momStepping - Turns momentum equation time-stepping off
168 cnh 1.15 C tempStepping - Turns temperature equation time-stepping off
169 adcroft 1.17 C saltStepping - Turns salinity equation time-stepping off
170 cnh 1.15 C useConstantF - Coriolis parameter set to f0
171     C useBetaPlaneF - Coriolis parameter set to f0 + beta.y
172     C useSphereF - Coriolis parameter set to 2.omega.sin(phi)
173 adcroft 1.14 C implicitDiffusion - Turns implicit vertical diffusion on
174 adcroft 1.40 C implicitViscosity - Turns implicit vertical viscosity on
175 cnh 1.18 C doThetaClimRelax - Set true if relaxation to temperature
176     C climatology is required.
177     C doSaltClimRelax - Set true if relaxation to salinity
178     C climatology is required.
179 adcroft 1.19 C periodicExternalForcing - Set true if forcing is time-dependant
180 cnh 1.29 C usingPCoords - Set to indicate that we are working in pressure
181     C coords.
182     C usingZCoords - Set to indicate that we are working in height
183     C coords.
184 adcroft 1.37 C nonHydrostatic - Using non-hydrostatic terms
185 adcroft 1.38 C globalFiles - Selects between "global" and "tiled" files
186     C allowFreezing - Allows water to freeze and form ice
187 adcroft 1.46 C groundAtK1 - put the surface(k=1) at the Lower Boundary (=ground)
188 cnh 1.1 COMMON /PARM_L/ usingCartesianGrid, usingSphericalPolarGrid,
189 adcroft 1.49.2.2 & usingCurvilinearGrid,
190 adcroft 1.36 & no_slip_sides,no_slip_bottom,
191 adcroft 1.46 & staggerTimeStep,
192 cnh 1.33 & momViscosity, momAdvection, momForcing, useCoriolis,
193     & momPressureForcing,tempDiffusion, tempAdvection, tempForcing,
194 cnh 1.8 & saltDiffusion, saltAdvection, saltForcing,
195 adcroft 1.17 & implicitFreeSurface, rigidLid,
196     & momStepping, tempStepping, saltStepping,
197 cnh 1.15 & metricTerms, usingSphericalPolarMTerms,
198     & useConstantF, useBetaPlaneF, useSphereF,
199 adcroft 1.40 & implicitDiffusion, implicitViscosity,
200     & doThetaClimRelax, doSaltClimRelax,
201 adcroft 1.35 & periodicExternalForcing, usingPCoords, usingZCoords,
202 adcroft 1.46 & nonHydrostatic, globalFiles,
203     & allowFreezing, groundAtK1
204 cnh 1.1 LOGICAL usingCartesianGrid
205     LOGICAL usingSphericalPolarGrid
206 adcroft 1.49.2.2 LOGICAL usingCurvilinearGrid
207 cnh 1.15 LOGICAL usingSphericalPolarMTerms
208 adcroft 1.36 LOGICAL no_slip_sides
209     LOGICAL no_slip_bottom
210 adcroft 1.46 LOGICAL staggerTimeStep
211 cnh 1.1 LOGICAL momViscosity
212     LOGICAL momAdvection
213     LOGICAL momForcing
214 cnh 1.9 LOGICAL momPressureForcing
215 cnh 1.1 LOGICAL useCoriolis
216     LOGICAL tempDiffusion
217     LOGICAL tempAdvection
218     LOGICAL tempForcing
219     LOGICAL saltDiffusion
220     LOGICAL saltAdvection
221     LOGICAL saltForcing
222 cnh 1.8 LOGICAL implicitFreeSurface
223     LOGICAL rigidLid
224 cnh 1.10 LOGICAL momStepping
225     LOGICAL tempStepping
226 adcroft 1.17 LOGICAL saltStepping
227 cnh 1.15 LOGICAL metricTerms
228     LOGICAL useConstantF
229     LOGICAL useBetaPlaneF
230     LOGICAL useSphereF
231 adcroft 1.14 LOGICAL implicitDiffusion
232 adcroft 1.40 LOGICAL implicitViscosity
233 cnh 1.18 LOGICAL doThetaClimRelax
234     LOGICAL doSaltClimRelax
235 adcroft 1.19 LOGICAL periodicExternalForcing
236 cnh 1.29 LOGICAL usingPCoords
237     LOGICAL usingZCoords
238 adcroft 1.37 LOGICAL nonHydrostatic
239 adcroft 1.38 LOGICAL globalFiles
240     LOGICAL allowFreezing
241 adcroft 1.46 LOGICAL groundAtK1
242 cnh 1.1
243     C-- COMMON /PARM_R/ "Real" valued parameters used by the model.
244     C cg2dTargetResidual
245     C - Target residual for cg2d solver.
246 cnh 1.33 C cg3dTargetResidual
247     C - Target residual for cg3d solver.
248 cnh 1.7 C cg2dpcOffDFac - Averaging weight for preconditioner off-diagonal.
249     C Note. 20th May 1998
250     C I made a weird discovery! In the model paper we argue
251     C for the form of the preconditioner used here ( see
252     C A Finite-volume, Incompressible Navier-Stokes Model
253     C ...., Marshall et. al ). The algebra gives a simple
254     C 0.5 factor for the averaging of ac and aCw to get a
255     C symmettric pre-conditioner. By using a factor of 0.51
256     C i.e. scaling the off-diagonal terms in the
257     C preconditioner down slightly I managed to get the
258     C number of iterations for convergence in a test case to
259     C drop form 192 -> 134! Need to investigate this further!
260     C For now I have introduced a parameter cg2dpcOffDFac which
261     C defaults to 0.51 but can be set at runtime.
262 cnh 1.24 C delP - Vertical grid spacing ( Pa ).
263     C delZ - Vertical grid spacing ( m ).
264 cnh 1.23 C delR - Vertical grid spacing ( units of r ).
265 cnh 1.1 C delX - Separation between cell faces (m) or (deg), depending
266     C delY on input flags.
267     C gravity - Accel. due to gravity ( m/s^2 )
268 cnh 1.32 C recip_gravity and its inverse
269 cnh 1.8 C gBaro - Accel. due to gravity used in barotropic equation ( m/s^2 )
270 cnh 1.1 C ronil - Reference density
271 cnh 1.24 C rhoConst - Vertically constant reference density
272 cnh 1.3 C startTime - Start time for model ( s )
273 cnh 1.1 C phiMin - Latitude of southern most cell face.
274     C thetaMin - Longitude of western most cell face (this
275     C is an "inert" parameter but it is included
276     C to make geographical references simple.)
277 cnh 1.3 C rSphere - Radius of sphere for a spherical polar grid ( m ).
278 cnh 1.25 C recip_RSphere - Reciprocal radius of sphere ( m ).
279 cnh 1.1 C f0 - Reference coriolis parameter ( 1/s )
280     C ( Southern edge f for beta plane )
281     C beta - df/dy ( s^-1.m^-1 )
282 cnh 1.15 C omega - Angular velocity ( rad/s )
283 cnh 1.1 C viscAh - Eddy viscosity coeff. for mixing of
284     C momentum laterally ( m^2/s )
285     C viscAz - Eddy viscosity coeff. for mixing of
286     C momentum vertically ( m^2/s )
287 cnh 1.27 C viscAp - Eddy viscosity coeff. for mixing of
288     C momentum vertically ( Pa^2/s )
289 cnh 1.24 C viscAr - Eddy viscosity coeff. for mixing of
290     C momentum vertically ( units of r^2/s )
291 cnh 1.1 C viscA4 - Biharmonic viscosity coeff. for mixing of
292     C momentum laterally ( m^4/s )
293     C diffKhT - Laplacian diffusion coeff. for mixing of
294     C heat laterally ( m^2/s )
295     C diffKzT - Laplacian diffusion coeff. for mixing of
296     C heat vertically ( m^2/s )
297 cnh 1.27 C diffKpT - Laplacian diffusion coeff. for mixing of
298     C heat vertically ( Pa^2/s )
299 cnh 1.24 C diffKrT - Laplacian diffusion coeff. for mixing of
300     C heat vertically ( units of r^2/s )
301 cnh 1.1 C diffK4T - Biharmonic diffusion coeff. for mixing of
302     C heat laterally ( m^4/s )
303     C diffKhS - Laplacian diffusion coeff. for mixing of
304     C salt laterally ( m^2/s )
305     C diffKzS - Laplacian diffusion coeff. for mixing of
306     C salt vertically ( m^2/s )
307 cnh 1.27 C diffKpS - Laplacian diffusion coeff. for mixing of
308     C salt vertically ( Pa^2/s )
309 cnh 1.24 C diffKrS - Laplacian diffusion coeff. for mixing of
310     C salt vertically ( units of r^2/s )
311 cnh 1.1 C diffK4S - Biharmonic diffusion coeff. for mixing of
312     C salt laterally ( m^4/s )
313 cnh 1.3 C deltaT - Default timestep ( s )
314 cnh 1.7 C deltaTClock - Timestep used as model "clock". This determines the
315     C IO frequencies and is used in tagging output. It can
316     C be totally different to the dynamical time. Typically
317     C it will be the deep-water timestep for accelerated runs.
318     C Frequency of checkpointing and dumping of the model state
319     C are referenced to this clock. ( s )
320 cnh 1.3 C deltaTMom - Timestep for momemtum equations ( s )
321     C deltaTtracer - Timestep for tracer equations ( s )
322 cnh 1.8 C freesurfFac - Parameter to turn implicit free surface term on or off
323     C freesurfac = 1. uses implicit free surface
324     C freesurfac = 0. uses rigid lid
325 jmc 1.48 C implicSurfPress - parameter of the Crank-Nickelson time stepping :
326     C Implicit part of Surface Pressure Gradient ( 0-1 )
327     C implicDiv2Dflow - parameter of the Crank-Nickelson time stepping :
328     C Implicit part of barotropic flow Divergence ( 0-1 )
329 cnh 1.24 C hFacMin - Minimum fraction size of a cell (affects hFacC etc...)
330     C hFacMinDz - Minimum dimesional size of a cell (affects hFacC etc..., m)
331 cnh 1.28 C hFacMinDp - Minimum dimesional size of a cell (affects hFacC etc..., Pa)
332 cnh 1.24 C hFacMinDr - Minimum dimesional size of a cell (affects hFacC etc..., units of r)
333     C tauCD - CD scheme coupling timescale ( 1/s )
334     C rCD - CD scheme normalised coupling parameter ( 0-1 )
335     C startTime - Starting time for this integration ( s ).
336     C endTime - Ending time for this integration ( s ).
337     C chkPtFreq - Frequency of rolling check pointing ( s ).
338     C pChkPtFreq - Frequency of permanent check pointing ( s ).
339     C dumpFreq - Frequency with which model state is written to
340     C post-processing files ( s ).
341     C afFacMom - Advection of momentum term tracer parameter
342     C vfFacMom - Momentum viscosity tracer parameter
343     C pfFacMom - Momentum pressure forcing tracer parameter
344     C cfFacMom - Coriolis term tracer parameter
345     C foFacMom - Momentum forcing tracer parameter
346     C mtFacMom - Metric terms tracer parameter
347 adcroft 1.39 C cosPower - Power of cosine of latitude to multiply viscosity
348 cnh 1.24 C cAdjFreq - Frequency of convective adjustment
349     C
350 cnh 1.27 C taveFreq - Frequency with which time-averaged model state is written to
351     C post-processing files ( s ).
352 cnh 1.18 C tauThetaClimRelax - Relaxation to climatology time scale ( s ).
353     C lambdaThetaClimRelax - Inverse time scale for relaxation ( 1/s ).
354     C tauSaltClimRelax - Relaxation to climatology time scale ( s ).
355     C lambdaSaltClimRelax - Inverse time scale for relaxation ( 1/s ).
356 adcroft 1.19 C externForcingPeriod - Is the period of which forcing varies (eg. 1 month)
357     C externForcingCycle - Is the repeat time of the forcing (eg. 1 year)
358     C (note: externForcingCycle must be an integer
359     C number times externForcingPeriod)
360 cnh 1.30 C horiVertRatio - Ratio on units in vertical to units in horizontal.
361 cnh 1.31 C recip_horiVertRatio ( 1 if horiz in m and vertical in m ).
362 cnh 1.30 C ( g*rho if horiz in m and vertical in Pa ).
363 cnh 1.34 C latFFTFiltLo - Low latitude for FFT filtering of latitude
364     C circles ( see filter*.F )
365 adcroft 1.46 C Ro_SeaLevel - standard position of Sea-Level in "R" coordinate, used as
366     C starting value (k=1) for vertical coordinate (rf(1)=Ro_SeaLevel)
367     C bottomDragLinear - Drag coefficient built in to core dynamics
368     C " Quadratic ( linear: 1/s, quadratic: 1/m )
369 cnh 1.24 COMMON /PARM_R/ cg2dTargetResidual, cg2dpcOffDFac,
370 cnh 1.33 & cg3dTargetResidual,
371 cnh 1.24 & delP, delZ, delR, delX, delY,
372 cnh 1.33 & deltaT,deltaTmom, deltaTtracer, deltaTClock,abeps, startTime,
373 adcroft 1.49.2.1 & phiMin, thetaMin, rSphere, recip_RSphere, f0, beta,
374     & fCori, fCoriG,
375 cnh 1.24 & viscAh, viscAz, viscA4, viscAr,
376     & diffKhT, diffKzT, diffK4T, diffKrT,
377 cnh 1.25 & diffKhS, diffKzS, diffK4S, diffKrS,
378 jmc 1.48 & delT, tauCD, rCD, freeSurfFac, implicSurfPress, implicDiv2Dflow,
379     & hFacMin, hFacMinDz,
380 cnh 1.32 & gravity, recip_Gravity, gBaro, rhonil, recip_rhonil,
381 cnh 1.27 & recip_rhoConst, rhoConst, tRef, sRef,
382 adcroft 1.20 & endTime, chkPtFreq, pchkPtFreq, dumpFreq, taveFreq,
383 cnh 1.15 & afFacMom, vfFacMom, pfFacMom, cfFacMom, foFacMom, mtFacMom,
384 adcroft 1.39 & cosPower,
385 cnh 1.18 & cAdjFreq, omega, tauThetaClimRelax, lambdaThetaClimRelax,
386 adcroft 1.19 & tauSaltClimRelax, lambdaSaltClimRelax,
387 cnh 1.27 & externForcingCycle, externForcingPeriod,
388 cnh 1.28 & viscAp, diffKpT, diffKpS, hFacMinDr, hFacMinDp,
389 cnh 1.34 & theta_S, specVol_S, horiVertRatio, recip_horiVertRatio,
390 adcroft 1.46 & latFFTFiltLo, ivdc_kappa, Ro_SeaLevel, zonal_filt_lat,
391     & bottomDragLinear,bottomDragQuadratic
392 cnh 1.27
393 adcroft 1.6 _RL cg2dTargetResidual
394 cnh 1.33 _RL cg3dTargetResidual
395 cnh 1.7 _RL cg2dpcOffDFac
396 cnh 1.25 _RL delZ(Nr)
397     _RL delP(Nr)
398     _RL delR(Nr)
399 adcroft 1.6 _RL delX(Nx)
400     _RL delY(Ny)
401     _RL deltaT
402 cnh 1.7 _RL deltaTClock
403 adcroft 1.6 _RL deltaTmom
404     _RL deltaTtracer
405     _RL abeps
406     _RL phiMin
407     _RL thetaMin
408     _RL rSphere
409 cnh 1.25 _RL recip_RSphere
410 adcroft 1.6 _RL f0
411 cnh 1.8 _RL freeSurfFac
412 jmc 1.48 _RL implicSurfPress
413     _RL implicDiv2Dflow
414 adcroft 1.22 _RL hFacMin
415     _RL hFacMinDz
416 cnh 1.28 _RL hFacMinDp
417 cnh 1.27 _RL hFacMinDr
418 adcroft 1.6 _RL beta
419     _RL viscAh
420     _RL viscAz
421 cnh 1.27 _RL viscAp
422 cnh 1.25 _RL viscAr
423 adcroft 1.6 _RL viscA4
424     _RL diffKhT
425 cnh 1.25 _RL diffKrT
426 adcroft 1.6 _RL diffKzT
427 cnh 1.27 _RL diffKpT
428 adcroft 1.6 _RL diffK4T
429     _RL diffKhS
430 cnh 1.25 _RL diffKrS
431 adcroft 1.6 _RL diffKzS
432 cnh 1.27 _RL diffKpS
433 adcroft 1.6 _RL diffK4S
434     _RL delt
435     _RL tauCD
436     _RL rCD
437     _RL gravity
438 cnh 1.32 _RL recip_gravity
439 cnh 1.8 _RL gBaro
440 adcroft 1.6 _RL rhonil
441 cnh 1.25 _RL recip_rhonil
442     _RL rhoConst
443 cnh 1.26 _RL recip_rhoConst
444     _RL specVol_S(Nr)
445 cnh 1.25 _RL tRef(Nr)
446 cnh 1.26 _RL theta_S(Nr)
447 cnh 1.25 _RL sRef(Nr)
448 adcroft 1.49.2.1 _RS fCori(1-OLx:sNx+OLx,1-OLy:sNy+OLy,nSx,nSy)
449     _RS fCoriG(1-OLx:sNx+OLx,1-OLy:sNy+OLy,nSx,nSy)
450 adcroft 1.6 _RL startTime
451     _RL endTime
452     _RL chkPtFreq
453 cnh 1.7 _RL pChkPtFreq
454 adcroft 1.6 _RL dumpFreq
455 adcroft 1.20 _RL taveFreq
456 cnh 1.9 _RL afFacMom
457     _RL vfFacMom
458     _RL pfFacMom
459     _RL cfFacMom
460     _RL foFacMom
461 cnh 1.15 _RL mTFacMom
462 adcroft 1.39 _RL cosPower
463 cnh 1.9 _RL cAdjFreq
464 cnh 1.15 _RL omega
465 cnh 1.18 _RL tauThetaClimRelax
466     _RL lambdaThetaClimRelax
467     _RL tauSaltClimRelax
468     _RL lambdaSaltClimRelax
469 adcroft 1.19 _RL externForcingCycle
470     _RL externForcingPeriod
471 cnh 1.30 _RL horiVertRatio
472 cnh 1.31 _RL recip_horiVertRatio
473 cnh 1.34 _RL latFFTFiltLo
474 adcroft 1.41 _RL ivdc_kappa
475 adcroft 1.46 _RL Ro_SeaLevel
476     _RL zonal_filt_lat
477     _RL bottomDragLinear
478     _RL bottomDragQuadratic
479 adcroft 1.6
480 adcroft 1.36 COMMON /PARM_A/ HeatCapacity_Cp,recip_Cp,
481 cnh 1.1 & Lamba_theta
482 adcroft 1.6 _RL HeatCapacity_Cp
483     _RL Lamba_theta
484 adcroft 1.36 _RL recip_Cp
485 adcroft 1.5
486     C Equation of State (polynomial coeffients)
487     COMMON /PARM_EOS_NL/ eosC,eosSig0,eosRefT,eosRefS
488 cnh 1.25 _RL eosC(9,Nr+1),eosSig0(Nr+1),eosRefT(Nr+1),eosRefS(Nr+1)
489 adcroft 1.5 C Linear equation of state
490     C tAlpha - Linear EOS thermal expansion coefficient ( 1/degree ).
491     C sBeta - Linear EOS haline contraction coefficient.
492 adcroft 1.12 COMMON /PARM_EOS_LIN/ tAlpha,sBeta,eosType
493 adcroft 1.6 _RL tAlpha
494     _RL sBeta
495 adcroft 1.12 character*(6) eosType
496 cnh 1.7
497 adcroft 1.44 C Logical flags for selecting packages
498 heimbach 1.45 LOGICAL useKPP
499     LOGICAL useGMRedi
500 adcroft 1.46 LOGICAL useOBCS
501 jmc 1.49 LOGICAL useAIM
502 heimbach 1.45 LOGICAL useECCO
503 adcroft 1.44 COMMON /PARM_PACKAGES/
504 jmc 1.49 & useKPP, useGMRedi, useOBCS, useAIM, useECCO
505    

  ViewVC Help
Powered by ViewVC 1.1.22