/[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.277 by gforget, Sun Nov 2 21:21:43 2014 UTC revision 1.284 by jmc, Mon Nov 28 22:47:42 2016 UTC
# Line 38  C                        must exist befo Line 38  C                        must exist befo
38  C     tRefFile      :: File containing reference Potential Temperat.  tRef (1.D)  C     tRefFile      :: File containing reference Potential Temperat.  tRef (1.D)
39  C     sRefFile      :: File containing reference salinity/spec.humid. sRef (1.D)  C     sRefFile      :: File containing reference salinity/spec.humid. sRef (1.D)
40  C     rhoRefFile    :: File containing reference density profile rhoRef (1.D)  C     rhoRefFile    :: File containing reference density profile rhoRef (1.D)
41    C     gravityFile   :: File containing gravity vertical profile (1.D)
42  C     delRFile      :: File containing vertical grid spacing delR  (1.D array)  C     delRFile      :: File containing vertical grid spacing delR  (1.D array)
43  C     delRcFile     :: File containing vertical grid spacing delRc (1.D array)  C     delRcFile     :: File containing vertical grid spacing delRc (1.D array)
44  C     hybSigmFile   :: File containing hybrid-sigma vertical coord. coeff. (2x 1.D)  C     hybSigmFile   :: File containing hybrid-sigma vertical coord. coeff. (2x 1.D)
# Line 84  C     the_run_name    :: string identify Line 85  C     the_run_name    :: string identify
85        COMMON /PARM_C/        COMMON /PARM_C/
86       &                buoyancyRelation, eosType,       &                buoyancyRelation, eosType,
87       &                pickupSuff, mdsioLocalDir, adTapeDir,       &                pickupSuff, mdsioLocalDir, adTapeDir,
88       &                tRefFile, sRefFile, rhoRefFile,       &                tRefFile, sRefFile, rhoRefFile, gravityFile,
89       &                delRFile, delRcFile, hybSigmFile,       &                delRFile, delRcFile, hybSigmFile,
90       &                delXFile, delYFile, horizGridFile,       &                delXFile, delYFile, horizGridFile,
91       &                bathyFile, topoFile, addWwallFile, addSwallFile,       &                bathyFile, topoFile, addWwallFile, addSwallFile,
# Line 108  C     the_run_name    :: string identify Line 109  C     the_run_name    :: string identify
109        CHARACTER*(MAX_LEN_FNAM) tRefFile        CHARACTER*(MAX_LEN_FNAM) tRefFile
110        CHARACTER*(MAX_LEN_FNAM) sRefFile        CHARACTER*(MAX_LEN_FNAM) sRefFile
111        CHARACTER*(MAX_LEN_FNAM) rhoRefFile        CHARACTER*(MAX_LEN_FNAM) rhoRefFile
112          CHARACTER*(MAX_LEN_FNAM) gravityFile
113        CHARACTER*(MAX_LEN_FNAM) delRFile        CHARACTER*(MAX_LEN_FNAM) delRFile
114        CHARACTER*(MAX_LEN_FNAM) delRcFile        CHARACTER*(MAX_LEN_FNAM) delRcFile
115        CHARACTER*(MAX_LEN_FNAM) hybSigmFile        CHARACTER*(MAX_LEN_FNAM) hybSigmFile
# Line 159  C                            in con. gra Line 161  C                            in con. gra
161  C     printResidualFreq   :: Frequency for printing residual in CG iterations  C     printResidualFreq   :: Frequency for printing residual in CG iterations
162  C     nIter0              :: Start time-step number of for this run  C     nIter0              :: Start time-step number of for this run
163  C     nTimeSteps          :: Number of timesteps to execute  C     nTimeSteps          :: Number of timesteps to execute
164    C     nTimeSteps_l2       :: Number of inner timesteps to execute per timestep
165  C     writeStatePrec      :: Precision used for writing model state.  C     writeStatePrec      :: Precision used for writing model state.
166  C     writeBinaryPrec     :: Precision used for writing binary files  C     writeBinaryPrec     :: Precision used for writing binary files
167  C     readBinaryPrec      :: Precision used for reading binary files  C     readBinaryPrec      :: Precision used for reading binary files
# Line 174  C     select_rStar        :: option rela Line 177  C     select_rStar        :: option rela
177  C                           =0 (default) use r coord. ; > 0 use r*  C                           =0 (default) use r coord. ; > 0 use r*
178  C     selectNHfreeSurf    :: option for Non-Hydrostatic (free-)Surface formulation:  C     selectNHfreeSurf    :: option for Non-Hydrostatic (free-)Surface formulation:
179  C                           =0 (default) hydrostatic surf. ; > 0 add NH effects.  C                           =0 (default) hydrostatic surf. ; > 0 add NH effects.
180    C     selectP_inEOS_Zc    :: select which pressure to use in EOS (for z-coords)
181    C                           =0: simply: -g*rhoConst*z
182    C                           =1: use pRef = integral{-g*rho(Tref,Sref,pRef)*dz}
183    C                           =2: use hydrostatic dynamical pressure
184    C                           =3: use full (Hyd+NH) dynamical pressure
185  C     selectAddFluid      :: option to add mass source/sink of fluid in the interior  C     selectAddFluid      :: option to add mass source/sink of fluid in the interior
186  C                            (3-D generalisation of oceanic real-fresh water flux)  C                            (3-D generalisation of oceanic real-fresh water flux)
187  C                           =0 off ; =1 add fluid ; =-1 virtual flux (no mass added)  C                           =0 off ; =1 add fluid ; =-1 virtual flux (no mass added)
188    C     selectImplicitDrag  :: select Implicit treatment of bottom/top drag
189    C                           = 0: fully explicit
190    C                           = 1: implicit on provisional velocity
191    C                                (i.e., before grad.Eta increment)
192    C                           = 2: fully implicit (combined with Impl Surf.Press)
193  C     momForcingOutAB     :: =1: take momentum forcing contribution  C     momForcingOutAB     :: =1: take momentum forcing contribution
194  C                            out of (=0: in) Adams-Bashforth time stepping.  C                            out of (=0: in) Adams-Bashforth time stepping.
195  C     tracForcingOutAB    :: =1: take tracer (Temp,Salt,pTracers) forcing contribution  C     tracForcingOutAB    :: =1: take tracer (Temp,Salt,pTracers) forcing contribution
# Line 187  C     saltAdvScheme       :: Salt. Horiz Line 200  C     saltAdvScheme       :: Salt. Horiz
200  C     saltVertAdvScheme   :: Salt. Vert. Advection scheme selector  C     saltVertAdvScheme   :: Salt. Vert. Advection scheme selector
201  C     selectKEscheme      :: Kinetic Energy scheme selector (Vector Inv.)  C     selectKEscheme      :: Kinetic Energy scheme selector (Vector Inv.)
202  C     selectVortScheme    :: Scheme selector for Vorticity term (Vector Inv.)  C     selectVortScheme    :: Scheme selector for Vorticity term (Vector Inv.)
203    C     selectBotDragQuadr  :: quadratic bottom drag discretisation option:
204    C                           =0: average KE from grid center to U & V location
205    C                           =1: use local velocity norm @ U & V location
206    C                           =2: same with wet-point averaging of other component
207  C     monitorSelect       :: select group of variables to monitor  C     monitorSelect       :: select group of variables to monitor
208  C                            =1 : dynvars ; =2 : + vort ; =3 : + surface  C                            =1 : dynvars ; =2 : + vort ; =3 : + surface
209  C-    debugLevel          :: controls printing of algorithm intermediate results  C-    debugLevel          :: controls printing of algorithm intermediate results
# Line 197  C                            and statist Line 214  C                            and statist
214       &        cg2dPreCondFreq, cg2dUseMinResSol,       &        cg2dPreCondFreq, cg2dUseMinResSol,
215       &        cg3dMaxIters, cg3dChkResFreq,       &        cg3dMaxIters, cg3dChkResFreq,
216       &        printResidualFreq,       &        printResidualFreq,
217       &        nIter0, nTimeSteps, nEndIter,       &        nIter0, nTimeSteps, nTimeSteps_l2, nEndIter,
218       &        writeStatePrec,       &        writeStatePrec,
219       &        writeBinaryPrec, readBinaryPrec,       &        writeBinaryPrec, readBinaryPrec,
220       &        selectCoriMap,       &        selectCoriMap,
221       &        selectSigmaCoord,       &        selectSigmaCoord,
222       &        nonlinFreeSurf, select_rStar,       &        nonlinFreeSurf, select_rStar,
223       &        selectNHfreeSurf,       &        selectNHfreeSurf, selectP_inEOS_Zc,
224       &        selectAddFluid,       &        selectAddFluid, selectImplicitDrag,
225       &        momForcingOutAB, tracForcingOutAB,       &        momForcingOutAB, tracForcingOutAB,
226       &        tempAdvScheme, tempVertAdvScheme,       &        tempAdvScheme, tempVertAdvScheme,
227       &        saltAdvScheme, saltVertAdvScheme,       &        saltAdvScheme, saltVertAdvScheme,
228       &        selectKEscheme, selectVortScheme,       &        selectKEscheme, selectVortScheme,
229         &        selectBotDragQuadr,
230       &        monitorSelect, debugLevel       &        monitorSelect, debugLevel
231        INTEGER cg2dMaxIters        INTEGER cg2dMaxIters
232        INTEGER cg2dChkResFreq        INTEGER cg2dChkResFreq
# Line 219  C                            and statist Line 237  C                            and statist
237        INTEGER printResidualFreq        INTEGER printResidualFreq
238        INTEGER nIter0        INTEGER nIter0
239        INTEGER nTimeSteps        INTEGER nTimeSteps
240          INTEGER nTimeSteps_l2
241        INTEGER nEndIter        INTEGER nEndIter
242        INTEGER writeStatePrec        INTEGER writeStatePrec
243        INTEGER writeBinaryPrec        INTEGER writeBinaryPrec
# Line 228  C                            and statist Line 247  C                            and statist
247        INTEGER nonlinFreeSurf        INTEGER nonlinFreeSurf
248        INTEGER select_rStar        INTEGER select_rStar
249        INTEGER selectNHfreeSurf        INTEGER selectNHfreeSurf
250          INTEGER selectP_inEOS_Zc
251        INTEGER selectAddFluid        INTEGER selectAddFluid
252          INTEGER selectImplicitDrag
253        INTEGER momForcingOutAB, tracForcingOutAB        INTEGER momForcingOutAB, tracForcingOutAB
254        INTEGER tempAdvScheme, tempVertAdvScheme        INTEGER tempAdvScheme, tempVertAdvScheme
255        INTEGER saltAdvScheme, saltVertAdvScheme        INTEGER saltAdvScheme, saltVertAdvScheme
256        INTEGER selectKEscheme        INTEGER selectKEscheme
257        INTEGER selectVortScheme        INTEGER selectVortScheme
258          INTEGER selectBotDragQuadr
259        INTEGER monitorSelect        INTEGER monitorSelect
260        INTEGER debugLevel        INTEGER debugLevel
261    
# Line 247  C     usingPCoords     :: Set to indicat Line 269  C     usingPCoords     :: Set to indicat
269  C                         type coordinate (p or p*).  C                         type coordinate (p or p*).
270  C     usingZCoords     :: Set to indicate that we are working in a height  C     usingZCoords     :: Set to indicate that we are working in a height
271  C                         type coordinate (z or z*)  C                         type coordinate (z or z*)
 C     useDynP_inEos_Zc :: use the dynamical pressure in EOS (with Z-coord.)  
 C                         this requires specific code for restart & exchange  
272  C     usingCartesianGrid :: If TRUE grid generation will be in a cartesian  C     usingCartesianGrid :: If TRUE grid generation will be in a cartesian
273  C                           coordinate frame.  C                           coordinate frame.
274  C     usingSphericalPolarGrid :: If TRUE grid generation will be in a  C     usingSphericalPolarGrid :: If TRUE grid generation will be in a
# Line 264  C     setCenterDr    :: set cell-Center Line 284  C     setCenterDr    :: set cell-Center
284  C- Momentum params:  C- Momentum params:
285  C     no_slip_sides  :: Impose "no-slip" at lateral boundaries.  C     no_slip_sides  :: Impose "no-slip" at lateral boundaries.
286  C     no_slip_bottom :: Impose "no-slip" at bottom boundary.  C     no_slip_bottom :: Impose "no-slip" at bottom boundary.
287    C     bottomVisc_pCell :: account for partial-cell in bottom visc. (no-slip BC)
288  C     useSmag3D      :: Use isotropic 3-D Smagorinsky  C     useSmag3D      :: Use isotropic 3-D Smagorinsky
289  C     useFullLeith   :: Set to true to use full Leith viscosity(may be unstable  C     useFullLeith   :: Set to true to use full Leith viscosity(may be unstable
290  C                       on irregular grids)  C                       on irregular grids)
# Line 288  C     useJamartMomAdv :: Use wet-point m Line 309  C     useJamartMomAdv :: Use wet-point m
309  C     upwindVorticity :: bias interpolation of vorticity in the Coriolis term  C     upwindVorticity :: bias interpolation of vorticity in the Coriolis term
310  C     highOrderVorticity :: use 3rd/4th order interp. of vorticity (V.I., advection)  C     highOrderVorticity :: use 3rd/4th order interp. of vorticity (V.I., advection)
311  C     useAbsVorticity :: work with f+zeta in Coriolis terms  C     useAbsVorticity :: work with f+zeta in Coriolis terms
312  C     upwindShear        :: use 1rst order upwind interp. (V.I., vertical advection)  C     upwindShear     :: use 1rst order upwind interp. (V.I., vertical advection)
313  C     momStepping    :: Turns momentum equation time-stepping off  C     momStepping    :: Turns momentum equation time-stepping off
314  C     calc_wVelocity :: Turns of vertical velocity calculation off  C     calc_wVelocity :: Turns vertical velocity calculation off
315  C- Temp. & Salt params:  C- Temp. & Salt params:
316  C     tempStepping   :: Turns temperature equation time-stepping on/off  C     tempStepping   :: Turns temperature equation time-stepping on/off
317  C     saltStepping   :: Turns salinity equation time-stepping on/off  C     saltStepping   :: Turns salinity equation time-stepping on/off
# Line 323  C                            at the surf Line 344  C                            at the surf
344  C     useRealFreshWaterFlux :: if True (=Natural BCS), treats P+R-E flux  C     useRealFreshWaterFlux :: if True (=Natural BCS), treats P+R-E flux
345  C                         as a real Fresh Water (=> changes the Sea Level)  C                         as a real Fresh Water (=> changes the Sea Level)
346  C                         if F, converts P+R-E to salt flux (no SL effect)  C                         if F, converts P+R-E to salt flux (no SL effect)
347    C     storePhiHyd4Phys :: store hydrostatic potential for use in Physics/EOS
348    C                         this requires specific code for restart & exchange
349  C     quasiHydrostatic :: Using non-hydrostatic terms in hydrostatic algorithm  C     quasiHydrostatic :: Using non-hydrostatic terms in hydrostatic algorithm
350  C     nonHydrostatic   :: Using non-hydrostatic algorithm  C     nonHydrostatic   :: Using non-hydrostatic algorithm
351  C     use3Dsolver      :: set to true to use 3-D pressure solver  C     use3Dsolver      :: set to true to use 3-D pressure solver
352  C     implicitIntGravWave :: treat Internal Gravity Wave implicitly  C     implicitIntGravWave :: treat Internal Gravity Wave implicitly
353  C     staggerTimeStep   :: enable a Stagger time stepping U,V (& W) then T,S  C     staggerTimeStep   :: enable a Stagger time stepping U,V (& W) then T,S
354    C     applyExchUV_early :: Apply EXCH to U,V earlier, just before integr_continuity
355  C     doResetHFactors   :: Do reset thickness factors @ beginning of each time-step  C     doResetHFactors   :: Do reset thickness factors @ beginning of each time-step
356  C     implicitDiffusion :: Turns implicit vertical diffusion on  C     implicitDiffusion :: Turns implicit vertical diffusion on
357  C     implicitViscosity :: Turns implicit vertical viscosity on  C     implicitViscosity :: Turns implicit vertical viscosity on
358  C     tempImplVertAdv :: Turns on implicit vertical advection for Temperature  C     tempImplVertAdv   :: Turns on implicit vertical advection for Temperature
359  C     saltImplVertAdv :: Turns on implicit vertical advection for Salinity  C     saltImplVertAdv   :: Turns on implicit vertical advection for Salinity
360  C     momImplVertAdv  :: Turns on implicit vertical advection for Momentum  C     momImplVertAdv    :: Turns on implicit vertical advection for Momentum
361  C     multiDimAdvection :: Flag that enable multi-dimension advection  C     multiDimAdvection :: Flag that enable multi-dimension advection
362  C     useMultiDimAdvec  :: True if multi-dim advection is used at least once  C     useMultiDimAdvec  :: True if multi-dim advection is used at least once
363  C     momDissip_In_AB   :: if False, put Dissipation tendency contribution  C     momDissip_In_AB   :: if False, put Dissipation tendency contribution
# Line 374  C     printDomain     :: controls printi Line 398  C     printDomain     :: controls printi
398    
399        COMMON /PARM_L/        COMMON /PARM_L/
400       & fluidIsAir, fluidIsWater,       & fluidIsAir, fluidIsWater,
401       & usingPCoords, usingZCoords, useDynP_inEos_Zc,       & usingPCoords, usingZCoords,
402       & usingCartesianGrid, usingSphericalPolarGrid, rotateGrid,       & usingCartesianGrid, usingSphericalPolarGrid, rotateGrid,
403       & usingCylindricalGrid, usingCurvilinearGrid, hasWetCSCorners,       & usingCylindricalGrid, usingCurvilinearGrid, hasWetCSCorners,
404       & deepAtmosphere, setInterFDr, setCenterDr,       & deepAtmosphere, setInterFDr, setCenterDr,
405       & no_slip_sides, no_slip_bottom, useSmag3D,       & no_slip_sides, no_slip_bottom, bottomVisc_pCell, useSmag3D,
406       & useFullLeith, useStrainTensionVisc, useAreaViscLength,       & useFullLeith, useStrainTensionVisc, useAreaViscLength,
407       & momViscosity, momAdvection, momForcing,       & momViscosity, momAdvection, momForcing,
408       & momPressureForcing, metricTerms, useNHMTerms,       & momPressureForcing, metricTerms, useNHMTerms,
# Line 396  C     printDomain     :: controls printi Line 420  C     printDomain     :: controls printi
420       & rigidLid, implicitFreeSurface,       & rigidLid, implicitFreeSurface,
421       & uniformLin_PhiSurf, uniformFreeSurfLev,       & uniformLin_PhiSurf, uniformFreeSurfLev,
422       & exactConserv, linFSConserveTr, useRealFreshWaterFlux,       & exactConserv, linFSConserveTr, useRealFreshWaterFlux,
423       & quasiHydrostatic, nonHydrostatic, use3Dsolver,       & storePhiHyd4Phys, quasiHydrostatic, nonHydrostatic,
424       & implicitIntGravWave, staggerTimeStep, doResetHFactors,       & use3Dsolver, implicitIntGravWave, staggerTimeStep,
425         & applyExchUV_early, doResetHFactors,
426       & implicitDiffusion, implicitViscosity,       & implicitDiffusion, implicitViscosity,
427       & tempImplVertAdv, saltImplVertAdv, momImplVertAdv,       & tempImplVertAdv, saltImplVertAdv, momImplVertAdv,
428       & multiDimAdvection, useMultiDimAdvec,       & multiDimAdvection, useMultiDimAdvec,
# Line 419  C     printDomain     :: controls printi Line 444  C     printDomain     :: controls printi
444        LOGICAL fluidIsWater        LOGICAL fluidIsWater
445        LOGICAL usingPCoords        LOGICAL usingPCoords
446        LOGICAL usingZCoords        LOGICAL usingZCoords
       LOGICAL useDynP_inEos_Zc  
447        LOGICAL usingCartesianGrid        LOGICAL usingCartesianGrid
448        LOGICAL usingSphericalPolarGrid, rotateGrid        LOGICAL usingSphericalPolarGrid, rotateGrid
449        LOGICAL usingCylindricalGrid        LOGICAL usingCylindricalGrid
# Line 430  C     printDomain     :: controls printi Line 454  C     printDomain     :: controls printi
454    
455        LOGICAL no_slip_sides        LOGICAL no_slip_sides
456        LOGICAL no_slip_bottom        LOGICAL no_slip_bottom
457          LOGICAL bottomVisc_pCell
458        LOGICAL useSmag3D        LOGICAL useSmag3D
459        LOGICAL useFullLeith        LOGICAL useFullLeith
460        LOGICAL useStrainTensionVisc        LOGICAL useStrainTensionVisc
# Line 477  C     printDomain     :: controls printi Line 502  C     printDomain     :: controls printi
502        LOGICAL exactConserv        LOGICAL exactConserv
503        LOGICAL linFSConserveTr        LOGICAL linFSConserveTr
504        LOGICAL useRealFreshWaterFlux        LOGICAL useRealFreshWaterFlux
505          LOGICAL storePhiHyd4Phys
506        LOGICAL quasiHydrostatic        LOGICAL quasiHydrostatic
507        LOGICAL nonHydrostatic        LOGICAL nonHydrostatic
508        LOGICAL use3Dsolver        LOGICAL use3Dsolver
509        LOGICAL implicitIntGravWave        LOGICAL implicitIntGravWave
510        LOGICAL staggerTimeStep        LOGICAL staggerTimeStep
511          LOGICAL applyExchUV_early
512        LOGICAL doResetHFactors        LOGICAL doResetHFactors
513        LOGICAL implicitDiffusion        LOGICAL implicitDiffusion
514        LOGICAL implicitViscosity        LOGICAL implicitViscosity
# Line 542  C                :: most cell face (Lat- Line 569  C                :: most cell face (Lat-
569  C                :: parameter but it makes geographical references simple.)  C                :: parameter but it makes geographical references simple.)
570  C     ygOrigin   :: Origin of the Y-axis (Cartesian Grid) / Latitude of Southern  C     ygOrigin   :: Origin of the Y-axis (Cartesian Grid) / Latitude of Southern
571  C                :: most face (Lat-Lon grid).  C                :: most face (Lat-Lon grid).
572  C     gravity    :: Accel. due to gravity ( m/s^2 )  C     rSphere    :: Radius of sphere for a spherical polar grid ( m ).
573  C     recip_gravity and its inverse  C     recip_rSphere :: Reciprocal radius of sphere ( m^-1 ).
574    C     radius_fromHorizGrid :: sphere Radius of input horiz. grid (Curvilinear Grid)
575    C     seaLev_Z   :: the reference height of sea-level (usually zero)
576    C     top_Pres   :: pressure (P-Coords) or reference pressure (Z-Coords) at the top
577    C     rSigmaBnd  :: vertical position (in r-unit) of r/sigma transition (Hybrid-Sigma)
578    C     gravity    :: Acceleration due to constant gravity ( m/s^2 )
579    C     recip_gravity :: Reciprocal gravity acceleration ( s^2/m )
580  C     gBaro      :: Accel. due to gravity used in barotropic equation ( m/s^2 )  C     gBaro      :: Accel. due to gravity used in barotropic equation ( m/s^2 )
581    C     gravFacC   :: gravity factor (vs surf. gravity) vert. profile at cell-Center
582    C     gravFacF   :: gravity factor (vs surf. gravity) vert. profile at cell-interF
583  C     rhoNil     :: Reference density for the linear equation of state  C     rhoNil     :: Reference density for the linear equation of state
584  C     rhoConst   :: Vertically constant reference density (Boussinesq)  C     rhoConst   :: Vertically constant reference density (Boussinesq)
585  C     thetaConst :: Constant reference for potential temperature  C     rho1Ref    :: reference vertical profile for density (anelastic)
586  C     rhoFacC    :: normalized (by rhoConst) reference density at cell-Center  C     rhoFacC    :: normalized (by rhoConst) reference density at cell-Center
587  C     rhoFacF    :: normalized (by rhoConst) reference density at cell-interFace  C     rhoFacF    :: normalized (by rhoConst) reference density at cell-interFace
588  C     rhoConstFresh :: Constant reference density for fresh water (rain)  C     rhoConstFresh :: Constant reference density for fresh water (rain)
589  C     rho1Ref    :: reference vertical profile for density  C     thetaConst :: Constant reference for potential temperature
590  C     tRef       :: reference vertical profile for potential temperature  C     tRef       :: reference vertical profile for potential temperature
591  C     sRef       :: reference vertical profile for salinity/specific humidity  C     sRef       :: reference vertical profile for salinity/specific humidity
592  C     phiRef     :: reference potential (pressure/rho, geopotential) profile  C     pRef4EOS   :: reference pressure used in EOS (case selectP_inEOS_Zc=1)
593    C     phiRef     :: reference potential (press/rho, geopot) profile (m^2/s^2)
594  C     dBdrRef    :: vertical gradient of reference buoyancy  [(m/s/r)^2]:  C     dBdrRef    :: vertical gradient of reference buoyancy  [(m/s/r)^2]:
595  C                :: z-coord: = N^2_ref = Brunt-Vaissala frequency [s^-2]  C                :: z-coord: = N^2_ref = Brunt-Vaissala frequency [s^-2]
596  C                :: p-coord: = -(d.alpha/dp)_ref          [(m^2.s/kg)^2]  C                :: p-coord: = -(d.alpha/dp)_ref          [(m^2.s/kg)^2]
# Line 572  C     rUnit2mass :: units conversion fac Line 608  C     rUnit2mass :: units conversion fac
608  C                :: from vertical r-coordinate unit to mass per unit area [kg/m2].  C                :: from vertical r-coordinate unit to mass per unit area [kg/m2].
609  C                :: z-coord: = rhoConst  ( [m] * rho = [kg/m2] ) ;  C                :: z-coord: = rhoConst  ( [m] * rho = [kg/m2] ) ;
610  C                :: p-coord: = 1/gravity ( [Pa] /  g = [kg/m2] ) ;  C                :: p-coord: = 1/gravity ( [Pa] /  g = [kg/m2] ) ;
 C     rSphere    :: Radius of sphere for a spherical polar grid ( m ).  
 C     recip_rSphere  :: Reciprocal radius of sphere ( m ).  
 C     radius_fromHorizGrid :: sphere Radius of input horiz. grid (Curvilinear Grid)  
611  C     f0         :: Reference coriolis parameter ( 1/s )  C     f0         :: Reference coriolis parameter ( 1/s )
612  C                   ( Southern edge f for beta plane )  C                   ( Southern edge f for beta plane )
613  C     beta       :: df/dy ( s^-1.m^-1 )  C     beta       :: df/dy ( s^-1.m^-1 )
# Line 669  C     alph_AB      :: Adams-Bashforth-3 Line 702  C     alph_AB      :: Adams-Bashforth-3
702  C     beta_AB      :: Adams-Bashforth-3 secondary factor  C     beta_AB      :: Adams-Bashforth-3 secondary factor
703  C     implicSurfPress :: parameter of the Crank-Nickelson time stepping :  C     implicSurfPress :: parameter of the Crank-Nickelson time stepping :
704  C                     Implicit part of Surface Pressure Gradient ( 0-1 )  C                     Implicit part of Surface Pressure Gradient ( 0-1 )
705  C     implicDiv2Dflow :: parameter of the Crank-Nickelson time stepping :  C     implicDiv2DFlow :: parameter of the Crank-Nickelson time stepping :
706  C                     Implicit part of barotropic flow Divergence ( 0-1 )  C                     Implicit part of barotropic flow Divergence ( 0-1 )
707  C     implicitNHPress :: parameter of the Crank-Nickelson time stepping :  C     implicitNHPress :: parameter of the Crank-Nickelson time stepping :
708  C                     Implicit part of Non-Hydrostatic Pressure Gradient ( 0-1 )  C                     Implicit part of Non-Hydrostatic Pressure Gradient ( 0-1 )
# Line 726  C     hMixCriteria:: criteria for mixed- Line 759  C     hMixCriteria:: criteria for mixed-
759  C     dRhoSmall   :: parameter for mixed-layer diagnostic  C     dRhoSmall   :: parameter for mixed-layer diagnostic
760  C     hMixSmooth  :: Smoothing parameter for mixed-layer diag (default=0=no smoothing)  C     hMixSmooth  :: Smoothing parameter for mixed-layer diag (default=0=no smoothing)
761  C     ivdc_kappa  :: implicit vertical diffusivity for convection [m^2/s]  C     ivdc_kappa  :: implicit vertical diffusivity for convection [m^2/s]
 C     Ro_SeaLevel :: standard position of Sea-Level in "R" coordinate, used as  
 C                    starting value (k=1) for vertical coordinate (rf(1)=Ro_SeaLevel)  
 C     rSigmaBnd   :: vertical position (in r-unit) of r/sigma transition (Hybrid-Sigma)  
762  C     sideDragFactor     :: side-drag scaling factor (used only if no_slip_sides)  C     sideDragFactor     :: side-drag scaling factor (used only if no_slip_sides)
763  C                           (default=2: full drag ; =1: gives half-slip BC)  C                           (default=2: full drag ; =1: gives half-slip BC)
764  C     bottomDragLinear    :: Linear    bottom-drag coefficient (units of [r]/s)  C     bottomDragLinear    :: Linear    bottom-drag coefficient (units of [r]/s)
# Line 746  C     thetaEuler    :: Euler angle, rota Line 776  C     thetaEuler    :: Euler angle, rota
776  C     psiEuler      :: Euler angle, rotation about new z-axis  C     psiEuler      :: Euler angle, rotation about new z-axis
777        COMMON /PARM_R/ cg2dTargetResidual, cg2dTargetResWunit,        COMMON /PARM_R/ cg2dTargetResidual, cg2dTargetResWunit,
778       & cg2dpcOffDFac, cg3dTargetResidual,       & cg2dpcOffDFac, cg3dTargetResidual,
779       & delR, delRc, xgOrigin, ygOrigin,       & delR, delRc, xgOrigin, ygOrigin, rSphere, recip_rSphere,
780         & radius_fromHorizGrid, seaLev_Z, top_Pres, rSigmaBnd,
781       & deltaT, deltaTMom, dTtracerLev, deltaTFreeSurf, deltaTClock,       & deltaT, deltaTMom, dTtracerLev, deltaTFreeSurf, deltaTClock,
782       & abEps, alph_AB, beta_AB,       & abEps, alph_AB, beta_AB,
      & rSphere, recip_rSphere, radius_fromHorizGrid,  
783       & f0, beta, fPrime, omega, rotationPeriod,       & f0, beta, fPrime, omega, rotationPeriod,
784       & viscFacAdj, viscAh, viscAhW, smag3D_coeff,       & viscFacAdj, viscAh, viscAhW, smag3D_coeff,
785       & viscAhMax, viscAhGrid, viscAhGridMax, viscAhGridMin,       & viscAhMax, viscAhGrid, viscAhGridMax, viscAhGridMin,
# Line 766  C     psiEuler      :: Euler angle, rota Line 796  C     psiEuler      :: Euler angle, rota
796       & BL79LatVary,       & BL79LatVary,
797       & diffKrBLEQsurf, diffKrBLEQdeep, diffKrBLEQscl, diffKrBLEQHo,       & diffKrBLEQsurf, diffKrBLEQdeep, diffKrBLEQscl, diffKrBLEQHo,
798       & tauCD, rCD, epsAB_CD,       & tauCD, rCD, epsAB_CD,
799       & freeSurfFac, implicSurfPress, implicDiv2Dflow, implicitNHPress,       & freeSurfFac, implicSurfPress, implicDiv2DFlow, implicitNHPress,
800       & hFacMin, hFacMinDz, hFacInf, hFacSup,       & hFacMin, hFacMinDz, hFacInf, hFacSup,
801       & gravity, recip_gravity, gBaro,       & gravity, recip_gravity, gBaro,
802       & rhoNil, rhoConst, recip_rhoConst, thetaConst,       & gravFacC, recip_gravFacC, gravFacF, recip_gravFacF,
803       & rhoFacC, recip_rhoFacC, rhoFacF, recip_rhoFacF,       & rhoNil, rhoConst, recip_rhoConst, rho1Ref,
804       & rhoConstFresh, rho1Ref, tRef, sRef, phiRef, dBdrRef,       & rhoFacC, recip_rhoFacC, rhoFacF, recip_rhoFacF, rhoConstFresh,
805         & thetaConst, tRef, sRef, pRef4EOS, phiRef, dBdrRef,
806       & rVel2wUnit, wUnit2rVel, mass2rUnit, rUnit2mass,       & rVel2wUnit, wUnit2rVel, mass2rUnit, rUnit2mass,
807       & baseTime, startTime, endTime,       & baseTime, startTime, endTime,
808       & chkPtFreq, pChkPtFreq, dumpFreq, adjDumpFreq,       & chkPtFreq, pChkPtFreq, dumpFreq, adjDumpFreq,
# Line 783  C     psiEuler      :: Euler angle, rota Line 814  C     psiEuler      :: Euler angle, rota
814       & convertFW2Salt, temp_EvPrRn, salt_EvPrRn,       & convertFW2Salt, temp_EvPrRn, salt_EvPrRn,
815       & temp_addMass, salt_addMass, hFacMinDr, hFacMinDp,       & temp_addMass, salt_addMass, hFacMinDr, hFacMinDp,
816       & ivdc_kappa, hMixCriteria, dRhoSmall, hMixSmooth,       & ivdc_kappa, hMixCriteria, dRhoSmall, hMixSmooth,
      & Ro_SeaLevel, rSigmaBnd,  
817       & sideDragFactor, bottomDragLinear, bottomDragQuadratic, nh_Am2,       & sideDragFactor, bottomDragLinear, bottomDragQuadratic, nh_Am2,
818       & smoothAbsFuncRange,       & smoothAbsFuncRange,
819       & tCylIn, tCylOut,       & tCylIn, tCylOut,
# Line 797  C     psiEuler      :: Euler angle, rota Line 827  C     psiEuler      :: Euler angle, rota
827        _RL delRc(Nr+1)        _RL delRc(Nr+1)
828        _RL xgOrigin        _RL xgOrigin
829        _RL ygOrigin        _RL ygOrigin
830          _RL rSphere
831          _RL recip_rSphere
832          _RL radius_fromHorizGrid
833          _RL seaLev_Z
834          _RL top_Pres
835          _RL rSigmaBnd
836        _RL deltaT        _RL deltaT
837        _RL deltaTClock        _RL deltaTClock
838        _RL deltaTMom        _RL deltaTMom
839        _RL dTtracerLev(Nr)        _RL dTtracerLev(Nr)
840        _RL deltaTFreeSurf        _RL deltaTFreeSurf
841        _RL abEps, alph_AB, beta_AB        _RL abEps, alph_AB, beta_AB
       _RL rSphere  
       _RL recip_rSphere  
       _RL radius_fromHorizGrid  
842        _RL f0        _RL f0
843        _RL beta        _RL beta
844        _RL fPrime        _RL fPrime
# Line 813  C     psiEuler      :: Euler angle, rota Line 846  C     psiEuler      :: Euler angle, rota
846        _RL rotationPeriod        _RL rotationPeriod
847        _RL freeSurfFac        _RL freeSurfFac
848        _RL implicSurfPress        _RL implicSurfPress
849        _RL implicDiv2Dflow        _RL implicDiv2DFlow
850        _RL implicitNHPress        _RL implicitNHPress
851        _RL hFacMin        _RL hFacMin
852        _RL hFacMinDz        _RL hFacMinDz
# Line 862  C     psiEuler      :: Euler angle, rota Line 895  C     psiEuler      :: Euler angle, rota
895        _RL diffKrBLEQscl        _RL diffKrBLEQscl
896        _RL diffKrBLEQHo        _RL diffKrBLEQHo
897        _RL tauCD, rCD, epsAB_CD        _RL tauCD, rCD, epsAB_CD
898        _RL gravity        _RL gravity,       recip_gravity
       _RL recip_gravity  
899        _RL gBaro        _RL gBaro
900          _RL gravFacC(Nr),   recip_gravFacC(Nr)
901          _RL gravFacF(Nr+1), recip_gravFacF(Nr+1)
902        _RL rhoNil        _RL rhoNil
903        _RL rhoConst,      recip_rhoConst        _RL rhoConst,      recip_rhoConst
904        _RL thetaConst        _RL rho1Ref(Nr)
905        _RL rhoFacC(Nr),   recip_rhoFacC(Nr)        _RL rhoFacC(Nr),   recip_rhoFacC(Nr)
906        _RL rhoFacF(Nr+1), recip_rhoFacF(Nr+1)        _RL rhoFacF(Nr+1), recip_rhoFacF(Nr+1)
907        _RL rhoConstFresh        _RL rhoConstFresh
908        _RL rho1Ref(Nr)        _RL thetaConst
909        _RL tRef(Nr)        _RL tRef(Nr)
910        _RL sRef(Nr)        _RL sRef(Nr)
911          _RL pRef4EOS(Nr)
912        _RL phiRef(2*Nr+1)        _RL phiRef(2*Nr+1)
913        _RL dBdrRef(Nr)        _RL dBdrRef(Nr)
914        _RL rVel2wUnit(Nr+1), wUnit2rVel(Nr+1)        _RL rVel2wUnit(Nr+1), wUnit2rVel(Nr+1)
# Line 912  C     psiEuler      :: Euler angle, rota Line 947  C     psiEuler      :: Euler angle, rota
947        _RL hMixCriteria        _RL hMixCriteria
948        _RL dRhoSmall        _RL dRhoSmall
949        _RL hMixSmooth        _RL hMixSmooth
       _RL Ro_SeaLevel  
       _RL rSigmaBnd  
950        _RL sideDragFactor        _RL sideDragFactor
951        _RL bottomDragLinear        _RL bottomDragLinear
952        _RL bottomDragQuadratic        _RL bottomDragQuadratic
# Line 965  C Logical flags for selecting packages Line 998  C Logical flags for selecting packages
998        LOGICAL useBulkForce        LOGICAL useBulkForce
999        LOGICAL useEBM        LOGICAL useEBM
1000        LOGICAL useCheapAML        LOGICAL useCheapAML
1001          LOGICAL useAUTODIFF
1002        LOGICAL useGrdchk        LOGICAL useGrdchk
1003        LOGICAL useSMOOTH        LOGICAL useSMOOTH
1004        LOGICAL usePROFILES        LOGICAL usePROFILES
# Line 1000  C Logical flags for selecting packages Line 1034  C Logical flags for selecting packages
1034        COMMON /PARM_PACKAGES/        COMMON /PARM_PACKAGES/
1035       &        useGAD, useOBCS, useSHAP_FILT, useZONAL_FILT,       &        useGAD, useOBCS, useSHAP_FILT, useZONAL_FILT,
1036       &        useOPPS, usePP81, useKL10, useMY82, useGGL90, useKPP,       &        useOPPS, usePP81, useKL10, useMY82, useGGL90, useKPP,
1037       &        useGMRedi, useBBL, useDOWN_SLOPE, useCTRL,       &        useGMRedi, useBBL, useDOWN_SLOPE,
1038       &        useCAL, useEXF, useBulkForce, useEBM, useCheapAML,       &        useCAL, useEXF, useBulkForce, useEBM, useCheapAML,
1039       &        useGrdchk,useSMOOTH,usePROFILES,useECCO,useSBO, useFLT,       &        useGrdchk, useSMOOTH, usePROFILES, useECCO, useCTRL,
1040         &        useSBO, useFLT, useAUTODIFF,
1041       &        usePTRACERS, useGCHEM, useRBCS, useOffLine, useMATRIX,       &        usePTRACERS, useGCHEM, useRBCS, useOffLine, useMATRIX,
1042       &        useFRAZIL, useSEAICE, useSALT_PLUME, useShelfIce,       &        useFRAZIL, useSEAICE, useSALT_PLUME, useShelfIce,
1043       &        useStreamIce, useICEFRONT, useThSIce, useLand,       &        useStreamIce, useICEFRONT, useThSIce, useLand,

Legend:
Removed from v.1.277  
changed lines
  Added in v.1.284

  ViewVC Help
Powered by ViewVC 1.1.22