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

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

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

revision 1.79 by adcroft, Thu Nov 7 21:51:15 2002 UTC revision 1.119 by jmc, Fri Jul 9 22:31:16 2004 UTC
# Line 73  C     pLoadFile       :: File containing Line 73  C     pLoadFile       :: File containing
73  C     buoyancyRelation :: Flag used to indicate which relation to use to  C     buoyancyRelation :: Flag used to indicate which relation to use to
74  C                        get buoyancy.  C                        get buoyancy.
75  C     eosType         :: choose the equation of state:  C     eosType         :: choose the equation of state:
76  C                        LINEAR, POLY3, UNESCO, JMD95Z, JMD95P  C                        LINEAR, POLY3, UNESCO, JMD95Z, JMD95P, MDJWF, IDEALGAS
77        COMMON /PARM_C/ checkPtSuff,        COMMON /PARM_C/ checkPtSuff,
78       &                bathyFile, topoFile,       &                bathyFile, topoFile,
79       &                hydrogThetaFile, hydrogSaltFile,       &                hydrogThetaFile, hydrogSaltFile,
# Line 82  C                        LINEAR, POLY3, Line 82  C                        LINEAR, POLY3,
82       &                EmPmRfile, surfQfile, surfQswfile,       &                EmPmRfile, surfQfile, surfQswfile,
83       &                uVelInitFile, vVelInitFile, pSurfInitFile,       &                uVelInitFile, vVelInitFile, pSurfInitFile,
84       &                dQdTfile, ploadFile,       &                dQdTfile, ploadFile,
85       &                eosType       &                eosType, pickupSuff,
86         &                mdsioLocalDir
87        CHARACTER*(5) checkPtSuff(maxNoChkptLev)        CHARACTER*(5) checkPtSuff(maxNoChkptLev)
88        CHARACTER*(MAX_LEN_FNAM) bathyFile, topoFile        CHARACTER*(MAX_LEN_FNAM) bathyFile, topoFile
89        CHARACTER*(MAX_LEN_FNAM) hydrogThetaFile        CHARACTER*(MAX_LEN_FNAM) hydrogThetaFile
# Line 100  C                        LINEAR, POLY3, Line 101  C                        LINEAR, POLY3,
101        CHARACTER*(MAX_LEN_FNAM) pSurfInitFile        CHARACTER*(MAX_LEN_FNAM) pSurfInitFile
102        CHARACTER*(MAX_LEN_FNAM) dQdTfile        CHARACTER*(MAX_LEN_FNAM) dQdTfile
103        CHARACTER*(MAX_LEN_FNAM) ploadFile        CHARACTER*(MAX_LEN_FNAM) ploadFile
104          CHARACTER*(MAX_LEN_FNAM) mdsioLocalDir
105        CHARACTER*(6) eosType        CHARACTER*(6) eosType
106          CHARACTER*(10) pickupSuff
107    
108  C--   COMMON /PARM_I/ Integer valued parameters used by the model.  C--   COMMON /PARM_I/ Integer valued parameters used by the model.
109  C     cg2dMaxIters        :: Maximum number of iterations in the  C     cg2dMaxIters        :: Maximum number of iterations in the
110  C                           two-dimensional con. grad solver.  C                           two-dimensional con. grad solver.
111  C     cg2dChkResFreq      :: Frequency with which to check residual  C     cg2dChkResFreq      :: Frequency with which to check residual
112  C                           in con. grad solver.  C                           in con. grad solver.
113    C     cg2dPreCondFreq     :: Frequency for updating cg2d preconditioner
114    C                            (non-linear free-surf.)
115  C     cg3dMaxIters        :: Maximum number of iterations in the  C     cg3dMaxIters        :: Maximum number of iterations in the
116  C                           three-dimensional con. grad solver.  C                           three-dimensional con. grad solver.
117  C     cg3dChkResFreq      :: Frequency with which to check residual  C     cg3dChkResFreq      :: Frequency with which to check residual
# Line 121  C     readBinaryPrec      :: Precision u Line 126  C     readBinaryPrec      :: Precision u
126  C     nCheckLev           :: Holds current checkpoint level  C     nCheckLev           :: Holds current checkpoint level
127  C     nonlinFreeSurf      :: option related to non-linear free surface  C     nonlinFreeSurf      :: option related to non-linear free surface
128  C                           =0 Linear free surface ; >0 Non-linear  C                           =0 Linear free surface ; >0 Non-linear
129    C     select_rStar        :: option related to r* vertical coordinate
130    C                           =0 (default) use r coord. ; > 0 use r*
131    C     tempAdvScheme       :: Temp. Horiz.Advection scheme selector
132    C     tempVertAdvScheme   :: Temp. Vert. Advection scheme selector
133    C     saltAdvScheme       :: Salt. Horiz.advection scheme selector
134    C     saltVertAdvScheme   :: Salt. Vert. Advection scheme selector
135    C     debugLevel          :: debug level selector: higher -> more writing
136    
137        COMMON /PARM_I/        COMMON /PARM_I/
138       &        cg2dMaxIters,       &        cg2dMaxIters,
139       &        cg2dChkResFreq,       &        cg2dChkResFreq, cg2dPreCondFreq,
140       &        cg3dMaxIters,       &        cg3dMaxIters,
141       &        cg3dChkResFreq,       &        cg3dChkResFreq,
142       &        nIter0, nTimeSteps, nEndIter,       &        nIter0, nTimeSteps, nEndIter,
143       &        numStepsPerPickup,       &        numStepsPerPickup,
144       &        writeStatePrec, nCheckLev,       &        writeStatePrec, nCheckLev,
145       &        writeBinaryPrec, readBinaryPrec,       &        writeBinaryPrec, readBinaryPrec,
146       &        nonlinFreeSurf,       &        nonlinFreeSurf, select_rStar,
147       &        tempAdvScheme, saltAdvScheme, tracerAdvScheme       &        tempAdvScheme, tempVertAdvScheme,
148         &        saltAdvScheme, saltVertAdvScheme,
149         &        tracerAdvScheme,
150         &        debugLevel
151        INTEGER cg2dMaxIters        INTEGER cg2dMaxIters
152        INTEGER cg2dChkResFreq        INTEGER cg2dChkResFreq
153          INTEGER cg2dPreCondFreq
154        INTEGER cg3dMaxIters        INTEGER cg3dMaxIters
155        INTEGER cg3dChkResFreq        INTEGER cg3dChkResFreq
156        INTEGER nIter0        INTEGER nIter0
# Line 146  C                           =0 Linear fr Line 162  C                           =0 Linear fr
162        INTEGER readBinaryPrec        INTEGER readBinaryPrec
163        INTEGER nCheckLev        INTEGER nCheckLev
164        INTEGER nonlinFreeSurf        INTEGER nonlinFreeSurf
165        INTEGER tempAdvScheme        INTEGER select_rStar
166        INTEGER saltAdvScheme        INTEGER tempAdvScheme, tempVertAdvScheme
167          INTEGER saltAdvScheme, saltVertAdvScheme
168        INTEGER tracerAdvScheme        INTEGER tracerAdvScheme
169          INTEGER debugLevel
170    
171    C
172          INTEGER debLevZero
173          PARAMETER(debLevZero=0)
174          INTEGER debLevA
175          PARAMETER(debLevA=1)
176          INTEGER debLevB
177          PARAMETER(debLevB=2)
178    
179  C--   COMMON /PARM_L/ Logical valued parameters used by the model.  C--   COMMON /PARM_L/ Logical valued parameters used by the model.
180  C     usingCartesianGrid :: If TRUE grid generation will be in a cartesian  C     usingCartesianGrid :: If TRUE grid generation will be in a cartesian
181  C                          coordinate frame.  C                          coordinate frame.
182  C     usingSphericalPolarGrid :: If TRUE grid generation will be in a  C     usingSphericalPolarGrid :: If TRUE grid generation will be in a
183  C                               spherical polar frame.  C                               spherical polar frame.
184    C     usingCylindricalGrid :: If TRUE grid generation will be Cylindrical
185  C     no_slip_sides :: Impose "no-slip" at lateral boundaries.  C     no_slip_sides :: Impose "no-slip" at lateral boundaries.
186  C     no_slip_bottom :: Impose "no-slip" at bottom boundary.  C     no_slip_bottom :: Impose "no-slip" at bottom boundary.
187  C     staggerTimeStep :: enable a Stagger time stepping T,S Rho then U,V  C     staggerTimeStep :: enable a Stagger time stepping T,S Rho then U,V
# Line 195  C     tr1Stepping   :: Turns passive tra Line 222  C     tr1Stepping   :: Turns passive tra
222  C     useConstantF  :: Coriolis parameter set to f0  C     useConstantF  :: Coriolis parameter set to f0
223  C     useBetaPlaneF :: Coriolis parameter set to f0 + beta.y  C     useBetaPlaneF :: Coriolis parameter set to f0 + beta.y
224  C     useSphereF    :: Coriolis parameter set to 2.omega.sin(phi)  C     useSphereF    :: Coriolis parameter set to 2.omega.sin(phi)
225    C     useCDscheme   :: use CD-scheme to calculate Coriolis terms.
226  C     useJamartWetPoints :: Use wet-point method for Coriolis (Jamart and Ozer, 1986)  C     useJamartWetPoints :: Use wet-point method for Coriolis (Jamart and Ozer, 1986)
227    C     useJamartMomAdv :: Use wet-point method for V.I. non-linear term
228    C     SadournyCoriolis :: use the enstrophy conserving scheme by Sadourny
229    C     upwindVorticity :: bias interpolation of vorticity in the Coriolis term
230    C     highOrderVorticity :: use 3rd/4th order interp. of vorticity in Coriolis
231    C     useAbsVorticity :: work with f+zeta in Coriolis terms
232  C     implicitDiffusion :: Turns implicit vertical diffusion on  C     implicitDiffusion :: Turns implicit vertical diffusion on
233  C     implicitViscosity :: Turns implicit vertical viscosity on  C     implicitViscosity :: Turns implicit vertical viscosity on
234    C     tempImplVertAdv :: Turns on implicit vertical advection for Temperature
235    C     saltImplVertAdv :: Turns on implicit vertical advection for Salinity
236    C     momImplVertAdv  :: Turns on implicit vertical advection for Momentum
237  C     multiDimAdvection :: Flag that enable multi-dimension advection  C     multiDimAdvection :: Flag that enable multi-dimension advection
238    C     useMultiDimAdvec  :: True if multi-dim advection is used at least once
239  C     forcing_In_AB :: if False, put forcing (Temp,Salt,Tracers) contribution  C     forcing_In_AB :: if False, put forcing (Temp,Salt,Tracers) contribution
240  C                      out off Adams-Bashforth time stepping.  C                      out off Adams-Bashforth time stepping.
241  C     doThetaClimRelax :: Set true if relaxation to temperature  C     doThetaClimRelax :: Set true if relaxation to temperature
# Line 207  C     doSaltClimRelax  :: Set true if re Line 244  C     doSaltClimRelax  :: Set true if re
244  C                        climatology is required.  C                        climatology is required.
245  C     periodicExternalForcing :: Set true if forcing is time-dependant  C     periodicExternalForcing :: Set true if forcing is time-dependant
246  C     usingPCoords     :: Set to indicate that we are working in pressure  C     usingPCoords     :: Set to indicate that we are working in pressure
247  C                        coords.  C                        coords. (jmc: is it still used ?)
248  C     usingZCoords     :: Set to indicate that we are working in height  C     usingZCoords     :: Set to indicate that we are working in height
249  C                        coords.  C                        coords. (jmc: is it still used ?)
250    C     useDynP_inEos_Zc :: use the dynamical pressure in EOS (with Z-coord.)
251    C                         this requires specific code for restart & exchange
252  C     setCenterDr    :: set cell Center depth and put Interface at the middle  C     setCenterDr    :: set cell Center depth and put Interface at the middle
253  C     nonHydrostatic :: Using non-hydrostatic terms  C     nonHydrostatic :: Using non-hydrostatic terms
254  C     quasiHydrostatic :: Using non-hydrostatic terms in hydrostatic algorithm  C     quasiHydrostatic :: Using non-hydrostatic terms in hydrostatic algorithm
255  C     globalFiles    :: Selects between "global" and "tiled" files  C     globalFiles    :: Selects between "global" and "tiled" files
256  C     allowFreezing  :: Allows water to freeze and form ice  C     useSingleCpuIO :: On SGI platforms, option globalFiles is either
257    C                       slow (f77) or does not work (f90).  When
258    C                       useSingleCpuIO is set, mdsio_writefield.F
259    C                       outputs from master mpi process only.
260    C     allowFreezing  :: Allows surface water to freeze and form ice
261    C     useOldFreezing :: use the old version (before checkpoint52a_pre, 2003-11-12)
262  C     groundAtK1  :: put the surface(k=1) at the Lower Boundary (=ground)  C     groundAtK1  :: put the surface(k=1) at the Lower Boundary (=ground)
263        COMMON /PARM_L/ usingCartesianGrid, usingSphericalPolarGrid,        COMMON /PARM_L/ usingCartesianGrid, usingSphericalPolarGrid,
264       & usingCurvilinearGrid,       & usingCurvilinearGrid, usingCylindricalGrid,
265       & no_slip_sides,no_slip_bottom,       & no_slip_sides,no_slip_bottom,
266       & staggerTimeStep,       & staggerTimeStep,
267       & momViscosity, momAdvection, momForcing, useCoriolis,       & momViscosity, momAdvection, momForcing, useCoriolis,
# Line 229  C     groundAtK1  :: put the surface(k=1 Line 273  C     groundAtK1  :: put the surface(k=1
273       & momStepping, tempStepping, saltStepping, tr1Stepping,       & momStepping, tempStepping, saltStepping, tr1Stepping,
274       & metricTerms, usingSphericalPolarMTerms, useNHMTerms,       & metricTerms, usingSphericalPolarMTerms, useNHMTerms,
275       & useConstantF, useBetaPlaneF, useSphereF,       & useConstantF, useBetaPlaneF, useSphereF,
276       & useEnergyConservingCoriolis, useJamartWetPoints,       & useCDscheme,
277         & useEnergyConservingCoriolis, useJamartWetPoints, useJamartMomAdv,
278         & SadournyCoriolis, upwindVorticity, highOrderVorticity,
279         & useAbsVorticity,
280       & implicitDiffusion, implicitViscosity,       & implicitDiffusion, implicitViscosity,
281       & multiDimAdvection, forcing_In_AB,       & tempImplVertAdv, saltImplVertAdv, momImplVertAdv,
282         & multiDimAdvection, useMultiDimAdvec, forcing_In_AB,
283       & doThetaClimRelax, doSaltClimRelax, doTr1ClimRelax,       & doThetaClimRelax, doSaltClimRelax, doTr1ClimRelax,
284       & periodicExternalForcing,       & periodicExternalForcing,
285       & usingPCoords, usingZCoords, setCenterDr,       & usingPCoords, usingZCoords, useDynP_inEos_Zc, setCenterDr,
286       & nonHydrostatic, quasiHydrostatic, globalFiles,       & nonHydrostatic, quasiHydrostatic, globalFiles, useSingleCpuIO,
287       & allowFreezing, groundAtK1,       & allowFreezing, useOldFreezing, groundAtK1,
288       & usePickupBeforeC35, debugMode,       & usePickupBeforeC35, usePickupBeforeC54, debugMode,
289       & readPickupWithTracer, writePickupWithTracer       & readPickupWithTracer, writePickupWithTracer
290        LOGICAL usingCartesianGrid        LOGICAL usingCartesianGrid
291        LOGICAL usingSphericalPolarGrid        LOGICAL usingSphericalPolarGrid
292          LOGICAL usingCylindricalGrid
293        LOGICAL usingCurvilinearGrid        LOGICAL usingCurvilinearGrid
294        LOGICAL usingSphericalPolarMTerms        LOGICAL usingSphericalPolarMTerms
295        LOGICAL useNHMTerms        LOGICAL useNHMTerms
# Line 272  C     groundAtK1  :: put the surface(k=1 Line 321  C     groundAtK1  :: put the surface(k=1
321        LOGICAL useConstantF        LOGICAL useConstantF
322        LOGICAL useBetaPlaneF        LOGICAL useBetaPlaneF
323        LOGICAL useSphereF        LOGICAL useSphereF
324          LOGICAL useCDscheme
325        LOGICAL useEnergyConservingCoriolis        LOGICAL useEnergyConservingCoriolis
326        LOGICAL useJamartWetPoints        LOGICAL useJamartWetPoints
327          LOGICAL useJamartMomAdv
328          LOGICAL SadournyCoriolis
329          LOGICAL upwindVorticity
330          LOGICAL highOrderVorticity
331          LOGICAL useAbsVorticity
332        LOGICAL implicitDiffusion        LOGICAL implicitDiffusion
333        LOGICAL implicitViscosity        LOGICAL implicitViscosity
334          LOGICAL tempImplVertAdv
335          LOGICAL saltImplVertAdv
336          LOGICAL momImplVertAdv
337        LOGICAL multiDimAdvection        LOGICAL multiDimAdvection
338          LOGICAL useMultiDimAdvec
339        LOGICAL forcing_In_AB        LOGICAL forcing_In_AB
340        LOGICAL doThetaClimRelax        LOGICAL doThetaClimRelax
341        LOGICAL doSaltClimRelax        LOGICAL doSaltClimRelax
# Line 284  C     groundAtK1  :: put the surface(k=1 Line 343  C     groundAtK1  :: put the surface(k=1
343        LOGICAL periodicExternalForcing        LOGICAL periodicExternalForcing
344        LOGICAL usingPCoords        LOGICAL usingPCoords
345        LOGICAL usingZCoords        LOGICAL usingZCoords
346          LOGICAL useDynP_inEos_Zc
347        LOGICAL setCenterDr        LOGICAL setCenterDr
348        LOGICAL nonHydrostatic        LOGICAL nonHydrostatic
349        LOGICAL quasiHydrostatic        LOGICAL quasiHydrostatic
350        LOGICAL globalFiles        LOGICAL globalFiles
351          LOGICAL useSingleCpuIO
352        LOGICAL allowFreezing        LOGICAL allowFreezing
353          LOGICAL useOldFreezing
354        LOGICAL groundAtK1        LOGICAL groundAtK1
355        LOGICAL usePickupBeforeC35        LOGICAL usePickupBeforeC35
356          LOGICAL usePickupBeforeC54
357        LOGICAL debugMode        LOGICAL debugMode
358        LOGICAL readPickupWithTracer        LOGICAL readPickupWithTracer
359        LOGICAL writePickupWithTracer        LOGICAL writePickupWithTracer
360    
361  C--   COMMON /PARM_R/ "Real" valued parameters used by the model.  C--   COMMON /PARM_R/ "Real" valued parameters used by the model.
362  C     gg2dTargetResidual  C     cg2dTargetResidual
363  C          :: Target residual for cg2d solver; no unit (RHS normalisation)  C          :: Target residual for cg2d solver; no unit (RHS normalisation)
364  C     cg2dTargetResWunit  C     cg2dTargetResWunit
365  C          :: Target residual for cg2d solver; W unit (No RHS normalisation)  C          :: Target residual for cg2d solver; W unit (No RHS normalisation)
# Line 316  C           number of iterations for con Line 379  C           number of iterations for con
379  C           drop form 192 -> 134! Need to investigate this further!  C           drop form 192 -> 134! Need to investigate this further!
380  C           For now I have introduced a parameter cg2dpcOffDFac which  C           For now I have introduced a parameter cg2dpcOffDFac which
381  C           defaults to 0.51 but can be set at runtime.  C           defaults to 0.51 but can be set at runtime.
 C     delP      :: Vertical grid spacing ( Pa ).  
 C     delZ      :: Vertical grid spacing ( m  ).  
382  C     delR      :: Vertical grid spacing ( units of r ).  C     delR      :: Vertical grid spacing ( units of r ).
383  C     delRc     :: Vertical grid spacing between cell centers (r unit).  C     delRc     :: Vertical grid spacing between cell centers (r unit).
384  C     delX      :: Separation between cell faces (m) or (deg), depending  C     delX      :: Separation between cell faces (m) or (deg), depending
# Line 339  C     f0        :: Reference coriolis pa Line 400  C     f0        :: Reference coriolis pa
400  C                 ( Southern edge f for beta plane )  C                 ( Southern edge f for beta plane )
401  C     beta      :: df/dy ( s^-1.m^-1 )  C     beta      :: df/dy ( s^-1.m^-1 )
402  C     omega     :: Angular velocity ( rad/s )  C     omega     :: Angular velocity ( rad/s )
403    C     rotationPeriod :: Rotation period (s) (= 2.pi/omega)
404  C     viscAh    :: Eddy viscosity coeff. for mixing of  C     viscAh    :: Eddy viscosity coeff. for mixing of
405  C                 momentum laterally ( m^2/s )  C                 momentum laterally ( m^2/s )
 C     viscAz    :: Eddy viscosity coeff. for mixing of  
 C                 momentum vertically ( m^2/s )  
 C     viscAp    :: Eddy viscosity coeff. for mixing of  
 C                 momentum vertically ( Pa^2/s )  
406  C     viscAr    :: Eddy viscosity coeff. for mixing of  C     viscAr    :: Eddy viscosity coeff. for mixing of
407  C                 momentum vertically ( units of r^2/s )  C                 momentum vertically ( units of r^2/s )
408  C     viscA4    :: Biharmonic viscosity coeff. for mixing of  C     viscA4    :: Biharmonic viscosity coeff. for mixing of
409  C                 momentum laterally ( m^4/s )  C                 momentum laterally ( m^4/s )
410    C     viscC2leith :: Leith non-dimensional viscosity factor
411    C     viscAhMax :: Maximum eddy viscosity coeff. for mixing of
412    C                 momentum laterally ( m^2/s )
413    C     viscA4Max :: Maximum biharmonic viscosity coeff. for mixing of
414    C                 momentum laterally ( m^4/s )
415    C     viscAhGrid:: non-dimensional grid-size dependent viscosity
416    C     viscA4Grid:: non-dimensional grid-size dependent bi-harmonic viscosity
417    C     viscC4leith :: Leith non-dimensional viscosity factor
418  C     diffKhT   :: Laplacian diffusion coeff. for mixing of  C     diffKhT   :: Laplacian diffusion coeff. for mixing of
419  C                 heat laterally ( m^2/s )  C                 heat laterally ( m^2/s )
 C     diffKzT   :: Laplacian diffusion coeff. for mixing of  
 C                 heat vertically ( m^2/s )  
 C     diffKpT   :: Laplacian diffusion coeff. for mixing of  
 C                 heat vertically ( Pa^2/s )  
420  C     diffKrT   :: Laplacian diffusion coeff. for mixing of  C     diffKrT   :: Laplacian diffusion coeff. for mixing of
421  C                 heat vertically ( units of r^2/s )  C                 heat vertically ( units of r^2/s )
422  C     diffK4T   :: Biharmonic diffusion coeff. for mixing of  C     diffK4T   :: Biharmonic diffusion coeff. for mixing of
423  C                 heat laterally ( m^4/s )  C                 heat laterally ( m^4/s )
424  C     diffKhS  ::  Laplacian diffusion coeff. for mixing of  C     diffKhS  ::  Laplacian diffusion coeff. for mixing of
425  C                 salt laterally ( m^2/s )  C                 salt laterally ( m^2/s )
 C     diffKzS   :: Laplacian diffusion coeff. for mixing of  
 C                 salt vertically ( m^2/s )  
 C     diffKpS   :: Laplacian diffusion coeff. for mixing of  
 C                 salt vertically ( Pa^2/s )  
426  C     diffKrS   :: Laplacian diffusion coeff. for mixing of  C     diffKrS   :: Laplacian diffusion coeff. for mixing of
427  C                 salt vertically ( units of r^2/s )  C                 salt vertically ( units of r^2/s )
428  C     diffK4S   :: Biharmonic diffusion coeff. for mixing of  C     diffK4S   :: Biharmonic diffusion coeff. for mixing of
429  C                 salt laterally ( m^4/s )  C                 salt laterally ( m^4/s )
430    C     diffKrBL79surf :: T/S surface diffusivity (m^2/s) Bryan and Lewis, 1979
431    C     diffKrBL79deep :: T/S deep diffusivity (m^2/s) Bryan and Lewis, 1979
432    C     diffKrBL79scl  :: depth scale for arctan fn (m) Bryan and Lewis, 1979
433    C     diffKrBL79Ho   :: depth offset for arctan fn (m) Bryan and Lewis, 1979
434  C     deltaT    :: Default timestep ( s )  C     deltaT    :: Default timestep ( s )
435  C     deltaTClock  :: Timestep used as model "clock". This determines the  C     deltaTClock  :: Timestep used as model "clock". This determines the
436  C                    IO frequencies and is used in tagging output. It can  C                    IO frequencies and is used in tagging output. It can
# Line 420  C     tauThetaClimRelax :: Relaxation to Line 482  C     tauThetaClimRelax :: Relaxation to
482  C     lambdaThetaClimRelax :: Inverse time scale for relaxation ( 1/s ).  C     lambdaThetaClimRelax :: Inverse time scale for relaxation ( 1/s ).
483  C     tauSaltClimRelax :: Relaxation to climatology time scale ( s ).  C     tauSaltClimRelax :: Relaxation to climatology time scale ( s ).
484  C     lambdaSaltClimRelax :: Inverse time scale for relaxation ( 1/s ).  C     lambdaSaltClimRelax :: Inverse time scale for relaxation ( 1/s ).
485    C     latBandClimRelax :: latitude band where Relaxation to Clim. is applied,
486    C                         i.e. where |yC| <= latBandClimRelax
487  C     externForcingPeriod :: Is the period of which forcing varies (eg. 1 month)  C     externForcingPeriod :: Is the period of which forcing varies (eg. 1 month)
488  C     externForcingCycle :: Is the repeat time of the forcing (eg. 1 year)  C     externForcingCycle :: Is the repeat time of the forcing (eg. 1 year)
489  C                          (note: externForcingCycle must be an integer  C                          (note: externForcingCycle must be an integer
# Line 441  C     bottomDragLinear   :: Drag coeffic Line 505  C     bottomDragLinear   :: Drag coeffic
505  C      --"-"--  Quadratic  ( linear: 1/s, quadratic: 1/m )  C      --"-"--  Quadratic  ( linear: 1/s, quadratic: 1/m )
506        COMMON /PARM_R/ cg2dTargetResidual, cg2dTargetResWunit,        COMMON /PARM_R/ cg2dTargetResidual, cg2dTargetResWunit,
507       & cg2dpcOffDFac, cg3dTargetResidual,       & cg2dpcOffDFac, cg3dTargetResidual,
508       & delP, delZ, delR, delRc, delX, delY,       & delR, delRc, delX, delY,
509       & deltaT, deltaTmom, deltaTtracer, deltaTfreesurf, deltaTClock,       & deltaT, deltaTmom, deltaTtracer, deltaTfreesurf, deltaTClock,
510       & abeps, startTime,       & abeps, startTime,
511       & phiMin, thetaMin, rSphere, recip_RSphere, f0, beta,       & phiMin, thetaMin, rSphere, recip_RSphere, f0, beta,
512       & fCori, fCoriG, fCoriCos,       & fCori, fCoriG, fCoriCos,
513       & viscAh,  viscAz,  viscA4,  viscAr, viscAstrain, viscAtension,       & viscAh,  viscAhMax, viscAhGrid, viscC2leith,
514       & diffKhT, diffKzT, diffK4T, diffKrT,       & viscA4,  viscA4Max, viscA4Grid, viscC4leith,
515       & diffKhS, diffKzS, diffK4S, diffKrS,       & viscAr, viscAstrain, viscAtension,
516         & diffKhT, diffK4T, diffKrT,
517         & diffKhS, diffK4S, diffKrS,
518         & diffKrBL79surf, diffKrBL79deep, diffKrBL79scl, diffKrBL79Ho,
519       & delT, tauCD, rCD, freeSurfFac, implicSurfPress, implicDiv2Dflow,       & delT, tauCD, rCD, freeSurfFac, implicSurfPress, implicDiv2Dflow,
520       & hFacMin, hFacMinDz, hFacInf, hFacSup,       & hFacMin, hFacMinDz, hFacInf, hFacSup,
521       & gravity, recip_Gravity, gBaro, rhonil, recip_rhonil,       & gravity, recip_Gravity, gBaro, rhonil, recip_rhonil,
522       & recip_rhoConst, rhoConst,       & recip_rhoConst, rhoConst,
523       & rhoConstFresh, convertEmP2rUnit, tRef, sRef,       & rhoConstFresh, convertEmP2rUnit, tRef, sRef,
524       & endTime, chkPtFreq, pchkPtFreq, dumpFreq,       & endTime, chkPtFreq, pchkPtFreq, dumpFreq, adjDumpFreq,
525       & diagFreq, taveFreq, tave_lastIter, monitorFreq,       & diagFreq, taveFreq, tave_lastIter, monitorFreq,
526       & afFacMom, vfFacMom, pfFacMom, cfFacMom, foFacMom, mtFacMom,       & afFacMom, vfFacMom, pfFacMom, cfFacMom, foFacMom, mtFacMom,
527       & cosPower, cAdjFreq, omega,       & cosPower, cAdjFreq, omega, rotationPeriod,
528       & tauThetaClimRelax, lambdaThetaClimRelax,       & tauThetaClimRelax, lambdaThetaClimRelax,
529       & tauSaltClimRelax, lambdaSaltClimRelax,       & tauSaltClimRelax, lambdaSaltClimRelax,
530       & tauTr1ClimRelax, lambdaTr1ClimRelax,       & tauTr1ClimRelax, lambdaTr1ClimRelax, latBandClimRelax,
531       & externForcingCycle, externForcingPeriod,       & externForcingCycle, externForcingPeriod,
532       & convertFW2Salt, temp_EvPrRn, salt_EvPrRn, trac_EvPrRn,       & convertFW2Salt, temp_EvPrRn, salt_EvPrRn, trac_EvPrRn,
533       & viscAp, diffKpT, diffKpS, hFacMinDr, hFacMinDp,       & hFacMinDr, hFacMinDp,
534       & horiVertRatio, recip_horiVertRatio,       & horiVertRatio, recip_horiVertRatio,
535       & ivdc_kappa, Ro_SeaLevel,       & ivdc_kappa, Ro_SeaLevel,
536       & bottomDragLinear,bottomDragQuadratic       & bottomDragLinear,bottomDragQuadratic,
537         & tCyl
538    
539        _RL cg2dTargetResidual        _RL cg2dTargetResidual
540        _RL cg2dTargetResWunit        _RL cg2dTargetResWunit
541        _RL cg3dTargetResidual        _RL cg3dTargetResidual
542        _RL cg2dpcOffDFac        _RL cg2dpcOffDFac
       _RL delZ(Nr)  
       _RL delP(Nr)  
543        _RL delR(Nr)        _RL delR(Nr)
544        _RL delRc(Nr+1)        _RL delRc(Nr+1)
545        _RL delX(Nx)        _RL delX(Nx)
# Line 500  C      --"-"--  Quadratic  ( linear: 1/s Line 566  C      --"-"--  Quadratic  ( linear: 1/s
566        _RL hFacSup        _RL hFacSup
567        _RL beta        _RL beta
568        _RL viscAh        _RL viscAh
569          _RL viscAhMax
570          _RL viscAhGrid
571          _RL viscC2leith
572        _RL viscAstrain        _RL viscAstrain
573        _RL viscAtension        _RL viscAtension
       _RL viscAz  
       _RL viscAp  
574        _RL viscAr        _RL viscAr
575        _RL viscA4        _RL viscA4
576          _RL viscA4Max
577          _RL viscA4Grid
578          _RL viscC4leith
579        _RL diffKhT        _RL diffKhT
580        _RL diffKrT        _RL diffKrT
       _RL diffKzT  
       _RL diffKpT  
581        _RL diffK4T        _RL diffK4T
582        _RL diffKhS        _RL diffKhS
583        _RL diffKrS        _RL diffKrS
       _RL diffKzS  
       _RL diffKpS  
584        _RL diffK4S        _RL diffK4S
585          _RL diffKrBL79surf
586          _RL diffKrBL79deep
587          _RL diffKrBL79scl
588          _RL diffKrBL79Ho
589        _RL delt        _RL delt
590        _RL tauCD        _RL tauCD
591        _RL rCD        _RL rCD
# Line 538  C      --"-"--  Quadratic  ( linear: 1/s Line 608  C      --"-"--  Quadratic  ( linear: 1/s
608        _RL chkPtFreq        _RL chkPtFreq
609        _RL pChkPtFreq        _RL pChkPtFreq
610        _RL dumpFreq        _RL dumpFreq
611          _RL adjDumpFreq
612        _RL diagFreq        _RL diagFreq
613        _RL taveFreq        _RL taveFreq
614        _RL tave_lastIter        _RL tave_lastIter
# Line 551  C      --"-"--  Quadratic  ( linear: 1/s Line 622  C      --"-"--  Quadratic  ( linear: 1/s
622        _RL cosPower        _RL cosPower
623        _RL cAdjFreq        _RL cAdjFreq
624        _RL omega        _RL omega
625          _RL rotationPeriod
626        _RL tauThetaClimRelax        _RL tauThetaClimRelax
627        _RL lambdaThetaClimRelax        _RL lambdaThetaClimRelax
628        _RL tauSaltClimRelax        _RL tauSaltClimRelax
629        _RL lambdaSaltClimRelax        _RL lambdaSaltClimRelax
630        _RL tauTr1ClimRelax        _RL tauTr1ClimRelax
631        _RL lambdaTr1ClimRelax        _RL lambdaTr1ClimRelax
632          _RL latBandClimRelax
633        _RL externForcingCycle        _RL externForcingCycle
634        _RL externForcingPeriod        _RL externForcingPeriod
635        _RL convertFW2Salt        _RL convertFW2Salt
# Line 569  C      --"-"--  Quadratic  ( linear: 1/s Line 642  C      --"-"--  Quadratic  ( linear: 1/s
642        _RL Ro_SeaLevel        _RL Ro_SeaLevel
643        _RL bottomDragLinear        _RL bottomDragLinear
644        _RL bottomDragQuadratic        _RL bottomDragQuadratic
645          _RL tCyl
646    
647        COMMON /PARM_A/ HeatCapacity_Cp,recip_Cp,  C--   COMMON /PARM_A/ Thermodynamics constants ?
648       &                Lamba_theta        COMMON /PARM_A/ HeatCapacity_Cp,recip_Cp
649        _RL HeatCapacity_Cp        _RL HeatCapacity_Cp
       _RL Lamba_theta  
650        _RL recip_Cp        _RL recip_Cp
651    
652  CmlC Equation of State (polynomial coeffients)  C--   COMMON /PARM_ATM/ Atmospheric physical parameters (Ideal Gas EOS, ...)
653  Cml      COMMON /PARM_EOS_NL/ eosC,eosSig0,eosRefT,eosRefS  C     celsius2K :: convert centigrade (Celsius) degree to Kelvin
654  Cml      _RL eosC(9,Nr+1),eosSig0(Nr+1),eosRefT(Nr+1),eosRefS(Nr+1)  C     atm_Po    :: standard reference pressure
655  CmlC Linear equation of state  C     atm_Cp    :: specific heat (Cp) of the (dry) air at constant pressure
656  CmlC     tAlpha    :: Linear EOS thermal expansion coefficient ( 1/degree ).  C     atm_Rd    :: gas constant for dry air
 CmlC     sBeta     :: Linear EOS haline contraction coefficient.  
 Cml      COMMON /PARM_EOS_LIN/ tAlpha,sBeta,eosType  
 Cml      _RL tAlpha  
 Cml      _RL sBeta  
   
 C Atmospheric physical parameters (Ideal Gas EOS, ...)  
 C     atm_po    :: standard reference pressure  
 C     atm_cp    :: specific heat (Cp) of the (dry) air at constant pressure  
657  C     atm_kappa :: kappa = R/Cp (R: constant of Ideal Gas EOS)  C     atm_kappa :: kappa = R/Cp (R: constant of Ideal Gas EOS)
658  C     Integr_GeoPot :: option to select the way we integrate the geopotential  C     atm_Rq    :: water vapour specific volume anomaly relative to dry air
659    C                  (e.g. typical value = (29/18 -1) 10^-3 with q [g/kg])
660    C     integr_GeoPot :: option to select the way we integrate the geopotential
661  C                     (still a subject of discussions ...)  C                     (still a subject of discussions ...)
662        COMMON /PARM_ATM/ atm_cp, atm_kappa, atm_po,  C     selectFindRoSurf :: select the way surf. ref. pressure (=Ro_surf) is
663       &                  Integr_GeoPot  C             derived from the orography. Implemented: 0,1 (see INI_P_GROUND)
664        _RL atm_cp, atm_kappa, atm_po        COMMON /PARM_ATM/
665        INTEGER Integr_GeoPot       &            celsius2K,
666         &            atm_Cp, atm_Rd, atm_kappa, atm_Rq, atm_Po,
667         &            integr_GeoPot, selectFindRoSurf
668          _RL celsius2K
669          _RL atm_Po, atm_Cp, atm_Rd, atm_kappa, atm_Rq
670          INTEGER integr_GeoPot, selectFindRoSurf
671    
672  C Logical flags for selecting packages  C Logical flags for selecting packages
673        LOGICAL useKPP        LOGICAL useKPP
674        LOGICAL useGMRedi        LOGICAL useGMRedi
675        LOGICAL useOBCS        LOGICAL useOBCS
676        LOGICAL useAIM        LOGICAL useAIM
677          LOGICAL useLand
678        LOGICAL useGrdchk        LOGICAL useGrdchk
679        LOGICAL useECCO        LOGICAL useECCO
680        LOGICAL useSHAP_FILT        LOGICAL useSHAP_FILT
681        LOGICAL useZONAL_FILT        LOGICAL useZONAL_FILT
682        LOGICAL useFLT        LOGICAL useFLT
683        LOGICAL usePTRACERS        LOGICAL usePTRACERS
684          LOGICAL useSBO
685          LOGICAL useSEAICE
686          LOGICAL useBulkForce
687          LOGICAL useThSIce
688          LOGICAL usefizhi
689          LOGICAL usegridalt
690          LOGICAL usediagnostics
691          LOGICAL useEBM
692        COMMON /PARM_PACKAGES/        COMMON /PARM_PACKAGES/
693       &        useKPP, useGMRedi, useOBCS, useAIM, useECCO,       &        useKPP, useGMRedi, useOBCS, useAIM, useLand, useECCO,
694       &        useSHAP_FILT, useZONAL_FILT, useGrdchk, useFLT,       &        useSHAP_FILT, useZONAL_FILT, useGrdchk, useFLT,
695       &        usePTRACERS       &        usePTRACERS,  useSBO, useSEAICE, useThSIce, useBulkForce,
696         &        usefizhi,  usegridalt, usediagnostics, useEBM
697    
698    C     Run-time flags for early-initialization of MNC
699          LOGICAL
700         &     useMNC,
701         &     mnc_use_indir, mnc_use_outdir, mnc_outdir_date,
702         &     mnc_echo_gvtypes, mnc_pickup_write, mnc_pickup_read,
703         &     mnc_use_for_mon
704          CHARACTER*(MAX_LEN_FNAM) mnc_outdir_str
705          CHARACTER*(MAX_LEN_FNAM) mnc_indir_str
706          COMMON /PARM_MNC/
707         &     useMNC,
708         &     mnc_use_indir, mnc_use_outdir, mnc_outdir_date,
709         &     mnc_echo_gvtypes, mnc_pickup_write, mnc_pickup_read,
710         &     mnc_outdir_str, mnc_indir_str,
711         &     mnc_use_for_mon
712    
713    
714    CEH3 ;;; Local Variables: ***
715    CEH3 ;;; mode:fortran ***
716    CEH3 ;;; End: ***

Legend:
Removed from v.1.79  
changed lines
  Added in v.1.119

  ViewVC Help
Powered by ViewVC 1.1.22