--- MITgcm/model/inc/PARAMS.h 2008/07/18 22:19:26 1.218 +++ MITgcm/model/inc/PARAMS.h 2010/11/17 21:15:08 1.244 @@ -1,4 +1,4 @@ -C $Header: /home/ubuntu/mnt/e9_copy/MITgcm/model/inc/PARAMS.h,v 1.218 2008/07/18 22:19:26 jmc Exp $ +C $Header: /home/ubuntu/mnt/e9_copy/MITgcm/model/inc/PARAMS.h,v 1.244 2010/11/17 21:15:08 jmc Exp $ C $Name: $ C @@ -38,6 +38,7 @@ 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 hybSigmFile :: File containing hybrid-sigma vertical coord. coeff. (2x 1.D) 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 @@ -46,13 +47,15 @@ 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 (3-D) C for potential temperature. C hydrogSaltFile :: File containing initial hydrographic data (3-D) C for salinity. C diffKrFile :: File containing 3D specification of vertical diffusivity +C viscAhDfile :: File containing 3D specification of horizontal viscosity +C viscAhZfile :: File containing 3D specification of horizontal viscosity +C viscA4Dfile :: File containing 3D specification of horizontal viscosity +C viscA4Zfile :: File containing 3D specification of horizontal viscosity C zonalWindFile :: File containing zonal wind data C meridWindFile :: File containing meridional wind data C thetaClimFile :: File containing surface theta climataology used @@ -77,9 +80,11 @@ & buoyancyRelation, eosType, & pickupSuff, mdsioLocalDir, & tRefFile, sRefFile, rhoRefFile, - & delRFile, delRcFile, + & delRFile, delRcFile, hybSigmFile, & delXFile, delYFile, horizGridFile, - & bathyFile, topoFile, shelfIceFile, + & bathyFile, topoFile, + & viscAhDfile, viscAhZfile, + & viscA4Dfile, viscA4Zfile, & hydrogThetaFile, hydrogSaltFile, diffKrFile, & zonalWindFile, meridWindFile, thetaClimFile, & saltClimFile, @@ -99,12 +104,17 @@ CHARACTER*(MAX_LEN_FNAM) rhoRefFile CHARACTER*(MAX_LEN_FNAM) delRFile CHARACTER*(MAX_LEN_FNAM) delRcFile + CHARACTER*(MAX_LEN_FNAM) hybSigmFile CHARACTER*(MAX_LEN_FNAM) delXFile CHARACTER*(MAX_LEN_FNAM) delYFile CHARACTER*(MAX_LEN_FNAM) horizGridFile - CHARACTER*(MAX_LEN_FNAM) bathyFile, topoFile, shelfIceFile + CHARACTER*(MAX_LEN_FNAM) bathyFile, topoFile CHARACTER*(MAX_LEN_FNAM) hydrogThetaFile, hydrogSaltFile CHARACTER*(MAX_LEN_FNAM) diffKrFile + CHARACTER*(MAX_LEN_FNAM) viscAhDfile + CHARACTER*(MAX_LEN_FNAM) viscAhZfile + CHARACTER*(MAX_LEN_FNAM) viscA4Dfile + CHARACTER*(MAX_LEN_FNAM) viscA4Zfile CHARACTER*(MAX_LEN_FNAM) zonalWindFile CHARACTER*(MAX_LEN_FNAM) meridWindFile CHARACTER*(MAX_LEN_FNAM) thetaClimFile @@ -141,10 +151,21 @@ C writeStatePrec :: Precision used for writing model state. C writeBinaryPrec :: Precision used for writing binary files C readBinaryPrec :: Precision used for reading binary files +C selectCoriMap :: select setting of Coriolis parameter map: +C =0 f-Plane (Constant Coriolis, = f0) +C =1 Beta-Plane Coriolis (= f0 + beta.y) +C =2 Spherical Coriolis (= 2.omega.sin(phi)) +C =3 Read Coriolis 2-d fields from files. +C selectSigmaCoord :: option related to sigma vertical coordinate C nonlinFreeSurf :: option related to non-linear free surface 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 selectNHfreeSurf :: option for Non-Hydrostatic (free-)Surface formulation: +C =0 (default) hydrostatic surf. ; > 0 add NH effects. +C selectAddFluid :: option to add mass source/sink of fluid in the interior +C (3-D generalisation of oceanic real-fresh water flux) +C =0 off ; =1 add fluid ; =-1 virtual flux (no mass added) 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 @@ -157,7 +178,8 @@ C selectVortScheme :: Scheme selector for Vorticity term (Vector Inv.) C monitorSelect :: select group of variables to monitor C =1 : dynvars ; =2 : + vort ; =3 : + surface -C debugLevel :: debug level selector: higher -> more writing +C- debugLevel :: controls printing of algorithm intermediate results +C and statistics ; higher -> more writing COMMON /PARM_I/ & cg2dMaxIters, @@ -167,7 +189,11 @@ & nIter0, nTimeSteps, nEndIter, & writeStatePrec, & writeBinaryPrec, readBinaryPrec, + & selectCoriMap, + & selectSigmaCoord, & nonlinFreeSurf, select_rStar, + & selectNHfreeSurf, + & selectAddFluid, & momForcingOutAB, tracForcingOutAB, & tempAdvScheme, tempVertAdvScheme, & saltAdvScheme, saltVertAdvScheme, @@ -184,8 +210,12 @@ INTEGER writeStatePrec INTEGER writeBinaryPrec INTEGER readBinaryPrec + INTEGER selectCoriMap + INTEGER selectSigmaCoord INTEGER nonlinFreeSurf INTEGER select_rStar + INTEGER selectNHfreeSurf + INTEGER selectAddFluid INTEGER momForcingOutAB, tracForcingOutAB INTEGER tempAdvScheme, tempVertAdvScheme INTEGER saltAdvScheme, saltVertAdvScheme @@ -235,9 +265,6 @@ C useNHMTerms :: If TRUE use non-hydrostatic metric terms. C useCoriolis :: Flag which turns the coriolis terms on and off. C use3dCoriolis :: Turns the 3-D coriolis terms (in Omega.cos Phi) on - 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 useCDscheme :: use CD-scheme to calculate Coriolis terms. C vectorInvariantMomentum :: use Vector-Invariant form (mom_vecinv package) C (default = F = use mom_fluxform package) @@ -259,9 +286,17 @@ C saltIsActiveTr :: Salinity is a dynamically active tracer C saltForcing :: Flag which turns external forcing of salinity on C and off. +C maskIniTemp :: apply mask to initial Pot.Temp. +C maskIniSalt :: apply mask to initial salinity +C checkIniTemp :: check for points with identically zero initial Pot.Temp. +C checkIniSalt :: check for points with identically zero initial salinity 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- Pressure solver related parameters (PARM02) +C useSRCGSolver :: Set to true to use conjugate gradient +C solver with single reduction (only one call of +C s/r mpi_allreduce), default is false C- Time-stepping params: C rigidLid :: Set to true to use rigid lid C implicitFreeSurface :: Set to true to use implicit free surface @@ -298,11 +333,10 @@ C useOldFreezing :: use the old version (before checkpoint52a_pre, 2003-11-12) C periodicExternalForcing :: Set true if forcing is time-dependant C- I/O parameters - -C globalFiles :: Selects between "global" and "tiled" files -C useSingleCpuIO :: On SGI platforms, option globalFiles is either -C slow (f77) or does not work (f90). When -C useSingleCpuIO is set, mdsio_writefield.F -C outputs from master mpi process only. +C globalFiles :: Selects between "global" and "tiled" files. +C On some platforms with MPI, option globalFiles is either +C slow or does not work. Use useSingleCpuIO instead. +C useSingleCpuIO :: moved to EEPARAMS.h C pickupStrictlyMatch :: check and stop if pickup-file do not stricly match C startFromPickupAB2 :: with AB-3 code, start from an AB-2 pickup C usePickupBeforeC54 :: start from old-pickup files, generated with code from @@ -316,6 +350,7 @@ C monitor_stdio :: use stdio for monitor output C dumpInitAndLast :: dumps model state to files at Initial (nIter0) C & Last iteration, in addition multiple of dumpFreq iter. +C debugMode :: controls printing of debug msg (sequence of S/R calls). COMMON /PARM_L/ & fluidIsAir, fluidIsWater, @@ -328,7 +363,6 @@ & momViscosity, momAdvection, momForcing, & momPressureForcing, metricTerms, useNHMTerms, & useCoriolis, use3dCoriolis, - & useConstantF, useBetaPlaneF, useSphereF, & useCDscheme, vectorInvariantMomentum, & useEnergyConservingCoriolis, useJamartWetPoints, useJamartMomAdv, & upwindVorticity, highOrderVorticity, @@ -336,6 +370,7 @@ & momStepping, tempStepping, saltStepping, & tempAdvection, tempIsActiveTr, tempForcing, & saltAdvection, saltIsActiveTr, saltForcing, + & maskIniTemp, maskIniSalt, checkIniTemp, checkIniSalt, & useRealFreshWaterFlux, & rigidLid, implicitFreeSurface, exactConserv, linFSConserveTr, & uniformLin_PhiSurf, @@ -349,13 +384,14 @@ & doThetaClimRelax, doSaltClimRelax, & allowFreezing, useOldFreezing, & periodicExternalForcing, - & globalFiles, useSingleCpuIO, + & globalFiles, & pickupStrictlyMatch, usePickupBeforeC54, startFromPickupAB2, & pickup_read_mdsio, pickup_write_mdsio, pickup_write_immed, & writePickupAtEnd, & timeave_mdsio, snapshot_mdsio, monitor_stdio, & outputTypesInclusive, dumpInitAndLast, debugMode, - & inAdMode, inAdTrue, inAdFalse, inAdExact + & inAdMode, inAdTrue, inAdFalse, inAdExact, + & useSRCGSolver LOGICAL fluidIsAir LOGICAL fluidIsWater @@ -384,6 +420,10 @@ LOGICAL saltAdvection LOGICAL saltIsActiveTr LOGICAL saltForcing + LOGICAL maskIniTemp + LOGICAL maskIniSalt + LOGICAL checkIniTemp + LOGICAL checkIniSalt LOGICAL useRealFreshWaterFlux LOGICAL useFullLeith LOGICAL useStrainTensionVisc @@ -402,9 +442,6 @@ LOGICAL tempStepping LOGICAL saltStepping LOGICAL metricTerms - LOGICAL useConstantF - LOGICAL useBetaPlaneF - LOGICAL useSphereF LOGICAL use3dCoriolis LOGICAL useCDscheme LOGICAL useEnergyConservingCoriolis @@ -432,7 +469,6 @@ LOGICAL useOldFreezing LOGICAL periodicExternalForcing LOGICAL globalFiles - LOGICAL useSingleCpuIO LOGICAL pickupStrictlyMatch LOGICAL usePickupBeforeC54 LOGICAL startFromPickupAB2 @@ -443,6 +479,7 @@ LOGICAL dumpInitAndLast LOGICAL debugMode LOGICAL inAdMode, inAdTrue, inAdFalse, inAdExact + LOGICAL useSRCGSolver C-- COMMON /PARM_R/ "Real" valued parameters used by the model. C cg2dTargetResidual @@ -477,6 +514,7 @@ 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 rho1Ref :: reference vertical profile for density C tRef :: reference vertical profile for potential temperature C sRef :: reference vertical profile for salinity/specific humidity C phiRef :: reference potential (pressure/rho, geopotential) profile @@ -497,39 +535,42 @@ C :: from vertical r-coordinate unit to mass per unit area [kg/m2]. C :: z-coord: = rhoConst ( [m] * rho = [kg/m2] ) ; C :: p-coord: = 1/gravity ( [Pa] / g = [kg/m2] ) ; -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 xgOrigin :: Origin of the X-axis (Cartesian Grid) / Longitude of Western +C :: most cell face (Lat-Lon grid) (Note: this is an "inert" +C :: parameter but it makes geographical references simple.) +C ygOrigin :: Origin of the Y-axis (Cartesian Grid) / Latitude of Southern +C :: most face (Lat-Lon grid). +C rSphere :: Radius of sphere for a spherical polar grid ( 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 ) -C omega :: Angular velocity ( rad/s ) +C f0 :: Reference coriolis parameter ( 1/s ) +C ( Southern edge f for beta plane ) +C beta :: df/dy ( s^-1.m^-1 ) +C fPrime :: Second Coriolis parameter ( 1/s ), related to Y-component +C of rotation (reference value = 2.Omega.Cos(Phi)) +C omega :: Angular velocity ( rad/s ) C rotationPeriod :: Rotation period (s) (= 2.pi/omega) -C viscAr :: Eddy viscosity coeff. for mixing of -C momentum vertically ( units of r^2/s ) -C viscAh :: Eddy viscosity coeff. for mixing of -C momentum laterally ( m^2/s ) -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 viscA4 :: Biharmonic viscosity coeff. for mixing of -C momentum laterally ( m^4/s ) -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 -C (act on Vorticity part) ( m^2/s ) -C viscA4D :: Biharmonic viscosity coeff. for mixing of momentum laterally -C (act on Divergence part) ( m^4/s ) -C viscA4Z :: Biharmonic viscosity coeff. for mixing of momentum laterally -C (act on Vorticity part) ( m^4/s ) +C viscArNr :: vertical profile of Eddy viscosity coeff. +C for vertical mixing of momentum ( units of r^2/s ) +C viscAh :: Eddy viscosity coeff. for mixing of +C momentum laterally ( m^2/s ) +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 viscA4 :: Biharmonic viscosity coeff. for mixing of +C momentum laterally ( m^4/s ) +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 +C (act on Vorticity part) ( m^2/s ) +C viscA4D :: Biharmonic viscosity coeff. for mixing of momentum laterally +C (act on Divergence part) ( m^4/s ) +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 visc. factor (grad(div)) C viscC4leith :: Leith non-dimensional viscosity factor (grad(vort)) @@ -592,14 +633,17 @@ C Implicit part of Surface Pressure Gradient ( 0-1 ) C implicDiv2Dflow :: parameter of the Crank-Nickelson time stepping : C Implicit part of barotropic flow Divergence ( 0-1 ) +C implicitNHPress :: parameter of the Crank-Nickelson time stepping : +C Implicit part of Non-Hydrostatic Pressure Gradient ( 0-1 ) C hFacMin :: Minimum fraction size of a cell (affects hFacC etc...) -C hFacMinDz :: Minimum dimesional size of a cell (affects hFacC etc..., m) -C hFacMinDp :: Minimum dimesional size of a cell (affects hFacC etc..., Pa) -C hFacMinDr :: Minimum dimesional size of a cell (affects hFacC etc..., units of r) +C hFacMinDz :: Minimum dimensional size of a cell (affects hFacC etc..., m) +C hFacMinDp :: Minimum dimensional size of a cell (affects hFacC etc..., Pa) +C hFacMinDr :: Minimum dimensional size of a cell (-> hFacC etc..., r units) C hFacInf :: Threshold (inf and sup) for fraction size of surface cell -C hFacSup that control vanishing and creating levels -C tauCD :: CD scheme coupling timescale ( 1/s ) -C rCD :: CD scheme normalised coupling parameter ( 0-1 ) +C hFacSup that control vanishing and creating levels +C tauCD :: CD scheme coupling timescale ( s ) +C rCD :: CD scheme normalised coupling parameter (= 1 - deltaT/tauCD) +C epsAB_CD :: Adams-Bashforth-2 stabilizing weight used in CD scheme C baseTime :: model base time (time origin) = time @ iteration zero C startTime :: Starting time for this integration ( s ). C endTime :: Ending time for this integration ( s ). @@ -635,13 +679,18 @@ C (use model surface (local) value if set to -1) C temp_EvPrRn :: temperature of Rain & Evap. C salt_EvPrRn :: salinity of Rain & Evap. +C temp_addMass :: temperature of addMass array +C salt_addMass :: salinity of addMass array C (notes: a) tracer content of Rain/Evap only used if both C NonLin_FrSurf & useRealFreshWater are set. C b) use model surface (local) value if set to UNSET_RL) -C hMixCrit :: criteria for mixed-layer diagnostic +C hMixCriteria:: criteria for mixed-layer diagnostic +C dRhoSmall :: parameter for mixed-layer diagnostic +C hMixSmooth :: Smoothing parameter for mixed-layer diag (default=0=no smoothing) 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) 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) @@ -660,8 +709,9 @@ & delR, delRc, delX, delY, & deltaT, deltaTmom, dTtracerLev, deltaTfreesurf, deltaTClock, & abEps, alph_AB, beta_AB, - & phiMin, thetaMin, rSphere, recip_RSphere, f0, beta, - & viscAh, viscAhW, viscAhMax, + & xgOrigin, ygOrigin, rSphere, recip_rSphere, + & f0, beta, fPrime, omega, rotationPeriod, + & viscFacAdj, viscAh, viscAhW, viscAhMax, & viscAhGrid, viscAhGridMax, viscAhGridMin, & viscC2leith, viscC2leithD, & viscC2smag, viscC4smag, @@ -669,29 +719,31 @@ & viscA4, viscA4W, viscA4Max, & viscA4Grid, viscA4GridMax, viscA4GridMin, & viscAhReMax, viscA4ReMax, - & viscC4leith, viscC4leithD, viscAr, + & viscC4leith, viscC4leithD, viscArNr, & diffKhT, diffK4T, diffKrNrT, & diffKhS, diffK4S, diffKrNrS, & diffKrBL79surf, diffKrBL79deep, diffKrBL79scl, diffKrBL79Ho, & BL79LatVary, & diffKrBLEQsurf, diffKrBLEQdeep, diffKrBLEQscl, diffKrBLEQHo, - & delT, tauCD, rCD, freeSurfFac, implicSurfPress, implicDiv2Dflow, + & tauCD, rCD, epsAB_CD, + & freeSurfFac, implicSurfPress, implicDiv2Dflow, implicitNHPress, & hFacMin, hFacMinDz, hFacInf, hFacSup, & gravity, recip_gravity, gBaro, & rhonil, recip_rhonil, rhoConst, recip_rhoConst, & rhoFacC, recip_rhoFacC, rhoFacF, recip_rhoFacF, - & rhoConstFresh, tRef, sRef, phiRef, dBdrRef, + & rhoConstFresh, rho1Ref, tRef, sRef, phiRef, dBdrRef, & rVel2wUnit, wUnit2rVel, mass2rUnit, rUnit2mass, & baseTime, startTime, endTime, & chkPtFreq, pChkPtFreq, dumpFreq, adjDumpFreq, & diagFreq, taveFreq, tave_lastIter, monitorFreq, adjMonitorFreq, & afFacMom, vfFacMom, pfFacMom, cfFacMom, foFacMom, mtFacMom, - & cosPower, cAdjFreq, omega, rotationPeriod, + & cosPower, cAdjFreq, & tauThetaClimRelax, tauSaltClimRelax, latBandClimRelax, & externForcingCycle, externForcingPeriod, & convertFW2Salt, temp_EvPrRn, salt_EvPrRn, - & hFacMinDr, hFacMinDp, - & ivdc_kappa, hMixCriteria, Ro_SeaLevel, + & temp_addMass, salt_addMass, hFacMinDr, hFacMinDp, + & ivdc_kappa, hMixCriteria, dRhoSmall, hMixSmooth, + & Ro_SeaLevel, rSigmaBnd, & sideDragFactor, bottomDragLinear, bottomDragQuadratic, nh_Am2, & smoothAbsFuncRange, & tCylIn, tCylOut, @@ -711,22 +763,27 @@ _RL dTtracerLev(Nr) _RL deltaTfreesurf _RL abEps, alph_AB, beta_AB - _RL phiMin - _RL thetaMin + _RL xgOrigin + _RL ygOrigin _RL rSphere _RL recip_rSphere _RL f0 + _RL beta + _RL fPrime + _RL omega + _RL rotationPeriod _RL freeSurfFac _RL implicSurfPress _RL implicDiv2Dflow + _RL implicitNHPress _RL hFacMin _RL hFacMinDz _RL hFacMinDp _RL hFacMinDr _RL hFacInf _RL hFacSup - _RL beta - _RL viscAr + _RL viscArNr(Nr) + _RL viscFacAdj _RL viscAh _RL viscAhW _RL viscAhD @@ -762,9 +819,7 @@ _RL diffKrBLEQdeep _RL diffKrBLEQscl _RL diffKrBLEQHo - _RL delt - _RL tauCD - _RL rCD + _RL tauCD, rCD, epsAB_CD _RL gravity _RL recip_gravity _RL gBaro @@ -773,6 +828,7 @@ _RL rhoFacC(Nr), recip_rhoFacC(Nr) _RL rhoFacF(Nr+1), recip_rhoFacF(Nr+1) _RL rhoConstFresh + _RL rho1Ref(Nr) _RL tRef(Nr) _RL sRef(Nr) _RL phiRef(2*Nr+1) @@ -799,8 +855,6 @@ _RL mtFacMom _RL cosPower _RL cAdjFreq - _RL omega - _RL rotationPeriod _RL tauThetaClimRelax _RL tauSaltClimRelax _RL latBandClimRelax @@ -809,9 +863,14 @@ _RL convertFW2Salt _RL temp_EvPrRn _RL salt_EvPrRn + _RL temp_addMass + _RL salt_addMass _RL ivdc_kappa _RL hMixCriteria + _RL dRhoSmall + _RL hMixSmooth _RL Ro_SeaLevel + _RL rSigmaBnd _RL sideDragFactor _RL bottomDragLinear _RL bottomDragQuadratic @@ -847,55 +906,62 @@ INTEGER integr_GeoPot, selectFindRoSurf C Logical flags for selecting packages + LOGICAL useGAD + LOGICAL useOBCS + LOGICAL useSHAP_FILT + LOGICAL useZONAL_FILT LOGICAL useOPPS LOGICAL usePP81 LOGICAL useMY82 LOGICAL useGGL90 LOGICAL useKPP - LOGICAL useGAD LOGICAL useGMRedi - LOGICAL useOBCS - LOGICAL useAIM - LOGICAL useLand + LOGICAL useDOWN_SLOPE LOGICAL useCAL LOGICAL useEXF + LOGICAL useBulkForce LOGICAL useEBM + LOGICAL useCheapAML LOGICAL useGrdchk + LOGICAL useSMOOTH LOGICAL useECCO - LOGICAL useSHAP_FILT - LOGICAL useZONAL_FILT + LOGICAL useSBO LOGICAL useFLT LOGICAL usePTRACERS LOGICAL useGCHEM LOGICAL useRBCS LOGICAL useOffLine LOGICAL useMATRIX - LOGICAL useSBO LOGICAL useSEAICE + LOGICAL useSALT_PLUME LOGICAL useShelfIce + LOGICAL useICEFRONT LOGICAL useThSIce LOGICAL useATM2d - LOGICAL useBulkForce - LOGICAL usefizhi - LOGICAL usegridalt + LOGICAL useAIM + LOGICAL useLand + LOGICAL useFizhi + LOGICAL useGridAlt LOGICAL useDiagnostics - LOGICAL useMNC LOGICAL useREGRID + LOGICAL useLayers + LOGICAL useMNC LOGICAL useRunClock LOGICAL useEMBED_FILES LOGICAL useMYPACKAGE - LOGICAL useSALT_PLUME COMMON /PARM_PACKAGES/ + & useGAD, useOBCS, useSHAP_FILT, useZONAL_FILT, & useOPPS, usePP81, useMY82, useGGL90, useKPP, - & useGAD, useGMRedi, useOBCS, useAIM, useLand, - & useCAL, useEXF, useEBM, useGrdchk, useECCO, - & useSHAP_FILT, useZONAL_FILT, useFLT, + & useGMRedi, useDOWN_SLOPE, + & useCAL, useEXF, useBulkForce, useEBM, useCheapAML, + & useGrdchk, useSMOOTH, useECCO, useSBO, useFLT, & usePTRACERS, useGCHEM, useRBCS, useOffLine, useMATRIX, - & useSBO, useSEAICE, useShelfIce, - & useThSIce, useATM2D, useBulkForce, - & usefizhi, usegridalt, useDiagnostics, useMNC, useREGRID, - & useRunClock, useEMBED_FILES, useMYPACKAGE, useSALT_PLUME - + & useSEAICE, useSALT_PLUME, useShelfIce, + & useICEFRONT, useThSIce, + & useATM2D, useAIM, useLand, useFizhi, useGridAlt, + & useDiagnostics, useREGRID, useLayers, useMNC, + & useRunClock, useEMBED_FILES, + & useMYPACKAGE CEH3 ;;; Local Variables: *** CEH3 ;;; mode:fortran *** CEH3 ;;; End: ***