/[MITgcm]/MITgcm_contrib/rpa_layers/modsrc/PARAMS.h
ViewVC logotype

Annotation of /MITgcm_contrib/rpa_layers/modsrc/PARAMS.h

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


Revision 1.1 - (hide annotations) (download)
Tue Sep 15 19:46:38 2009 UTC (15 years, 10 months ago) by rpa
Branch: MAIN
File MIME type: text/plain
mods to model/src for running layers package

1 rpa 1.1 C $Header: /u/gcmpack/MITgcm/model/inc/PARAMS.h,v 1.227 2009/01/27 15:35:27 jmc Exp $
2     C $Name: $
3     C
4    
5     CBOP
6     C !ROUTINE: PARAMS.h
7     C !INTERFACE:
8     C #include PARAMS.h
9    
10     C !DESCRIPTION:
11     C Header file defining model "parameters". The values from the
12     C model standard input file are stored into the variables held
13     C here. Notes describing the parameters can also be found here.
14    
15     CEOP
16    
17     C Macros for special grid options
18     #include "PARAMS_MACROS.h"
19    
20     C-- Contants
21     C Useful physical values
22     Real*8 PI
23     PARAMETER ( PI = 3.14159265358979323844D0 )
24     Real*8 deg2rad
25     PARAMETER ( deg2rad = 2.D0*PI/360.D0 )
26    
27     C-- COMMON /PARM_C/ Character valued parameters used by the model.
28     C buoyancyRelation :: Flag used to indicate which relation to use to
29     C get buoyancy.
30     C eosType :: choose the equation of state:
31     C LINEAR, POLY3, UNESCO, JMD95Z, JMD95P, MDJWF, IDEALGAS
32     C pickupSuff :: force to start from pickup files (even if nIter0=0)
33     C and read pickup files with this suffix (max 10 Char.)
34     C mdsioLocalDir :: read-write tiled file from/to this directory name
35     C (+ 4 digits Processor-Rank) instead of current dir.
36     C tRefFile :: File containing reference Potential Temperat. tRef (1.D)
37     C sRefFile :: File containing reference salinity/spec.humid. sRef (1.D)
38     C rhoRefFile :: File containing reference density profile rhoRef (1.D)
39     C delRFile :: File containing vertical grid spacing delR (1.D array)
40     C delRcFile :: File containing vertical grid spacing delRc (1.D array)
41     C delXFile :: File containing X-spacing grid definition (1.D array)
42     C delYFile :: File containing Y-spacing grid definition (1.D array)
43     C horizGridFile :: File containing horizontal-grid definition
44     C (only when using curvilinear_grid)
45     C bathyFile :: File containing bathymetry. If not defined bathymetry
46     C is taken from inline function.
47     C topoFile :: File containing the topography of the surface (unit=m)
48     C (mainly used for the atmosphere = ground height).
49     C hydrogThetaFile :: File containing initial hydrographic data (3-D)
50     C for potential temperature.
51     C hydrogSaltFile :: File containing initial hydrographic data (3-D)
52     C for salinity.
53     C diffKrFile :: File containing 3D specification of vertical diffusivity
54     C zonalWindFile :: File containing zonal wind data
55     C meridWindFile :: File containing meridional wind data
56     C thetaClimFile :: File containing surface theta climataology used
57     C in relaxation term -lambda(theta-theta*)
58     C saltClimFile :: File containing surface salt climataology used
59     C in relaxation term -lambda(salt-salt*)
60     C surfQfile :: File containing surface heat flux, excluding SW
61     C (old version, kept for backward compatibility)
62     C surfQnetFile :: File containing surface net heat flux
63     C surfQswFile :: File containing surface shortwave radiation
64     C dQdTfile :: File containing thermal relaxation coefficient
65     C EmPmRfile :: File containing surface fresh water flux
66     C NOTE: for backward compatibility EmPmRfile is specified in
67     C m/s when using external_fields_load.F. It is converted
68     C to kg/m2/s by multiplying by rhoConstFresh.
69     C saltFluxFile :: File containing surface salt flux
70     C pLoadFile :: File containing pressure loading
71     C eddyPsiXFile :: File containing zonal Eddy streamfunction data
72     C eddyPsiYFile :: File containing meridional Eddy streamfunction data
73     C the_run_name :: string identifying the name of the model "run"
74     COMMON /PARM_C/
75     & buoyancyRelation, eosType,
76     & pickupSuff, mdsioLocalDir,
77     & tRefFile, sRefFile, rhoRefFile,
78     & delRFile, delRcFile,
79     & delXFile, delYFile, horizGridFile,
80     & bathyFile, topoFile,
81     & hydrogThetaFile, hydrogSaltFile, diffKrFile,
82     & zonalWindFile, meridWindFile, thetaClimFile,
83     & saltClimFile,
84     & EmPmRfile, saltFluxFile,
85     & surfQfile, surfQnetFile, surfQswFile,
86     & lambdaThetaFile, lambdaSaltFile,
87     & uVelInitFile, vVelInitFile, pSurfInitFile,
88     & dQdTfile, ploadFile,
89     & eddyPsiXFile, eddyPsiYFile,
90     & the_run_name
91     CHARACTER*(MAX_LEN_FNAM) buoyancyRelation
92     CHARACTER*(6) eosType
93     CHARACTER*(10) pickupSuff
94     CHARACTER*(MAX_LEN_FNAM) mdsioLocalDir
95     CHARACTER*(MAX_LEN_FNAM) tRefFile
96     CHARACTER*(MAX_LEN_FNAM) sRefFile
97     CHARACTER*(MAX_LEN_FNAM) rhoRefFile
98     CHARACTER*(MAX_LEN_FNAM) delRFile
99     CHARACTER*(MAX_LEN_FNAM) delRcFile
100     CHARACTER*(MAX_LEN_FNAM) delXFile
101     CHARACTER*(MAX_LEN_FNAM) delYFile
102     CHARACTER*(MAX_LEN_FNAM) horizGridFile
103     CHARACTER*(MAX_LEN_FNAM) bathyFile, topoFile
104     CHARACTER*(MAX_LEN_FNAM) hydrogThetaFile, hydrogSaltFile
105     CHARACTER*(MAX_LEN_FNAM) diffKrFile
106     CHARACTER*(MAX_LEN_FNAM) zonalWindFile
107     CHARACTER*(MAX_LEN_FNAM) meridWindFile
108     CHARACTER*(MAX_LEN_FNAM) thetaClimFile
109     CHARACTER*(MAX_LEN_FNAM) saltClimFile
110     CHARACTER*(MAX_LEN_FNAM) surfQfile
111     CHARACTER*(MAX_LEN_FNAM) surfQnetFile
112     CHARACTER*(MAX_LEN_FNAM) surfQswFile
113     CHARACTER*(MAX_LEN_FNAM) EmPmRfile
114     CHARACTER*(MAX_LEN_FNAM) saltFluxFile
115     CHARACTER*(MAX_LEN_FNAM) uVelInitFile
116     CHARACTER*(MAX_LEN_FNAM) vVelInitFile
117     CHARACTER*(MAX_LEN_FNAM) pSurfInitFile
118     CHARACTER*(MAX_LEN_FNAM) dQdTfile
119     CHARACTER*(MAX_LEN_FNAM) ploadFile
120     CHARACTER*(MAX_LEN_FNAM) eddyPsiXFile
121     CHARACTER*(MAX_LEN_FNAM) eddyPsiYFile
122     CHARACTER*(MAX_LEN_FNAM) lambdaThetaFile
123     CHARACTER*(MAX_LEN_FNAM) lambdaSaltFile
124     CHARACTER*(MAX_LEN_PREC/2) the_run_name
125    
126     C-- COMMON /PARM_I/ Integer valued parameters used by the model.
127     C cg2dMaxIters :: Maximum number of iterations in the
128     C two-dimensional con. grad solver.
129     C cg2dChkResFreq :: Frequency with which to check residual
130     C in con. grad solver.
131     C cg2dPreCondFreq :: Frequency for updating cg2d preconditioner
132     C (non-linear free-surf.)
133     C cg3dMaxIters :: Maximum number of iterations in the
134     C three-dimensional con. grad solver.
135     C cg3dChkResFreq :: Frequency with which to check residual
136     C in con. grad solver.
137     C nIter0 :: Start time-step number of for this run
138     C nTimeSteps :: Number of timesteps to execute
139     C writeStatePrec :: Precision used for writing model state.
140     C writeBinaryPrec :: Precision used for writing binary files
141     C readBinaryPrec :: Precision used for reading binary files
142     C nonlinFreeSurf :: option related to non-linear free surface
143     C =0 Linear free surface ; >0 Non-linear
144     C select_rStar :: option related to r* vertical coordinate
145     C =0 (default) use r coord. ; > 0 use r*
146     C selectAddFluid :: option to add mass source/sink of fluid in the interior
147     C (3-D generalisation of oceanic real-fresh water flux)
148     C =0 off ; =1 add fluid ; =-1 virtual flux (no mass added)
149     C momForcingOutAB :: =1: take momentum forcing contribution
150     C out of (=0: in) Adams-Bashforth time stepping.
151     C tracForcingOutAB :: =1: take tracer (Temp,Salt,pTracers) forcing contribution
152     C out of (=0: in) Adams-Bashforth time stepping.
153     C tempAdvScheme :: Temp. Horiz.Advection scheme selector
154     C tempVertAdvScheme :: Temp. Vert. Advection scheme selector
155     C saltAdvScheme :: Salt. Horiz.advection scheme selector
156     C saltVertAdvScheme :: Salt. Vert. Advection scheme selector
157     C selectKEscheme :: Kinetic Energy scheme selector (Vector Inv.)
158     C selectVortScheme :: Scheme selector for Vorticity term (Vector Inv.)
159     C monitorSelect :: select group of variables to monitor
160     C =1 : dynvars ; =2 : + vort ; =3 : + surface
161     C debugLevel :: debug level selector: higher -> more writing
162    
163     COMMON /PARM_I/
164     & cg2dMaxIters,
165     & cg2dChkResFreq, cg2dPreCondFreq,
166     & cg3dMaxIters,
167     & cg3dChkResFreq,
168     & nIter0, nTimeSteps, nEndIter,
169     & writeStatePrec,
170     & writeBinaryPrec, readBinaryPrec,
171     & nonlinFreeSurf, select_rStar,
172     & selectAddFluid,
173     & momForcingOutAB, tracForcingOutAB,
174     & tempAdvScheme, tempVertAdvScheme,
175     & saltAdvScheme, saltVertAdvScheme,
176     & selectKEscheme, selectVortScheme,
177     & monitorSelect, debugLevel
178     INTEGER cg2dMaxIters
179     INTEGER cg2dChkResFreq
180     INTEGER cg2dPreCondFreq
181     INTEGER cg3dMaxIters
182     INTEGER cg3dChkResFreq
183     INTEGER nIter0
184     INTEGER nTimeSteps
185     INTEGER nEndIter
186     INTEGER writeStatePrec
187     INTEGER writeBinaryPrec
188     INTEGER readBinaryPrec
189     INTEGER nonlinFreeSurf
190     INTEGER select_rStar
191     INTEGER selectAddFluid
192     INTEGER momForcingOutAB, tracForcingOutAB
193     INTEGER tempAdvScheme, tempVertAdvScheme
194     INTEGER saltAdvScheme, saltVertAdvScheme
195     INTEGER selectKEscheme
196     INTEGER selectVortScheme
197     INTEGER monitorSelect
198     INTEGER debugLevel
199    
200     C-- COMMON /PARM_L/ Logical valued parameters used by the model.
201     C- Coordinate + Grid params:
202     C fluidIsAir :: Set to indicate that the fluid major constituent
203     C is air
204     C fluidIsWater :: Set to indicate that the fluid major constituent
205     C is water
206     C usingPCoords :: Set to indicate that we are working in a pressure
207     C type coordinate (p or p*).
208     C usingZCoords :: Set to indicate that we are working in a height
209     C type coordinate (z or z*)
210     C useDynP_inEos_Zc :: use the dynamical pressure in EOS (with Z-coord.)
211     C this requires specific code for restart & exchange
212     C usingCartesianGrid :: If TRUE grid generation will be in a cartesian
213     C coordinate frame.
214     C usingSphericalPolarGrid :: If TRUE grid generation will be in a
215     C spherical polar frame.
216     C rotateGrid :: rotate grid coordinates to geographical coordinates
217     C according to Euler angles phiEuler, thetaEuler, psiEuler
218     C usingCurvilinearGrid :: If TRUE, use a curvilinear grid (to be provided)
219     C usingCylindricalGrid :: If TRUE grid generation will be Cylindrical
220     C deepAtmosphere :: deep model (drop the shallow-atmosphere approximation)
221     C setInterFDr :: set Interface depth (put cell-Center at the middle)
222     C setCenterDr :: set cell-Center depth (put Interface at the middle)
223     C- Momentum params:
224     C no_slip_sides :: Impose "no-slip" at lateral boundaries.
225     C no_slip_bottom :: Impose "no-slip" at bottom boundary.
226     C useFullLeith :: Set to true to use full Leith viscosity(may be unstable
227     C on irregular grids)
228     C useStrainTensionVisc:: Set to true to use Strain-Tension viscous terms
229     C useAreaViscLength :: Set to true to use old scaling for viscous lengths,
230     C e.g., L2=Raz. May be preferable for cube sphere.
231     C momViscosity :: Flag which turns momentum friction terms on and off.
232     C momAdvection :: Flag which turns advection of momentum on and off.
233     C momForcing :: Flag which turns external forcing of momentum on
234     C and off.
235     C momPressureForcing :: Flag which turns pressure term in momentum equation
236     C on and off.
237     C metricTerms :: Flag which turns metric terms on or off.
238     C useNHMTerms :: If TRUE use non-hydrostatic metric terms.
239     C useCoriolis :: Flag which turns the coriolis terms on and off.
240     C use3dCoriolis :: Turns the 3-D coriolis terms (in Omega.cos Phi) on - off
241     C useConstantF :: Coriolis parameter set to f0
242     C useBetaPlaneF :: Coriolis parameter set to f0 + beta.y
243     C useSphereF :: Coriolis parameter set to 2.omega.sin(phi)
244     C useCDscheme :: use CD-scheme to calculate Coriolis terms.
245     C vectorInvariantMomentum :: use Vector-Invariant form (mom_vecinv package)
246     C (default = F = use mom_fluxform package)
247     C useJamartWetPoints :: Use wet-point method for Coriolis (Jamart & Ozer 1986)
248     C useJamartMomAdv :: Use wet-point method for V.I. non-linear term
249     C upwindVorticity :: bias interpolation of vorticity in the Coriolis term
250     C highOrderVorticity :: use 3rd/4th order interp. of vorticity (V.I., advection)
251     C useAbsVorticity :: work with f+zeta in Coriolis terms
252     C upwindShear :: use 1rst order upwind interp. (V.I., vertical advection)
253     C momStepping :: Turns momentum equation time-stepping off
254     C- Temp. & Salt params:
255     C tempStepping :: Turns temperature equation time-stepping off
256     C saltStepping :: Turns salinity equation time-stepping off
257     C tempAdvection :: Flag which turns advection of temperature on and off.
258     C tempIsActiveTr :: Pot.Temp. is a dynamically active tracer
259     C tempForcing :: Flag which turns external forcing of temperature on
260     C and off.
261     C saltAdvection :: Flag which turns advection of salinity on and off.
262     C saltIsActiveTr :: Salinity is a dynamically active tracer
263     C saltForcing :: Flag which turns external forcing of salinity on
264     C and off.
265     C useRealFreshWaterFlux :: if True (=Natural BCS), treats P+R-E flux
266     C as a real Fresh Water (=> changes the Sea Level)
267     C if F, converts P+R-E to salt flux (no SL effect)
268     C- Time-stepping params:
269     C rigidLid :: Set to true to use rigid lid
270     C implicitFreeSurface :: Set to true to use implicit free surface
271     C exactConserv :: Set to true to conserve exactly the total Volume
272     C linFSConserveTr :: Set to true to correct source/sink of tracer
273     C at the surface due to Linear Free Surface
274     C uniformLin_PhiSurf :: Set to true to use a uniform Bo_surf in the
275     C linear relation Phi_surf = Bo_surf*eta
276     C quasiHydrostatic :: Using non-hydrostatic terms in hydrostatic algorithm
277     C nonHydrostatic :: Using non-hydrostatic algorithm
278     C use3Dsolver :: set to true to use 3-D pressure solver
279     C implicitIntGravWave :: treat Internal Gravity Wave implicitly
280     C staggerTimeStep :: enable a Stagger time stepping U,V (& W) then T,S
281     C implicitDiffusion :: Turns implicit vertical diffusion on
282     C implicitViscosity :: Turns implicit vertical viscosity on
283     C tempImplVertAdv :: Turns on implicit vertical advection for Temperature
284     C saltImplVertAdv :: Turns on implicit vertical advection for Salinity
285     C momImplVertAdv :: Turns on implicit vertical advection for Momentum
286     C multiDimAdvection :: Flag that enable multi-dimension advection
287     C useMultiDimAdvec :: True if multi-dim advection is used at least once
288     C momDissip_In_AB :: if False, put Dissipation tendency contribution
289     C out off Adams-Bashforth time stepping.
290     C doAB_onGtGs :: if the Adams-Bashforth time stepping is used, always
291     C apply AB on tracer tendencies (rather than on Tracer)
292     C- Other forcing params -
293     C balanceEmPmR :: substract global mean of EmPmR at every time step
294     C balanceQnet :: substract global mean of Qnet at every time step
295     C balancePrintMean:: print substracted global means to STDOUT
296     C doThetaClimRelax :: Set true if relaxation to temperature
297     C climatology is required.
298     C doSaltClimRelax :: Set true if relaxation to salinity
299     C climatology is required.
300     C allowFreezing :: Allows surface water to freeze and form ice
301     C useOldFreezing :: use the old version (before checkpoint52a_pre, 2003-11-12)
302     C periodicExternalForcing :: Set true if forcing is time-dependant
303     C- I/O parameters -
304     C globalFiles :: Selects between "global" and "tiled" files
305     C useSingleCpuIO :: On SGI platforms, option globalFiles is either
306     C slow (f77) or does not work (f90). When
307     C useSingleCpuIO is set, mdsio_writefield.F
308     C outputs from master mpi process only.
309     C pickupStrictlyMatch :: check and stop if pickup-file do not stricly match
310     C startFromPickupAB2 :: with AB-3 code, start from an AB-2 pickup
311     C usePickupBeforeC54 :: start from old-pickup files, generated with code from
312     C before checkpoint-54a, Jul 06, 2004.
313     C pickup_write_mdsio :: use mdsio to write pickups
314     C pickup_read_mdsio :: use mdsio to read pickups
315     C pickup_write_immed :: echo the pickup immediately (for conversion)
316     C writePickupAtEnd :: write pickup at the last timestep
317     C timeave_mdsio :: use mdsio for timeave output
318     C snapshot_mdsio :: use mdsio for "snapshot" (dumpfreq/diagfreq) output
319     C monitor_stdio :: use stdio for monitor output
320     C dumpInitAndLast :: dumps model state to files at Initial (nIter0)
321     C & Last iteration, in addition multiple of dumpFreq iter.
322    
323     COMMON /PARM_L/
324     & fluidIsAir, fluidIsWater,
325     & usingPCoords, usingZCoords, useDynP_inEos_Zc,
326     & usingCartesianGrid, usingSphericalPolarGrid, rotateGrid,
327     & usingCurvilinearGrid, usingCylindricalGrid,
328     & deepAtmosphere, setInterFDr, setCenterDr,
329     & no_slip_sides, no_slip_bottom,
330     & useFullLeith, useStrainTensionVisc, useAreaViscLength,
331     & momViscosity, momAdvection, momForcing,
332     & momPressureForcing, metricTerms, useNHMTerms,
333     & useCoriolis, use3dCoriolis,
334     & useConstantF, useBetaPlaneF, useSphereF,
335     & useCDscheme, vectorInvariantMomentum,
336     & useEnergyConservingCoriolis, useJamartWetPoints, useJamartMomAdv,
337     & upwindVorticity, highOrderVorticity,
338     & useAbsVorticity, upwindShear,
339     & momStepping, tempStepping, saltStepping,
340     & tempAdvection, tempIsActiveTr, tempForcing,
341     & saltAdvection, saltIsActiveTr, saltForcing,
342     & useRealFreshWaterFlux,
343     & rigidLid, implicitFreeSurface, exactConserv, linFSConserveTr,
344     & uniformLin_PhiSurf,
345     & quasiHydrostatic, nonHydrostatic,
346     & use3Dsolver, implicitIntGravWave, staggerTimeStep,
347     & implicitDiffusion, implicitViscosity,
348     & tempImplVertAdv, saltImplVertAdv, momImplVertAdv,
349     & multiDimAdvection, useMultiDimAdvec,
350     & momDissip_In_AB, doAB_onGtGs,
351     & balanceEmPmR, balanceQnet, balancePrintMean,
352     & doThetaClimRelax, doSaltClimRelax,
353     & allowFreezing, useOldFreezing,
354     & periodicExternalForcing,
355     & globalFiles, useSingleCpuIO,
356     & pickupStrictlyMatch, usePickupBeforeC54, startFromPickupAB2,
357     & pickup_read_mdsio, pickup_write_mdsio, pickup_write_immed,
358     & writePickupAtEnd,
359     & timeave_mdsio, snapshot_mdsio, monitor_stdio,
360     & outputTypesInclusive, dumpInitAndLast, debugMode,
361     & inAdMode, inAdTrue, inAdFalse, inAdExact
362    
363     LOGICAL fluidIsAir
364     LOGICAL fluidIsWater
365     LOGICAL usingPCoords
366     LOGICAL usingZCoords
367     LOGICAL useDynP_inEos_Zc
368     LOGICAL usingCartesianGrid
369     LOGICAL usingSphericalPolarGrid, rotateGrid
370     LOGICAL usingCylindricalGrid
371     LOGICAL usingCurvilinearGrid
372     LOGICAL deepAtmosphere
373     LOGICAL setInterFDr
374     LOGICAL setCenterDr
375     LOGICAL useNHMTerms
376     LOGICAL no_slip_sides
377     LOGICAL no_slip_bottom
378     LOGICAL momViscosity
379     LOGICAL momAdvection
380     LOGICAL momForcing
381     LOGICAL momPressureForcing
382     LOGICAL useCoriolis
383     LOGICAL vectorInvariantMomentum
384     LOGICAL tempAdvection
385     LOGICAL tempIsActiveTr
386     LOGICAL tempForcing
387     LOGICAL saltAdvection
388     LOGICAL saltIsActiveTr
389     LOGICAL saltForcing
390     LOGICAL useRealFreshWaterFlux
391     LOGICAL useFullLeith
392     LOGICAL useStrainTensionVisc
393     LOGICAL useAreaViscLength
394     LOGICAL rigidLid
395     LOGICAL implicitFreeSurface
396     LOGICAL exactConserv
397     LOGICAL linFSConserveTr
398     LOGICAL uniformLin_PhiSurf
399     LOGICAL quasiHydrostatic
400     LOGICAL nonHydrostatic
401     LOGICAL use3Dsolver
402     LOGICAL implicitIntGravWave
403     LOGICAL staggerTimeStep
404     LOGICAL momStepping
405     LOGICAL tempStepping
406     LOGICAL saltStepping
407     LOGICAL metricTerms
408     LOGICAL useConstantF
409     LOGICAL useBetaPlaneF
410     LOGICAL useSphereF
411     LOGICAL use3dCoriolis
412     LOGICAL useCDscheme
413     LOGICAL useEnergyConservingCoriolis
414     LOGICAL useJamartWetPoints
415     LOGICAL useJamartMomAdv
416     LOGICAL upwindVorticity
417     LOGICAL highOrderVorticity
418     LOGICAL useAbsVorticity
419     LOGICAL upwindShear
420     LOGICAL implicitDiffusion
421     LOGICAL implicitViscosity
422     LOGICAL tempImplVertAdv
423     LOGICAL saltImplVertAdv
424     LOGICAL momImplVertAdv
425     LOGICAL multiDimAdvection
426     LOGICAL useMultiDimAdvec
427     LOGICAL momDissip_In_AB
428     LOGICAL doAB_onGtGs
429     LOGICAL balanceEmPmR
430     LOGICAL balanceQnet
431     LOGICAL balancePrintMean
432     LOGICAL doThetaClimRelax
433     LOGICAL doSaltClimRelax
434     LOGICAL allowFreezing
435     LOGICAL useOldFreezing
436     LOGICAL periodicExternalForcing
437     LOGICAL globalFiles
438     LOGICAL useSingleCpuIO
439     LOGICAL pickupStrictlyMatch
440     LOGICAL usePickupBeforeC54
441     LOGICAL startFromPickupAB2
442     LOGICAL pickup_read_mdsio, pickup_write_mdsio
443     LOGICAL pickup_write_immed, writePickupAtEnd
444     LOGICAL timeave_mdsio, snapshot_mdsio, monitor_stdio
445     LOGICAL outputTypesInclusive
446     LOGICAL dumpInitAndLast
447     LOGICAL debugMode
448     LOGICAL inAdMode, inAdTrue, inAdFalse, inAdExact
449    
450     C-- COMMON /PARM_R/ "Real" valued parameters used by the model.
451     C cg2dTargetResidual
452     C :: Target residual for cg2d solver; no unit (RHS normalisation)
453     C cg2dTargetResWunit
454     C :: Target residual for cg2d solver; W unit (No RHS normalisation)
455     C cg3dTargetResidual
456     C :: Target residual for cg3d solver.
457     C cg2dpcOffDFac :: Averaging weight for preconditioner off-diagonal.
458     C Note. 20th May 1998
459     C I made a weird discovery! In the model paper we argue
460     C for the form of the preconditioner used here ( see
461     C A Finite-volume, Incompressible Navier-Stokes Model
462     C ...., Marshall et. al ). The algebra gives a simple
463     C 0.5 factor for the averaging of ac and aCw to get a
464     C symmettric pre-conditioner. By using a factor of 0.51
465     C i.e. scaling the off-diagonal terms in the
466     C preconditioner down slightly I managed to get the
467     C number of iterations for convergence in a test case to
468     C drop form 192 -> 134! Need to investigate this further!
469     C For now I have introduced a parameter cg2dpcOffDFac which
470     C defaults to 0.51 but can be set at runtime.
471     C delR :: Vertical grid spacing ( units of r ).
472     C delRc :: Vertical grid spacing between cell centers (r unit).
473     C delX :: Separation between cell faces (m) or (deg), depending
474     C delY on input flags.
475     C gravity :: Accel. due to gravity ( m/s^2 )
476     C recip_gravity and its inverse
477     C gBaro :: Accel. due to gravity used in barotropic equation ( m/s^2 )
478     C rhoNil :: Reference density for the linear equation of state
479     C rhoConst :: Vertically constant reference density
480     C rhoFacC :: normalized (by rhoConst) reference density at cell-Center
481     C rhoFacF :: normalized (by rhoConst) reference density at cell-interFace
482     C rhoConstFresh :: Constant reference density for fresh water (rain)
483     C rho1Ref :: reference vertical profile for density
484     C tRef :: reference vertical profile for potential temperature
485     C sRef :: reference vertical profile for salinity/specific humidity
486     C phiRef :: reference potential (pressure/rho, geopotential) profile
487     C dBdrRef :: vertical gradient of reference boyancy [(m/s/r)^2)]:
488     C :: z-coord: = N^2_ref = Brunt-Vaissala frequency [s^-2]
489     C :: p-coord: = -(d.alpha/dp)_ref [(m^2.s/kg)^2]
490     C rVel2wUnit :: units conversion factor (Non-Hydrostatic code),
491     C :: from r-coordinate vertical velocity to vertical velocity [m/s].
492     C :: z-coord: = 1 ; p-coord: wSpeed [m/s] = rVel [Pa/s] * rVel2wUnit
493     C wUnit2rVel :: units conversion factor (Non-Hydrostatic code),
494     C :: from vertical velocity [m/s] to r-coordinate vertical velocity.
495     C :: z-coord: = 1 ; p-coord: rVel [Pa/s] = wSpeed [m/s] * wUnit2rVel
496     C mass2rUnit :: units conversion factor (surface forcing),
497     C :: from mass per unit area [kg/m2] to vertical r-coordinate unit.
498     C :: z-coord: = 1/rhoConst ( [kg/m2] / rho = [m] ) ;
499     C :: p-coord: = gravity ( [kg/m2] * g = [Pa] ) ;
500     C rUnit2mass :: units conversion factor (surface forcing),
501     C :: from vertical r-coordinate unit to mass per unit area [kg/m2].
502     C :: z-coord: = rhoConst ( [m] * rho = [kg/m2] ) ;
503     C :: p-coord: = 1/gravity ( [Pa] / g = [kg/m2] ) ;
504     C xgOrigin :: Origin of the X-axis (Cartesian Grid) / Longitude of Western
505     C :: most cell face (Lat-Lon grid) (Note: this is an "inert"
506     C :: parameter but it makes geographical references simple.)
507     C ygOrigin :: Origin of the Y-axis (Cartesian Grid) / Latitude of Southern
508     C :: most face (Lat-Lon grid).
509     C rSphere :: Radius of sphere for a spherical polar grid ( m ).
510     C recip_rSphere :: Reciprocal radius of sphere ( m ).
511     C f0 :: Reference coriolis parameter ( 1/s )
512     C ( Southern edge f for beta plane )
513     C beta :: df/dy ( s^-1.m^-1 )
514     C omega :: Angular velocity ( rad/s )
515     C rotationPeriod :: Rotation period (s) (= 2.pi/omega)
516     C viscAr :: Eddy viscosity coeff. for mixing of
517     C momentum vertically ( units of r^2/s )
518     C viscAh :: Eddy viscosity coeff. for mixing of
519     C momentum laterally ( m^2/s )
520     C viscAhW :: Eddy viscosity coeff. for mixing of vertical
521     C momentum laterally, no effect for hydrostatic
522     C model, defaults to viscAh if unset ( m^2/s )
523     C Not used if variable horiz. viscosity is used.
524     C viscA4 :: Biharmonic viscosity coeff. for mixing of
525     C momentum laterally ( m^4/s )
526     C viscA4W :: Biharmonic viscosity coeff. for mixing of vertical
527     C momentum laterally, no effect for hydrostatic
528     C model, defaults to viscA4 if unset ( m^2/s )
529     C Not used if variable horiz. viscosity is used.
530     C viscAhD :: Eddy viscosity coeff. for mixing of momentum laterally
531     C (act on Divergence part) ( m^2/s )
532     C viscAhZ :: Eddy viscosity coeff. for mixing of momentum laterally
533     C (act on Vorticity part) ( m^2/s )
534     C viscA4D :: Biharmonic viscosity coeff. for mixing of momentum laterally
535     C (act on Divergence part) ( m^4/s )
536     C viscA4Z :: Biharmonic viscosity coeff. for mixing of momentum laterally
537     C (act on Vorticity part) ( m^4/s )
538     C viscC2leith :: Leith non-dimensional viscosity factor (grad(vort))
539     C viscC2leithD :: Modified Leith non-dimensional visc. factor (grad(div))
540     C viscC4leith :: Leith non-dimensional viscosity factor (grad(vort))
541     C viscC4leithD :: Modified Leith non-dimensional viscosity factor (grad(div))
542     C viscC2smag :: Smagorinsky non-dimensional viscosity factor (harmonic)
543     C viscC4smag :: Smagorinsky non-dimensional viscosity factor (biharmonic)
544     C viscAhMax :: Maximum eddy viscosity coeff. for mixing of
545     C momentum laterally ( m^2/s )
546     C viscAhReMax :: Maximum gridscale Reynolds number for eddy viscosity
547     C coeff. for mixing of momentum laterally (non-dim)
548     C viscAhGrid :: non-dimensional grid-size dependent viscosity
549     C viscAhGridMax:: maximum and minimum harmonic viscosity coefficients ...
550     C viscAhGridMin:: in terms of non-dimensional grid-size dependent visc.
551     C viscA4Max :: Maximum biharmonic viscosity coeff. for mixing of
552     C momentum laterally ( m^4/s )
553     C viscA4ReMax :: Maximum Gridscale Reynolds number for
554     C biharmonic viscosity coeff. momentum laterally (non-dim)
555     C viscA4Grid :: non-dimensional grid-size dependent bi-harmonic viscosity
556     C viscA4GridMax:: maximum and minimum biharmonic viscosity coefficients ...
557     C viscA4GridMin:: in terms of non-dimensional grid-size dependent viscosity
558     C diffKhT :: Laplacian diffusion coeff. for mixing of
559     C heat laterally ( m^2/s )
560     C diffKrNrT :: vertical profile of Laplacian diffusion coeff.
561     C for mixing of heat vertically ( units of r^2/s )
562     C diffK4T :: Biharmonic diffusion coeff. for mixing of
563     C heat laterally ( m^4/s )
564     C diffKhS :: Laplacian diffusion coeff. for mixing of
565     C salt laterally ( m^2/s )
566     C diffKrNrS :: vertical profile of Laplacian diffusion coeff.
567     C for mixing of salt vertically ( units of r^2/s ),
568     C diffK4S :: Biharmonic diffusion coeff. for mixing of
569     C salt laterally ( m^4/s )
570     C diffKrBL79surf :: T/S surface diffusivity (m^2/s) Bryan and Lewis, 1979
571     C diffKrBL79deep :: T/S deep diffusivity (m^2/s) Bryan and Lewis, 1979
572     C diffKrBL79scl :: depth scale for arctan fn (m) Bryan and Lewis, 1979
573     C diffKrBL79Ho :: depth offset for arctan fn (m) Bryan and Lewis, 1979
574     C BL79LatVary :: polarwise of this latitude diffKrBL79 is applied with
575     C gradual transition to diffKrBLEQ towards Equator
576     C diffKrBLEQsurf :: same as diffKrBL79surf but at Equator
577     C diffKrBLEQdeep :: same as diffKrBL79deep but at Equator
578     C diffKrBLEQscl :: same as diffKrBL79scl but at Equator
579     C diffKrBLEQHo :: same as diffKrBL79Ho but at Equator
580     C deltaT :: Default timestep ( s )
581     C deltaTClock :: Timestep used as model "clock". This determines the
582     C IO frequencies and is used in tagging output. It can
583     C be totally different to the dynamical time. Typically
584     C it will be the deep-water timestep for accelerated runs.
585     C Frequency of checkpointing and dumping of the model state
586     C are referenced to this clock. ( s )
587     C deltaTMom :: Timestep for momemtum equations ( s )
588     C dTtracerLev :: Timestep for tracer equations ( s ), function of level k
589     C deltaTfreesurf :: Timestep for free-surface equation ( s )
590     C freesurfFac :: Parameter to turn implicit free surface term on or off
591     C freesurfac = 1. uses implicit free surface
592     C freesurfac = 0. uses rigid lid
593     C abEps :: Adams-Bashforth-2 stabilizing weight
594     C alph_AB :: Adams-Bashforth-3 primary factor
595     C beta_AB :: Adams-Bashforth-3 secondary factor
596     C implicSurfPress :: parameter of the Crank-Nickelson time stepping :
597     C Implicit part of Surface Pressure Gradient ( 0-1 )
598     C implicDiv2Dflow :: parameter of the Crank-Nickelson time stepping :
599     C Implicit part of barotropic flow Divergence ( 0-1 )
600     C hFacMin :: Minimum fraction size of a cell (affects hFacC etc...)
601     C hFacMinDz :: Minimum dimesional size of a cell (affects hFacC etc..., m)
602     C hFacMinDp :: Minimum dimesional size of a cell (affects hFacC etc..., Pa)
603     C hFacMinDr :: Minimum dimesional size of a cell (affects hFacC etc..., units of r)
604     C hFacInf :: Threshold (inf and sup) for fraction size of surface cell
605     C hFacSup that control vanishing and creating levels
606     C tauCD :: CD scheme coupling timescale ( 1/s )
607     C rCD :: CD scheme normalised coupling parameter ( 0-1 )
608     C baseTime :: model base time (time origin) = time @ iteration zero
609     C startTime :: Starting time for this integration ( s ).
610     C endTime :: Ending time for this integration ( s ).
611     C chkPtFreq :: Frequency of rolling check pointing ( s ).
612     C pChkPtFreq :: Frequency of permanent check pointing ( s ).
613     C dumpFreq :: Frequency with which model state is written to
614     C post-processing files ( s ).
615     C diagFreq :: Frequency with which model writes diagnostic output
616     C of intermediate quantities.
617     C afFacMom :: Advection of momentum term tracer parameter
618     C vfFacMom :: Momentum viscosity tracer parameter
619     C pfFacMom :: Momentum pressure forcing tracer parameter
620     C cfFacMom :: Coriolis term tracer parameter
621     C foFacMom :: Momentum forcing tracer parameter
622     C mtFacMom :: Metric terms tracer parameter
623     C cosPower :: Power of cosine of latitude to multiply viscosity
624     C cAdjFreq :: Frequency of convective adjustment
625     C
626     C taveFreq :: Frequency with which time-averaged model state
627     C is written to post-processing files ( s ).
628     C tave_lastIter :: (for state variable only) fraction of the last time
629     C step (of each taveFreq period) put in the time average.
630     C (fraction for 1rst iter = 1 - tave_lastIter)
631     C tauThetaClimRelax :: Relaxation to climatology time scale ( s ).
632     C tauSaltClimRelax :: Relaxation to climatology time scale ( s ).
633     C latBandClimRelax :: latitude band where Relaxation to Clim. is applied,
634     C i.e. where |yC| <= latBandClimRelax
635     C externForcingPeriod :: Is the period of which forcing varies (eg. 1 month)
636     C externForcingCycle :: Is the repeat time of the forcing (eg. 1 year)
637     C (note: externForcingCycle must be an integer
638     C number times externForcingPeriod)
639     C convertFW2Salt :: salinity, used to convert Fresh-Water Flux to Salt Flux
640     C (use model surface (local) value if set to -1)
641     C temp_EvPrRn :: temperature of Rain & Evap.
642     C salt_EvPrRn :: salinity of Rain & Evap.
643     C (notes: a) tracer content of Rain/Evap only used if both
644     C NonLin_FrSurf & useRealFreshWater are set.
645     C b) use model surface (local) value if set to UNSET_RL)
646     C hMixCriteria:: criteria for mixed-layer diagnostic
647     C dRhoSmall :: parameter for mixed-layer diagnostic
648     C hMixSmooth :: Smoothing parameter for mixed-layer diag (default=0=no smoothing)
649     C ivdc_kappa :: implicit vertical diffusivity for convection [m^2/s]
650     C Ro_SeaLevel :: standard position of Sea-Level in "R" coordinate, used as
651     C starting value (k=1) for vertical coordinate (rf(1)=Ro_SeaLevel)
652     C sideDragFactor :: side-drag scaling factor (used only if no_slip_sides)
653     C (default=2: full drag ; =1: gives half-slip BC)
654     C bottomDragLinear :: Linear bottom-drag coefficient (units of [r]/s)
655     C bottomDragQuadratic :: Quadratic bottom-drag coefficient (units of [r]/m)
656     C (if using zcoordinate, units becomes linear: m/s, quadratic: [-])
657     C smoothAbsFuncRange :: 1/2 of interval around zero, for which FORTRAN ABS
658     C is to be replace by a smoother function
659     C (affects myabs, mymin, mymax)
660     C nh_Am2 :: scales the non-hydrostatic terms and changes internal scales
661     C (i.e. allows convection at different Rayleigh numbers)
662     C phiEuler :: Euler angle, rotation about original z-axis
663     C thetaEuler :: Euler angle, rotation about new x-axis
664     C psiEuler :: Euler angle, rotation about new z-axis
665     COMMON /PARM_R/ cg2dTargetResidual, cg2dTargetResWunit,
666     & cg2dpcOffDFac, cg3dTargetResidual,
667     & delR, delRc, delX, delY,
668     & deltaT, deltaTmom, dTtracerLev, deltaTfreesurf, deltaTClock,
669     & abEps, alph_AB, beta_AB,
670     & xgOrigin, ygOrigin, rSphere, recip_RSphere, f0, beta,
671     & viscAh, viscAhW, viscAhMax,
672     & viscAhGrid, viscAhGridMax, viscAhGridMin,
673     & viscC2leith, viscC2leithD,
674     & viscC2smag, viscC4smag,
675     & viscAhD, viscAhZ, viscA4D, viscA4Z,
676     & viscA4, viscA4W, viscA4Max,
677     & viscA4Grid, viscA4GridMax, viscA4GridMin,
678     & viscAhReMax, viscA4ReMax,
679     & viscC4leith, viscC4leithD, viscAr,
680     & diffKhT, diffK4T, diffKrNrT,
681     & diffKhS, diffK4S, diffKrNrS,
682     & diffKrBL79surf, diffKrBL79deep, diffKrBL79scl, diffKrBL79Ho,
683     & BL79LatVary,
684     & diffKrBLEQsurf, diffKrBLEQdeep, diffKrBLEQscl, diffKrBLEQHo,
685     & delT, tauCD, rCD, freeSurfFac, implicSurfPress, implicDiv2Dflow,
686     & hFacMin, hFacMinDz, hFacInf, hFacSup,
687     & gravity, recip_gravity, gBaro,
688     & rhonil, recip_rhonil, rhoConst, recip_rhoConst,
689     & rhoFacC, recip_rhoFacC, rhoFacF, recip_rhoFacF,
690     & rhoConstFresh, rho1Ref, tRef, sRef, phiRef, dBdrRef,
691     & rVel2wUnit, wUnit2rVel, mass2rUnit, rUnit2mass,
692     & baseTime, startTime, endTime,
693     & chkPtFreq, pChkPtFreq, dumpFreq, adjDumpFreq,
694     & diagFreq, taveFreq, tave_lastIter, monitorFreq, adjMonitorFreq,
695     & afFacMom, vfFacMom, pfFacMom, cfFacMom, foFacMom, mtFacMom,
696     & cosPower, cAdjFreq, omega, rotationPeriod,
697     & tauThetaClimRelax, tauSaltClimRelax, latBandClimRelax,
698     & externForcingCycle, externForcingPeriod,
699     & convertFW2Salt, temp_EvPrRn, salt_EvPrRn,
700     & hFacMinDr, hFacMinDp,
701     & ivdc_kappa, hMixCriteria, dRhoSmall, hMixSmooth, Ro_SeaLevel,
702     & sideDragFactor, bottomDragLinear, bottomDragQuadratic, nh_Am2,
703     & smoothAbsFuncRange,
704     & tCylIn, tCylOut,
705     & phiEuler, thetaEuler, psiEuler
706    
707     _RL cg2dTargetResidual
708     _RL cg2dTargetResWunit
709     _RL cg3dTargetResidual
710     _RL cg2dpcOffDFac
711     _RL delR(Nr)
712     _RL delRc(Nr+1)
713     _RL delX(Nx)
714     _RL delY(Ny)
715     _RL deltaT
716     _RL deltaTClock
717     _RL deltaTmom
718     _RL dTtracerLev(Nr)
719     _RL deltaTfreesurf
720     _RL abEps, alph_AB, beta_AB
721     _RL xgOrigin
722     _RL ygOrigin
723     _RL rSphere
724     _RL recip_rSphere
725     _RL f0
726     _RL freeSurfFac
727     _RL implicSurfPress
728     _RL implicDiv2Dflow
729     _RL hFacMin
730     _RL hFacMinDz
731     _RL hFacMinDp
732     _RL hFacMinDr
733     _RL hFacInf
734     _RL hFacSup
735     _RL beta
736     _RL viscAr
737     _RL viscAh
738     _RL viscAhW
739     _RL viscAhD
740     _RL viscAhZ
741     _RL viscAhMax
742     _RL viscAhReMax
743     _RL viscAhGrid, viscAhGridMax, viscAhGridMin
744     _RL viscC2leith
745     _RL viscC2leithD
746     _RL viscC2smag
747     _RL viscA4
748     _RL viscA4W
749     _RL viscA4D
750     _RL viscA4Z
751     _RL viscA4Max
752     _RL viscA4ReMax
753     _RL viscA4Grid, viscA4GridMax, viscA4GridMin
754     _RL viscC4leith
755     _RL viscC4leithD
756     _RL viscC4smag
757     _RL diffKhT
758     _RL diffKrNrT(Nr)
759     _RL diffK4T
760     _RL diffKhS
761     _RL diffKrNrS(Nr)
762     _RL diffK4S
763     _RL diffKrBL79surf
764     _RL diffKrBL79deep
765     _RL diffKrBL79scl
766     _RL diffKrBL79Ho
767     _RL BL79LatVary
768     _RL diffKrBLEQsurf
769     _RL diffKrBLEQdeep
770     _RL diffKrBLEQscl
771     _RL diffKrBLEQHo
772     _RL delt
773     _RL tauCD
774     _RL rCD
775     _RL gravity
776     _RL recip_gravity
777     _RL gBaro
778     _RL rhonil, recip_rhonil
779     _RL rhoConst, recip_rhoConst
780     _RL rhoFacC(Nr), recip_rhoFacC(Nr)
781     _RL rhoFacF(Nr+1), recip_rhoFacF(Nr+1)
782     _RL rhoConstFresh
783     _RL rho1Ref(Nr)
784     _RL tRef(Nr)
785     _RL sRef(Nr)
786     _RL phiRef(2*Nr+1)
787     _RL dBdrRef(Nr)
788     _RL rVel2wUnit(Nr+1), wUnit2rVel(Nr+1)
789     _RL mass2rUnit, rUnit2mass
790     _RL baseTime
791     _RL startTime
792     _RL endTime
793     _RL chkPtFreq
794     _RL pChkPtFreq
795     _RL dumpFreq
796     _RL adjDumpFreq
797     _RL diagFreq
798     _RL taveFreq
799     _RL tave_lastIter
800     _RL monitorFreq
801     _RL adjMonitorFreq
802     _RL afFacMom
803     _RL vfFacMom
804     _RL pfFacMom
805     _RL cfFacMom
806     _RL foFacMom
807     _RL mtFacMom
808     _RL cosPower
809     _RL cAdjFreq
810     _RL omega
811     _RL rotationPeriod
812     _RL tauThetaClimRelax
813     _RL tauSaltClimRelax
814     _RL latBandClimRelax
815     _RL externForcingCycle
816     _RL externForcingPeriod
817     _RL convertFW2Salt
818     _RL temp_EvPrRn
819     _RL salt_EvPrRn
820     _RL ivdc_kappa
821     _RL hMixCriteria
822     _RL dRhoSmall
823     _RL hMixSmooth
824     _RL Ro_SeaLevel
825     _RL sideDragFactor
826     _RL bottomDragLinear
827     _RL bottomDragQuadratic
828     _RL smoothAbsFuncRange
829     _RL nh_Am2
830     _RL tCylIn
831     _RL tCylOut
832     _RL phiEuler, thetaEuler, psiEuler
833    
834     C-- COMMON /PARM_A/ Thermodynamics constants ?
835     COMMON /PARM_A/ HeatCapacity_Cp,recip_Cp
836     _RL HeatCapacity_Cp
837     _RL recip_Cp
838    
839     C-- COMMON /PARM_ATM/ Atmospheric physical parameters (Ideal Gas EOS, ...)
840     C celsius2K :: convert centigrade (Celsius) degree to Kelvin
841     C atm_Po :: standard reference pressure
842     C atm_Cp :: specific heat (Cp) of the (dry) air at constant pressure
843     C atm_Rd :: gas constant for dry air
844     C atm_kappa :: kappa = R/Cp (R: constant of Ideal Gas EOS)
845     C atm_Rq :: water vapour specific volume anomaly relative to dry air
846     C (e.g. typical value = (29/18 -1) 10^-3 with q [g/kg])
847     C integr_GeoPot :: option to select the way we integrate the geopotential
848     C (still a subject of discussions ...)
849     C selectFindRoSurf :: select the way surf. ref. pressure (=Ro_surf) is
850     C derived from the orography. Implemented: 0,1 (see INI_P_GROUND)
851     COMMON /PARM_ATM/
852     & celsius2K,
853     & atm_Cp, atm_Rd, atm_kappa, atm_Rq, atm_Po,
854     & integr_GeoPot, selectFindRoSurf
855     _RL celsius2K
856     _RL atm_Po, atm_Cp, atm_Rd, atm_kappa, atm_Rq
857     INTEGER integr_GeoPot, selectFindRoSurf
858    
859     C Logical flags for selecting packages
860     LOGICAL useGAD
861     LOGICAL useOBCS
862     LOGICAL useSHAP_FILT
863     LOGICAL useZONAL_FILT
864     LOGICAL useOPPS
865     LOGICAL usePP81
866     LOGICAL useMY82
867     LOGICAL useGGL90
868     LOGICAL useKPP
869     LOGICAL useGMRedi
870     LOGICAL useDOWN_SLOPE
871     LOGICAL useCAL
872     LOGICAL useEXF
873     LOGICAL useBulkForce
874     LOGICAL useEBM
875     LOGICAL useCheapAML
876     LOGICAL useGrdchk
877     LOGICAL useECCO
878     LOGICAL useSBO
879     LOGICAL useFLT
880     LOGICAL usePTRACERS
881     LOGICAL useGCHEM
882     LOGICAL useRBCS
883     LOGICAL useOffLine
884     LOGICAL useMATRIX
885     LOGICAL useSEAICE
886     LOGICAL useSALT_PLUME
887     LOGICAL useShelfIce
888     LOGICAL useThSIce
889     LOGICAL useATM2d
890     LOGICAL useAIM
891     LOGICAL useLand
892     LOGICAL useFizhi
893     LOGICAL useGridAlt
894     LOGICAL useDiagnostics
895     LOGICAL useREGRID
896     LOGICAL useMNC
897     LOGICAL useRunClock
898     LOGICAL useEMBED_FILES
899     LOGICAL useMYPACKAGE
900     C-- added by RPA
901     LOGICAL useLayers
902     COMMON /PARM_PACKAGES/
903     & useGAD, useOBCS, useSHAP_FILT, useZONAL_FILT,
904     & useOPPS, usePP81, useMY82, useGGL90, useKPP,
905     & useGMRedi, useDOWN_SLOPE,
906     & useCAL, useEXF, useBulkForce, useEBM, useCheapAML,
907     & useGrdchk, useECCO, useSBO, useFLT,
908     & usePTRACERS, useGCHEM, useRBCS, useOffLine, useMATRIX,
909     & useSEAICE, useSALT_PLUME, useShelfIce, useThSIce,
910     & useATM2D, useAIM, useLand, useFizhi, useGridAlt,
911     & useDiagnostics, useREGRID, useMNC,
912     & useRunClock, useEMBED_FILES,
913     & useMYPACKAGE,
914     C-- added by RPA
915     & useLayers
916     CEH3 ;;; Local Variables: ***
917     CEH3 ;;; mode:fortran ***
918     CEH3 ;;; End: ***

  ViewVC Help
Powered by ViewVC 1.1.22