--- MITgcm/model/inc/PARAMS.h 2005/08/24 23:08:35 1.164 +++ MITgcm/model/inc/PARAMS.h 2006/12/28 01:46:30 1.193 @@ -1,4 +1,4 @@ -C $Header: /home/ubuntu/mnt/e9_copy/MITgcm/model/inc/PARAMS.h,v 1.164 2005/08/24 23:08:35 jmc Exp $ +C $Header: /home/ubuntu/mnt/e9_copy/MITgcm/model/inc/PARAMS.h,v 1.193 2006/12/28 01:46:30 jmc Exp $ C $Name: $ C @@ -36,9 +36,9 @@ PARAMETER ( UNSET_FLOAT8 = 1.234567D5 ) Real*4 UNSET_FLOAT4 PARAMETER ( UNSET_FLOAT4 = 1.234567E5 ) - _RL UNSET_RL + _RL UNSET_RL PARAMETER ( UNSET_RL = 1.234567D5 ) - _RS UNSET_RS + _RS UNSET_RS PARAMETER ( UNSET_RS = 1.234567E5 ) INTEGER UNSET_I PARAMETER ( UNSET_I = 123456789 ) @@ -49,14 +49,21 @@ C-- COMMON /PARM_C/ Character valued parameters used by the model. C checkPtSuff :: List of checkpoint file suffices +C tRefFile :: File containing reference Potential Temperat. tRef (1.D) +C sRefFile :: File containing reference salinity/spec.humid. sRef (1.D) +C rhoRefFile :: File containing reference density profile rhoRef (1.D) +C delRFile :: File containing vertical grid spacing delR (1.D array) +C delRcFile :: File containing vertical grid spacing delRc (1.D array) C delXFile :: File containing X-spacing grid definition (1.D array) C delYFile :: File containing Y-spacing grid definition (1.D array) -C horizGridFile :: File containing horizontal-grid definition +C horizGridFile :: File containing horizontal-grid definition C (only when using curvilinear_grid) C bathyFile :: File containing bathymetry. If not defined bathymetry C is taken from inline function. C topoFile :: File containing the topography of the surface (unit=m) C (mainly used for the atmosphere = ground height). +C shelfIceFile:: File containing the topography of the shelfice draught +C (unit=m) C hydrogThetaFile :: File containing initial hydrographic data for potential C temperature. C hydrogSaltFile :: File containing initial hydrographic data for salinity. @@ -82,8 +89,10 @@ C LINEAR, POLY3, UNESCO, JMD95Z, JMD95P, MDJWF, IDEALGAS C the_run_name :: string identifying the name of the model "run" COMMON /PARM_C/ checkPtSuff, + & tRefFile, sRefFile, rhoRefFile, + & delRFile, delRcFile, & delXFile, delYFile, horizGridFile, - & bathyFile, topoFile, + & bathyFile, topoFile, shelfIceFile, & hydrogThetaFile, hydrogSaltFile, & zonalWindFile, meridWindFile, thetaClimFile, & saltClimFile, buoyancyRelation, @@ -94,13 +103,18 @@ & dQdTfile, ploadFile, & eddyTauxFile, eddyTauyFile, & eosType, pickupSuff, - & mdsioLocalDir, + & mdsioLocalDir, & the_run_name CHARACTER*(5) checkPtSuff(maxNoChkptLev) + CHARACTER*(MAX_LEN_FNAM) tRefFile + CHARACTER*(MAX_LEN_FNAM) sRefFile + CHARACTER*(MAX_LEN_FNAM) rhoRefFile + CHARACTER*(MAX_LEN_FNAM) delRFile + CHARACTER*(MAX_LEN_FNAM) delRcFile CHARACTER*(MAX_LEN_FNAM) delXFile CHARACTER*(MAX_LEN_FNAM) delYFile CHARACTER*(MAX_LEN_FNAM) horizGridFile - CHARACTER*(MAX_LEN_FNAM) bathyFile, topoFile + CHARACTER*(MAX_LEN_FNAM) bathyFile, topoFile, shelfIceFile CHARACTER*(MAX_LEN_FNAM) hydrogThetaFile CHARACTER*(MAX_LEN_FNAM) hydrogSaltFile CHARACTER*(MAX_LEN_FNAM) zonalWindFile @@ -123,7 +137,7 @@ CHARACTER*(MAX_LEN_FNAM) lambdaThetaFile CHARACTER*(MAX_LEN_FNAM) lambdaSaltFile CHARACTER*(MAX_LEN_FNAM) mdsioLocalDir - CHARACTER*(MAX_LEN_FNAM) the_run_name + CHARACTER*(MAX_LEN_PREC/2) the_run_name CHARACTER*(6) eosType CHARACTER*(10) pickupSuff @@ -150,10 +164,15 @@ C =0 Linear free surface ; >0 Non-linear C select_rStar :: option related to r* vertical coordinate C =0 (default) use r coord. ; > 0 use r* +C momForcingOutAB :: =1: take momentum forcing contribution +C out of (=0: in) Adams-Bashforth time stepping. +C tracForcingOutAB :: =1: take tracer (Temp,Salt,pTracers) forcing contribution +C out of (=0: in) Adams-Bashforth time stepping. C tempAdvScheme :: Temp. Horiz.Advection scheme selector -C tempVertAdvScheme :: Temp. Vert. Advection scheme selector +C tempVertAdvScheme :: Temp. Vert. Advection scheme selector C saltAdvScheme :: Salt. Horiz.advection scheme selector C saltVertAdvScheme :: Salt. Vert. Advection scheme selector +C selectKEscheme :: Kinetic Energy scheme selector (Vector Inv.) C debugLevel :: debug level selector: higher -> more writing COMMON /PARM_I/ @@ -166,8 +185,10 @@ & writeStatePrec, nCheckLev, & writeBinaryPrec, readBinaryPrec, & nonlinFreeSurf, select_rStar, + & momForcingOutAB, tracForcingOutAB, & tempAdvScheme, tempVertAdvScheme, & saltAdvScheme, saltVertAdvScheme, + & selectKEscheme, & debugLevel INTEGER cg2dMaxIters INTEGER cg2dChkResFreq @@ -184,8 +205,10 @@ INTEGER nCheckLev INTEGER nonlinFreeSurf INTEGER select_rStar + INTEGER momForcingOutAB, tracForcingOutAB INTEGER tempAdvScheme, tempVertAdvScheme INTEGER saltAdvScheme, saltVertAdvScheme + INTEGER selectKEscheme INTEGER debugLevel C @@ -202,9 +225,10 @@ C usingSphericalPolarGrid :: If TRUE grid generation will be in a C spherical polar frame. C usingCylindricalGrid :: If TRUE grid generation will be Cylindrical +C usingCurvilinearGrid :: If TRUE, use a curvilinear grid (to be provided) +C deepAtmosphere :: deep model (drop the shallow-atmosphere approximation) C no_slip_sides :: Impose "no-slip" at lateral boundaries. C no_slip_bottom :: Impose "no-slip" at bottom boundary. -C staggerTimeStep :: enable a Stagger time stepping T,S Rho then U,V C momViscosity :: Flag which turns momentum friction terms on and off. C momAdvection :: Flag which turns advection of momentum on and off. C momForcing :: Flag which turns external forcing of momentum on @@ -212,8 +236,7 @@ C momPressureForcing :: Flag which turns pressure term in momentum equation C on and off. C metricTerms :: Flag which turns metric terms on or off. -C usingSphericalPolarMTerms :: If TRUE use spherical polar metric terms. -C useNHMTerms :: If TRUE use non-hydrostatic metric terms. +C useNHMTerms :: If TRUE use non-hydrostatic metric terms. C useCoriolis :: Flag which turns the coriolis terms on and off. C tempAdvection :: Flag which turns advection of temperature on C and off. @@ -226,22 +249,26 @@ C useRealFreshWaterFlux :: if True (=Natural BCS), treats P+R-E flux C as a real Fresh Water (=> changes the Sea Level) C if F, converts P+R-E to salt flux (no SL effect) -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 C on irregular grids) -C useAnisotropicViscAGridMax :: Set to true to use Alistair's latest -C anisotropic length scale. It is used only for maximum viscosity -C calculations. Alistair recommends a value of viscA*GridMax=.25 +C useAreaViscLength :: Set to true to use old scaling for viscous +C lengths, e.g., L2=Raz. May be preferable for cube sphere. +C useStrainTensionVisc:: Set to true to use Strain-Tension viscous terms C rigidLid :: Set to true to use rigid lid -C implicitFreeSurface :: Set to true to use implcit free surface +C implicitFreeSurface :: Set to true to use implicit free surface C exactConserv :: Set to true to conserve exactly the total Volume C uniformLin_PhiSurf :: Set to true to use a uniform Bo_surf in the C linear relation Phi_surf = Bo_surf*eta +C use3Dsolver :: set to true to use 3-D pressure solver +C implicitIntGravWave :: treat Internal Gravity Wave implicitly +C staggerTimeStep :: enable a Stagger time stepping T,S Rho then U,V C momStepping :: Turns momentum equation time-stepping off C tempStepping :: Turns temperature equation time-stepping off C saltStepping :: Turns salinity equation time-stepping off C useConstantF :: Coriolis parameter set to f0 C useBetaPlaneF :: Coriolis parameter set to f0 + beta.y C useSphereF :: Coriolis parameter set to 2.omega.sin(phi) +C use3dCoriolis :: Turns the 3-D coriolis terms (in Omega.cos Phi) on - off C useCDscheme :: use CD-scheme to calculate Coriolis terms. C useJamartWetPoints :: Use wet-point method for Coriolis (Jamart and Ozer, 1986) C useJamartMomAdv :: Use wet-point method for V.I. non-linear term @@ -257,8 +284,10 @@ C momImplVertAdv :: Turns on implicit vertical advection for Momentum C multiDimAdvection :: Flag that enable multi-dimension advection C useMultiDimAdvec :: True if multi-dim advection is used at least once -C forcing_In_AB :: if False, put forcing (Temp,Salt,Tracers) contribution -C out off Adams-Bashforth time stepping. +C momDissip_In_AB :: if False, put Dissipation tendency contribution +C out off Adams-Bashforth time stepping. +C doAB_onGtGs :: if the Adams-Bashforth time stepping is used, always +C apply AB on tracer tendencies (rather than on Tracer) C startFromPickupAB2 :: with AB-3 code, start from an AB-2 pickup C doThetaClimRelax :: Set true if relaxation to temperature C climatology is required. @@ -275,7 +304,8 @@ C is water C useDynP_inEos_Zc :: use the dynamical pressure in EOS (with Z-coord.) C this requires specific code for restart & exchange -C setCenterDr :: set cell Center depth and put Interface at the middle +C setInterFDr :: set Interface depth (put cell-Center at the middle) +C setCenterDr :: set cell-Center depth (put Interface at the middle) C nonHydrostatic :: Using non-hydrostatic terms C quasiHydrostatic :: Using non-hydrostatic terms in hydrostatic algorithm C globalFiles :: Selects between "global" and "tiled" files @@ -291,37 +321,40 @@ C timeave_mdsio :: use mdsio for timeave output C snapshot_mdsio :: use mdsio for "snapshot" (dumpfreq/diagfreq) output C monitor_stdio :: use stdio for monitor output -C calendarDumps :: When set, approximate months (30-31 days) and years (360-372 days) -C for parameters chkPtFreq, pChkPtFreq, taveFreq, SEAICE_taveFreq, -C KPP_taveFreq, and freq in pkg/diagnostics are converted to exact -C calendar months and years. Requires pkg/cal. C dumpInitAndLast :: dumps model state to files at Initial (nIter0) C & Last iteration, in addition multiple of dumpFreq iter. +C balanceEmPmR :: substract global mean of EmPmR at every time step +C balanceQnet :: substract global mean of Qnet at every time step +C balancePrintMean:: print substracted global means to STDOUT + COMMON /PARM_L/ usingCartesianGrid, usingSphericalPolarGrid, & usingCurvilinearGrid, usingCylindricalGrid, + & deepAtmosphere, setInterFDr, setCenterDr, & no_slip_sides,no_slip_bottom, - & staggerTimeStep, - & momViscosity, momAdvection, momForcing, useCoriolis, + & momViscosity, momAdvection, momForcing, useCoriolis, & momPressureForcing, vectorInvariantMomentum, & tempAdvection, tempForcing, & saltAdvection, saltForcing, & useRealFreshWaterFlux, - & useFullLeith, useAnisotropicViscAGridMax, + & useFullLeith, useStrainTensionVisc, + & useAreaViscLength, & rigidLid, implicitFreeSurface, exactConserv, uniformLin_PhiSurf, + & use3Dsolver, implicitIntGravWave, staggerTimeStep, & momStepping, tempStepping, saltStepping, - & metricTerms, usingSphericalPolarMTerms, useNHMTerms, - & useConstantF, useBetaPlaneF, useSphereF, + & metricTerms, useNHMTerms, + & useConstantF, useBetaPlaneF, useSphereF, use3dCoriolis, & useCDscheme, & useEnergyConservingCoriolis, useJamartWetPoints, useJamartMomAdv, & SadournyCoriolis, upwindVorticity, highOrderVorticity, & useAbsVorticity, upwindShear, & implicitDiffusion, implicitViscosity, & tempImplVertAdv, saltImplVertAdv, momImplVertAdv, - & multiDimAdvection, useMultiDimAdvec, forcing_In_AB, - & doThetaClimRelax, doSaltClimRelax, doTr1ClimRelax, - & periodicExternalForcing, + & multiDimAdvection, useMultiDimAdvec, + & momDissip_In_AB, doAB_onGtGs, + & doThetaClimRelax, doSaltClimRelax, doTr1ClimRelax, + & periodicExternalForcing, & fluidIsAir, fluidIsWater, - & usingPCoords, usingZCoords, useDynP_inEos_Zc, setCenterDr, + & usingPCoords, usingZCoords, useDynP_inEos_Zc, & nonHydrostatic, quasiHydrostatic, globalFiles, useSingleCpuIO, & allowFreezing, useOldFreezing, & usePickupBeforeC35, usePickupBeforeC54, startFromPickupAB2, @@ -329,17 +362,18 @@ & timeave_mdsio, snapshot_mdsio, monitor_stdio, & outputTypesInclusive, dumpInitAndLast, debugMode, & inAdMode, inAdTrue, inAdFalse, inAdExact, - & calendarDumps + & balanceEmPmR, balanceQnet, balancePrintMean LOGICAL usingCartesianGrid LOGICAL usingSphericalPolarGrid LOGICAL usingCylindricalGrid LOGICAL usingCurvilinearGrid - LOGICAL usingSphericalPolarMTerms + LOGICAL deepAtmosphere + LOGICAL setInterFDr + LOGICAL setCenterDr LOGICAL useNHMTerms LOGICAL no_slip_sides LOGICAL no_slip_bottom - LOGICAL staggerTimeStep LOGICAL momViscosity LOGICAL momAdvection LOGICAL momForcing @@ -351,11 +385,16 @@ LOGICAL saltAdvection LOGICAL saltForcing LOGICAL useRealFreshWaterFlux - LOGICAL useFullLeith, useAnisotropicViscAGridMax + LOGICAL useFullLeith + LOGICAL useStrainTensionVisc + LOGICAL useAreaViscLength LOGICAL rigidLid LOGICAL implicitFreeSurface LOGICAL exactConserv LOGICAL uniformLin_PhiSurf + LOGICAL use3Dsolver + LOGICAL implicitIntGravWave + LOGICAL staggerTimeStep LOGICAL momStepping LOGICAL tempStepping LOGICAL saltStepping @@ -363,6 +402,7 @@ LOGICAL useConstantF LOGICAL useBetaPlaneF LOGICAL useSphereF + LOGICAL use3dCoriolis LOGICAL useCDscheme LOGICAL useEnergyConservingCoriolis LOGICAL useJamartWetPoints @@ -374,12 +414,13 @@ LOGICAL upwindShear LOGICAL implicitDiffusion LOGICAL implicitViscosity - LOGICAL tempImplVertAdv - LOGICAL saltImplVertAdv + LOGICAL tempImplVertAdv + LOGICAL saltImplVertAdv LOGICAL momImplVertAdv LOGICAL multiDimAdvection LOGICAL useMultiDimAdvec - LOGICAL forcing_In_AB + LOGICAL momDissip_In_AB + LOGICAL doAB_onGtGs LOGICAL doThetaClimRelax LOGICAL doSaltClimRelax LOGICAL doTr1ClimRelax @@ -389,7 +430,6 @@ LOGICAL usingPCoords LOGICAL usingZCoords LOGICAL useDynP_inEos_Zc - LOGICAL setCenterDr LOGICAL nonHydrostatic LOGICAL quasiHydrostatic LOGICAL globalFiles @@ -406,7 +446,10 @@ LOGICAL timeave_mdsio, snapshot_mdsio, monitor_stdio LOGICAL outputTypesInclusive LOGICAL inAdMode, inAdTrue, inAdFalse, inAdExact - LOGICAL calendarDumps + + LOGICAL balanceEmPmR + LOGICAL balanceQnet + LOGICAL balancePrintMean C-- COMMON /PARM_R/ "Real" valued parameters used by the model. C cg2dTargetResidual @@ -437,16 +480,22 @@ C recip_gravity and its inverse C gBaro :: Accel. due to gravity used in barotropic equation ( m/s^2 ) C rhoNil :: Reference density for the linear equation of state -C rhoConst :: Vertically constant reference density +C rhoConst :: Vertically constant reference density +C rhoFacC :: normalized (by rhoConst) reference density at cell-Center +C rhoFacF :: normalized (by rhoConst) reference density at cell-interFace C rhoConstFresh :: Constant reference density for fresh water (rain) C tRef :: reference vertical profile for potential temperature -C sRef :: reference vertical profile for salinity/specific humidity +C sRef :: reference vertical profile for salinity/specific humidity +C phiRef :: reference potential (pressure/rho, geopotential) profile +C dBdrRef :: vertical gradient of reference boyancy [(m/s/r)^2)]: +C :: z-coord: = N^2_ref = Brunt-Vaissala frequency [s^-2] +C :: p-coord: = -(d.alpha/dp)_ref [(m^2.s/kg)^2] C phiMin :: Latitude of southern most cell face. C thetaMin :: Longitude of western most cell face (this C is an "inert" parameter but it is included C to make geographical references simple.) C rSphere :: Radius of sphere for a spherical polar grid ( m ). -C recip_RSphere :: Reciprocal radius of sphere ( m ). +C recip_rSphere :: Reciprocal radius of sphere ( m ). C f0 :: Reference coriolis parameter ( 1/s ) C ( Southern edge f for beta plane ) C beta :: df/dy ( s^-1.m^-1 ) @@ -457,6 +506,7 @@ C viscAhW :: Eddy viscosity coeff. for mixing of vertical C momentum laterally, no effect for hydrostatic C model, defaults to viscAh if unset ( m^2/s ) +C Not used if variable horiz. viscosity is used. C viscAr :: Eddy viscosity coeff. for mixing of C momentum vertically ( units of r^2/s ) C viscA4 :: Biharmonic viscosity coeff. for mixing of @@ -464,6 +514,7 @@ C viscA4W :: Biharmonic viscosity coeff. for mixing of vertical C momentum laterally, no effect for hydrostatic C model, defaults to viscA4 if unset ( m^2/s ) +C Not used if variable horiz. viscosity is used. C viscAhD :: Eddy viscosity coeff. for mixing of momentum laterally C (act on Divergence part) ( m^2/s ) C viscAhZ :: Eddy viscosity coeff. for mixing of momentum laterally @@ -473,14 +524,19 @@ C viscA4Z :: Biharmonic viscosity coeff. for mixing of momentum laterally C (act on Vorticity part) ( m^4/s ) C viscC2leith :: Leith non-dimensional viscosity factor (grad(vort)) -C viscC2leithD :: Modified Leith non-dimensional viscosity factor (grad(div)) -C viscC2smag :: Smagorinsky non-dimensional viscosity factor +C viscC2leithD :: Modified Leith non-dimensional visc. factor (grad(div)) +C viscC2smag :: Smagorinsky non-dimensional viscosity factor (harmonic) +C viscC4smag :: Smagorinsky non-dimensional viscosity factor (biharmonic) C viscAhMax :: Maximum eddy viscosity coeff. for mixing of -C momentum laterally ( m^2/s ) +C momentum laterally ( m^2/s ) +C viscAhReMax :: Maximum gridscale Reynolds number for eddy viscosity +C coeff. for mixing of momentum laterally (non-dim) C viscAhGridMax:: maximum and minimum harmonic viscosity coefficients ... -C viscAhGridMin:: in terms of non-dimensional grid-size dependent viscosity +C viscAhGridMin:: in terms of non-dimensional grid-size dependent visc. C viscA4Max :: Maximum biharmonic viscosity coeff. for mixing of C momentum laterally ( m^4/s ) +C viscA4ReMax :: Maximum Gridscale Reynolds number for +C biharmonic viscosity coeff. momentum laterally (non-dim) C viscAhGrid:: non-dimensional grid-size dependent viscosity C viscA4Grid:: non-dimensional grid-size dependent bi-harmonic viscosity C viscA4GridMax:: maximum and minimum biharmonic viscosity coefficients ... @@ -574,9 +630,17 @@ C ( g*rho if horiz in m and vertical in Pa ). 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 bottomDragLinear :: Drag coefficient built in to core dynamics -C --"-"-- Quadratic ( linear: 1/s, quadratic: 1/m ) - COMMON /PARM_R/ cg2dTargetResidual, cg2dTargetResWunit, +C sideDragFactor :: side-drag scaling factor (used only if no_slip_sides) +C (default=2: full drag ; =1: gives half-slip BC) +C bottomDragLinear :: Linear bottom-drag coefficient (units of [r]/s) +C bottomDragQuadratic :: Quadratic bottom-drag coefficient (units of [r]/m) +C (if using zcoordinate, units becomes linear: m/s, quadratic: [-]) +C smoothAbsFuncRange :: 1/2 of interval around zero, for which FORTRAN ABS +C is to be replace by a smoother function +C (affects myabs, mymin, mymax) +C nh_Am2 :: scales the non-hydrostatic terms and changes internal scales +C (i.e. allows convection at different Rayleigh numbers) + COMMON /PARM_R/ cg2dTargetResidual, cg2dTargetResWunit, & cg2dpcOffDFac, cg3dTargetResidual, & delR, delRc, delX, delY, & deltaT, deltaTmom, dTtracerLev, deltaTfreesurf, deltaTClock, @@ -585,36 +649,37 @@ & viscAh, viscAhW, viscAhMax, & viscAhGrid, viscAhGridMax, viscAhGridMin, & viscC2leith, viscC2leithD, - & viscC2smag, + & viscC2smag, viscC4smag, & viscAhD, viscAhZ, viscA4D, viscA4Z, - & viscA4, viscA4W, + & viscA4, viscA4W, & viscA4Max, viscA4Grid, viscA4GridMax, viscA4GridMin, - & viscC4leith, viscC4leithD, viscAr, viscAstrain, viscAtension, + & viscAhRemax, viscA4Remax, + & viscC4leith, viscC4leithD, viscAr, & diffKhT, diffK4T, diffKrNrT, & diffKhS, diffK4S, diffKrNrS, & diffKrBL79surf, diffKrBL79deep, diffKrBL79scl, diffKrBL79Ho, & delT, tauCD, rCD, freeSurfFac, implicSurfPress, implicDiv2Dflow, & hFacMin, hFacMinDz, hFacInf, hFacSup, - & gravity, recip_Gravity, gBaro, rhonil, recip_rhonil, - & recip_rhoConst, rhoConst, - & rhoConstFresh, convertEmP2rUnit, tRef, sRef, - & baseTime, startTime, endTime, - & chkPtFreq, pchkPtFreq, dumpFreq, adjDumpFreq, + & gravity, recip_Gravity, gBaro, + & rhonil, recip_rhonil, rhoConst, recip_rhoConst, + & rhoFacC, recip_rhoFacC, rhoFacF, recip_rhoFacF, + & rhoConstFresh, convertEmP2rUnit, tRef, sRef, phiRef, dBdrRef, + & baseTime, startTime, endTime, + & chkPtFreq, pChkPtFreq, dumpFreq, adjDumpFreq, & diagFreq, taveFreq, tave_lastIter, monitorFreq, adjMonitorFreq, & afFacMom, vfFacMom, pfFacMom, cfFacMom, foFacMom, mtFacMom, & cosPower, cAdjFreq, omega, rotationPeriod, - & tauThetaClimRelax, - & tauSaltClimRelax, + & tauThetaClimRelax, tauSaltClimRelax, & tauTr1ClimRelax, lambdaTr1ClimRelax, latBandClimRelax, & externForcingCycle, externForcingPeriod, & convertFW2Salt, temp_EvPrRn, salt_EvPrRn, & hFacMinDr, hFacMinDp, & horiVertRatio, recip_horiVertRatio, & ivdc_kappa, Ro_SeaLevel, - & bottomDragLinear,bottomDragQuadratic,nh_Am2, + & sideDragFactor, bottomDragLinear, bottomDragQuadratic, nh_Am2, + & smoothAbsFuncRange, & tCylIn, tCylOut - _RL nh_Am2 _RL cg2dTargetResidual _RL cg2dTargetResWunit _RL cg3dTargetResidual @@ -632,7 +697,7 @@ _RL phiMin _RL thetaMin _RL rSphere - _RL recip_RSphere + _RL recip_rSphere _RL f0 _RL freeSurfFac _RL implicSurfPress @@ -649,29 +714,30 @@ _RL viscAhD _RL viscAhZ _RL viscAhMax + _RL viscAhReMax _RL viscAhGrid _RL viscAhGridMax _RL viscAhGridMin _RL viscC2leith _RL viscC2leithD _RL viscC2smag - _RL viscAstrain - _RL viscAtension + _RL viscC4smag _RL viscAr - _RL viscA4 + _RL viscA4 _RL viscA4W _RL viscA4D _RL viscA4Z _RL viscA4Max + _RL viscA4ReMax _RL viscA4Grid, viscA4GridMax, viscA4GridMin _RL viscC4leith _RL viscC4leithD - _RL diffKhT + _RL diffKhT _RL diffKrNrT(Nr) - _RL diffK4T - _RL diffKhS + _RL diffK4T + _RL diffKhS _RL diffKrNrS(Nr) - _RL diffK4S + _RL diffK4S _RL diffKrBL79surf _RL diffKrBL79deep _RL diffKrBL79scl @@ -682,14 +748,16 @@ _RL gravity _RL recip_gravity _RL gBaro - _RL rhonil - _RL recip_rhonil - _RL rhoConst - _RL recip_rhoConst + _RL rhonil, recip_rhonil + _RL rhoConst, recip_rhoConst + _RL rhoFacC(Nr), recip_rhoFacC(Nr) + _RL rhoFacF(Nr+1), recip_rhoFacF(Nr+1) _RL rhoConstFresh _RL convertEmP2rUnit _RL tRef(Nr) _RL sRef(Nr) + _RL phiRef(2*Nr+1) + _RL dBdrRef(Nr) _RL baseTime _RL startTime _RL endTime @@ -707,7 +775,7 @@ _RL pfFacMom _RL cfFacMom _RL foFacMom - _RL mTFacMom + _RL mtFacMom _RL cosPower _RL cAdjFreq _RL omega @@ -726,8 +794,11 @@ _RL recip_horiVertRatio _RL ivdc_kappa _RL Ro_SeaLevel + _RL sideDragFactor _RL bottomDragLinear _RL bottomDragQuadratic + _RL smoothAbsFuncRange + _RL nh_Am2 _RL tCylIn _RL tCylOut @@ -748,7 +819,7 @@ C (still a subject of discussions ...) C selectFindRoSurf :: select the way surf. ref. pressure (=Ro_surf) is C derived from the orography. Implemented: 0,1 (see INI_P_GROUND) - COMMON /PARM_ATM/ + COMMON /PARM_ATM/ & celsius2K, & atm_Cp, atm_Rd, atm_kappa, atm_Rq, atm_Po, & integr_GeoPot, selectFindRoSurf @@ -766,6 +837,9 @@ LOGICAL useOBCS LOGICAL useAIM LOGICAL useLand + LOGICAL useCAL + LOGICAL useEXF + LOGICAL useEBM LOGICAL useGrdchk LOGICAL useECCO LOGICAL useSHAP_FILT @@ -773,25 +847,33 @@ LOGICAL useFLT LOGICAL usePTRACERS LOGICAL useGCHEM + LOGICAL useRBCS + LOGICAL useOffLine + LOGICAL useMATRIX LOGICAL useSBO LOGICAL useSEAICE - LOGICAL useBulkForce + LOGICAL useShelfIce LOGICAL useThSIce + LOGICAL useATM2d + LOGICAL useBulkForce LOGICAL usefizhi LOGICAL usegridalt - LOGICAL usediagnostics - LOGICAL useEBM + LOGICAL useDiagnostics LOGICAL useMNC - LOGICAL useMATRIX + LOGICAL useREGRID LOGICAL useRunClock + LOGICAL useEMBED_FILES + LOGICAL useMYPACKAGE COMMON /PARM_PACKAGES/ - & useKPP, useGMRedi, useOBCS, useAIM, useLand, useECCO, - & useSHAP_FILT, useZONAL_FILT, useGrdchk, useFLT, - & usePTRACERS, useGCHEM, - & useSBO, useSEAICE, useThSIce, useBulkForce, - & usefizhi, usegridalt, usediagnostics, useEBM, useMNC, - & usePP81, useMY82, useOPPS, useGGL90, useMATRIX, - & useRunClock + & useOPPS, usePP81, useMY82, useGGL90, useKPP, + & useGMRedi, useOBCS, useAIM, useLand, + & useCAL, useEXF, useEBM, useGrdchk, useECCO, + & useSHAP_FILT, useZONAL_FILT, useFLT, + & usePTRACERS, useGCHEM, useRBCS, useOffLine, useMATRIX, + & useSBO, useSEAICE, useShelfIce, + & useThSIce, useATM2D, useBulkForce, + & usefizhi, usegridalt, useDiagnostics, useMNC, useREGRID, + & useRunClock, useEMBED_FILES, useMYPACKAGE CEH3 ;;; Local Variables: *** CEH3 ;;; mode:fortran ***