/[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.45 - (hide annotations) (download)
Mon Sep 11 23:12:20 2000 UTC (23 years, 8 months ago) by heimbach
Branch: MAIN
CVS Tags: branch-atmos-merge-start, checkpoint33, checkpoint32, checkpoint31, checkpoint34, branch-atmos-merge-phase4, branch-atmos-merge-phase1, branch-atmos-merge-phase3, branch-atmos-merge-phase2
Branch point for: branch-atmos-merge
Changes since 1.44: +8 -5 lines
File MIME type: text/plain
Included variable surfQswfile for shortwave heating.
Change variable names useKPP, useGMRedi, useECCO.
Tested for exp(0,2,4).

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

  ViewVC Help
Powered by ViewVC 1.1.22