/[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.95 by jmc, Wed Oct 15 22:57:43 2003 UTC revision 1.119 by jmc, Fri Jul 9 22:31:16 2004 UTC
# Line 110  C     cg2dMaxIters        :: Maximum num Line 110  C     cg2dMaxIters        :: Maximum num
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 126  C     nonlinFreeSurf      :: option rela Line 128  C     nonlinFreeSurf      :: option rela
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  C     select_rStar        :: option related to r* vertical coordinate
130  C                           =0 (default) use r coord. ; > 0 use r*  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,
# Line 137  C                           =0 (default) Line 144  C                           =0 (default)
144       &        writeStatePrec, nCheckLev,       &        writeStatePrec, nCheckLev,
145       &        writeBinaryPrec, readBinaryPrec,       &        writeBinaryPrec, readBinaryPrec,
146       &        nonlinFreeSurf, select_rStar,       &        nonlinFreeSurf, select_rStar,
147       &        tempAdvScheme, saltAdvScheme, tracerAdvScheme,       &        tempAdvScheme, tempVertAdvScheme,
148         &        saltAdvScheme, saltVertAdvScheme,
149         &        tracerAdvScheme,
150       &        debugLevel       &        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 153  C                           =0 (default) Line 163  C                           =0 (default)
163        INTEGER nCheckLev        INTEGER nCheckLev
164        INTEGER nonlinFreeSurf        INTEGER nonlinFreeSurf
165        INTEGER select_rStar        INTEGER select_rStar
166        INTEGER tempAdvScheme        INTEGER tempAdvScheme, tempVertAdvScheme
167        INTEGER saltAdvScheme        INTEGER saltAdvScheme, saltVertAdvScheme
168        INTEGER tracerAdvScheme        INTEGER tracerAdvScheme
169        INTEGER debugLevel        INTEGER debugLevel
170    
# Line 171  C     usingCartesianGrid :: If TRUE grid Line 181  C     usingCartesianGrid :: If TRUE grid
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 213  C     useBetaPlaneF :: Coriolis paramete Line 224  C     useBetaPlaneF :: Coriolis paramete
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.  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 237  C     useSingleCpuIO :: On SGI platforms Line 257  C     useSingleCpuIO :: On SGI platforms
257  C                       slow (f77) or does not work (f90).  When  C                       slow (f77) or does not work (f90).  When
258  C                       useSingleCpuIO is set, mdsio_writefield.F  C                       useSingleCpuIO is set, mdsio_writefield.F
259  C                       outputs from master mpi process only.  C                       outputs from master mpi process only.
260  C     allowFreezing  :: Allows water to freeze and form ice  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 253  C     groundAtK1  :: put the surface(k=1 Line 274  C     groundAtK1  :: put the surface(k=1
274       & metricTerms, usingSphericalPolarMTerms, useNHMTerms,       & metricTerms, usingSphericalPolarMTerms, useNHMTerms,
275       & useConstantF, useBetaPlaneF, useSphereF,       & useConstantF, useBetaPlaneF, useSphereF,
276       & useCDscheme,       & useCDscheme,
277       & useEnergyConservingCoriolis, useJamartWetPoints,       & 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, useDynP_inEos_Zc, setCenterDr,       & usingPCoords, usingZCoords, useDynP_inEos_Zc, setCenterDr,
286       & nonHydrostatic, quasiHydrostatic, globalFiles, useSingleCpuIO,       & 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 299  C     groundAtK1  :: put the surface(k=1 Line 324  C     groundAtK1  :: put the surface(k=1
324        LOGICAL useCDscheme        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 316  C     groundAtK1  :: put the surface(k=1 Line 350  C     groundAtK1  :: put the surface(k=1
350        LOGICAL globalFiles        LOGICAL globalFiles
351        LOGICAL useSingleCpuIO        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 343  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 369  C     omega     :: Angular velocity ( ra Line 403  C     omega     :: Angular velocity ( ra
403  C     rotationPeriod :: Rotation period (s) (= 2.pi/omega)  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 471  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, rotationPeriod,       & cosPower, cAdjFreq, omega, rotationPeriod,
# Line 493  C      --"-"--  Quadratic  ( linear: 1/s Line 530  C      --"-"--  Quadratic  ( linear: 1/s
530       & tauTr1ClimRelax, lambdaTr1ClimRelax, latBandClimRelax,       & 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 530  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 568  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 601  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  C--   COMMON /PARM_A/ Thermodynamics constants ?  C--   COMMON /PARM_A/ Thermodynamics constants ?
648        COMMON /PARM_A/ HeatCapacity_Cp,recip_Cp        COMMON /PARM_A/ HeatCapacity_Cp,recip_Cp
# Line 641  C Logical flags for selecting packages Line 683  C Logical flags for selecting packages
683        LOGICAL usePTRACERS        LOGICAL usePTRACERS
684        LOGICAL useSBO        LOGICAL useSBO
685        LOGICAL useSEAICE        LOGICAL useSEAICE
686        LOGICAL useBulkforce        LOGICAL useBulkForce
687        LOGICAL useThermSEAICE        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, useLand, useECCO,       &        useKPP, useGMRedi, useOBCS, useAIM, useLand, useECCO,
694       &        useSHAP_FILT, useZONAL_FILT, useGrdchk, useFLT,       &        useSHAP_FILT, useZONAL_FILT, useGrdchk, useFLT,
695       &        usePTRACERS,  useSBO, useSEAICE,       &        usePTRACERS,  useSBO, useSEAICE, useThSIce, useBulkForce,
696       &        useThermSEAICE, useBulkforce       &        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.95  
changed lines
  Added in v.1.119

  ViewVC Help
Powered by ViewVC 1.1.22