/[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.4 by cnh, Mon Apr 27 04:24:22 1998 UTC revision 1.26 by cnh, Sun Aug 23 15:34:39 1998 UTC
# Line 9  C     | stored into the variables held h Line 9  C     | stored into the variables held h
9  C     | the parameters can also be found here.                   |  C     | the parameters can also be found here.                   |
10  C     \==========================================================/  C     \==========================================================/
11    
12    C     Macros for special grid options
13    #include "PARAMS_MACROS.h"
14    
15  C--   Contants  C--   Contants
 C     nOBands - No. of offline data time bands  
       INTEGER nOBands  
       PARAMETER ( nOBands = 12 )  
16  C     Useful physical values  C     Useful physical values
17        Real*8 PI        Real*8 PI
18        PARAMETER ( PI    = 3.14159265358979323844D0   )        PARAMETER ( PI    = 3.14159265358979323844D0   )
19        Real*8 deg2rad        Real*8 deg2rad
20        PARAMETER ( deg2rad = 2.D0*PI/360.D0           )        PARAMETER ( deg2rad = 2.D0*PI/360.D0           )
21    
22    C     Symbolic values
23    C     precXXXX - Used to indicate what precision to use for
24    C                dumping model state.
25          INTEGER precFloat32
26          PARAMETER ( precFloat32 = 0 )
27          INTEGER precFloat64
28          PARAMETER ( precFloat64 = 1 )
29    
30    C     Checkpoint data
31          INTEGER maxNoChkptLev
32          PARAMETER ( maxNoChkptLev = 2 )
33    
34  C--   COMMON /PARM_C/ Character valued parameters used by the model.  C--   COMMON /PARM_C/ Character valued parameters used by the model.
35  C     oBandId  - Offline dataset identifiers for different periods.  C     checkPtSuff - List of checkpoint file suffices
36        COMMON /PARM_C/ oBandId  C     bathyFile   - File containing bathymetry. If not defined bathymetry
37        CHARACTER*3 oBandId(nOBands)  C                   is taken from inline function.
38    C     hydrogThetaFile - File containing initial hydrographic data for potential
39    C                       temperature.
40    C     hydrogSaltFile  - File containing initial hydrographic data for salinity.
41    C     zonalWindFile   - File containing zonal wind data
42    C     meridWindFile   - File containing meridional wind data
43    C     thetaClimFile   - File containing theta climataology used
44    C                       in relaxation term -lambda(theta-theta*)
45    C     saltClimFile    - File containing salt climataology used
46    C                       in relaxation term -lambda(salt-salt*)
47    C     buoyancyRelation - Flag used to indicate which relation to use to
48    C                        get buoyancy.
49          COMMON /PARM_C/ checkPtSuff,
50         &                bathyFile, hydrogThetaFile, hydrogSaltFile,
51         &                zonalWindFile, meridWindFile, thetaClimFile,
52         &                saltClimFile, buoyancyRelation
53          CHARACTER*(5) checkPtSuff(maxNoChkptLev)
54          CHARACTER*(MAX_LEN_FNAM) bathyFile
55          CHARACTER*(MAX_LEN_FNAM) hydrogThetaFile
56          CHARACTER*(MAX_LEN_FNAM) hydrogSaltFile
57          CHARACTER*(MAX_LEN_FNAM) zonalWindFile
58          CHARACTER*(MAX_LEN_FNAM) meridWindFile
59          CHARACTER*(MAX_LEN_FNAM) thetaClimFile
60          CHARACTER*(MAX_LEN_FNAM) saltClimFile
61          CHARACTER*(MAX_LEN_FNAM) buoyancyRelation
62    
63  C--   COMMON /PARM_I/ Integer valued parameters used by the model.  C--   COMMON /PARM_I/ Integer valued parameters used by the model.
64  C     cg2dMaxIters        - Maximum number of iterations in the  C     cg2dMaxIters        - Maximum number of iterations in the
65  C                           two-dimensional con. grad solver.  C                           two-dimensional con. grad solver.
# Line 32  C     nIter0              - Start time-s Line 69  C     nIter0              - Start time-s
69  C     nTimeSteps          - Number of timesteps to execute  C     nTimeSteps          - Number of timesteps to execute
70  C     numStepsPerPickup   - For offline setup. Frequency of pickup  C     numStepsPerPickup   - For offline setup. Frequency of pickup
71  C                           of flow fields.  C                           of flow fields.
72    C     writeStatePrec      - Precision used for writing model state.
73    C     writeBinaryPrec     - Precision used for writing binary files
74    C     readBinaryPrec      - Precision used for reading binary files
75    C     nCheckLev           - Holds current checkpoint level
76        COMMON /PARM_I/        COMMON /PARM_I/
77       &        cg2dMaxIters,       &        cg2dMaxIters,
78       &        cg2dChkResFreq,       &        cg2dChkResFreq,
79       &        nIter0, nTimeSteps,       &        nIter0, nTimeSteps,
80       &        numStepsPerPickup       &        numStepsPerPickup,
81         &        writeStatePrec, nCheckLev,
82         &        writeBinaryPrec, readBinaryPrec
83        INTEGER cg2dMaxIters        INTEGER cg2dMaxIters
84        INTEGER cg2dChkResFreq        INTEGER cg2dChkResFreq
85        INTEGER nIter0        INTEGER nIter0
86        INTEGER nTimeSteps        INTEGER nTimeSteps
87        INTEGER numStepsPerPickup        INTEGER numStepsPerPickup
88          INTEGER writeStatePrec
89          INTEGER writeBinaryPrec
90          INTEGER readBinaryPrec
91          INTEGER nCheckLev
92    
93  C--   COMMON /PARM_L/ Logical valued parameters used by the model.  C--   COMMON /PARM_L/ Logical valued parameters used by the model.
94  C     usingCartesianGrid - If TRUE grid generation will be in a cartesian  C     usingCartesianGrid - If TRUE grid generation will be in a cartesian
# Line 52  C     momViscosity  - Flag which turns m Line 99  C     momViscosity  - Flag which turns m
99  C     momAdvection  - Flag which turns advection of momentum on and off.  C     momAdvection  - Flag which turns advection of momentum on and off.
100  C     momForcing    - Flag which turns external forcing of momentum on  C     momForcing    - Flag which turns external forcing of momentum on
101  C                     and off.  C                     and off.
102    C     momPressureForcing - Flag which turns pressure term in momentum equation
103    C                          on and off.
104    C     metricTerms   - Flag which turns metric terms on or off.
105    C     usingSphericalPolarMTerms - If TRUE use spherical polar metric terms.
106  C     useCoriolis   - Flag which turns the coriolis terms on and off.  C     useCoriolis   - Flag which turns the coriolis terms on and off.
107  C     tempDiffusion - Flag which turns diffusion of temperature on  C     tempDiffusion - Flag which turns diffusion of temperature on
108  C                     and off.  C                     and off.
# Line 65  C     saltAdvection - Flag which turns a Line 116  C     saltAdvection - Flag which turns a
116  C                     and off.  C                     and off.
117  C     saltForcing   - Flag which turns external forcing of salinit on  C     saltForcing   - Flag which turns external forcing of salinit on
118  C                     and off.  C                     and off.
119    C     implicitFreeSurface - Set to true to use implcit free surface
120    C     rigidLid            - Set to true to use rigid lid
121    C     momStepping   - Turns momentum equation time-stepping off
122    C     tempStepping  - Turns temperature equation time-stepping off
123    C     saltStepping  - Turns salinity equation time-stepping off
124    C     useConstantF  - Coriolis parameter set to f0
125    C     useBetaPlaneF - Coriolis parameter set to f0 + beta.y
126    C     useSphereF    - Coriolis parameter set to 2.omega.sin(phi)
127    C     implicitDiffusion - Turns implicit vertical diffusion on
128    C     doThetaClimRelax - Set true if relaxation to temperature
129    C                        climatology is required.
130    C     doSaltClimRelax  - Set true if relaxation to salinity
131    C                        climatology is required.
132    C     periodicExternalForcing - Set true if forcing is time-dependant
133        COMMON /PARM_L/ usingCartesianGrid, usingSphericalPolarGrid,        COMMON /PARM_L/ usingCartesianGrid, usingSphericalPolarGrid,
134       & momViscosity, momAdvection, momForcing, useCoriolis,       & momViscosity, momAdvection, momForcing, useCoriolis, momPressureForcing,
135       & tempDiffusion, tempAdvection, tempForcing,       & tempDiffusion, tempAdvection, tempForcing,
136       & saltDiffusion, saltAdvection, saltForcing       & saltDiffusion, saltAdvection, saltForcing,
137         & implicitFreeSurface, rigidLid,
138         & momStepping, tempStepping, saltStepping,
139         & metricTerms, usingSphericalPolarMTerms,
140         & useConstantF, useBetaPlaneF, useSphereF,
141         & implicitDiffusion, doThetaClimRelax, doSaltClimRelax,
142         & periodicExternalForcing
143        LOGICAL usingCartesianGrid        LOGICAL usingCartesianGrid
144        LOGICAL usingSphericalPolarGrid        LOGICAL usingSphericalPolarGrid
145          LOGICAL usingSphericalPolarMTerms
146        LOGICAL momViscosity        LOGICAL momViscosity
147        LOGICAL momAdvection        LOGICAL momAdvection
148        LOGICAL momForcing        LOGICAL momForcing
149          LOGICAL momPressureForcing
150        LOGICAL useCoriolis        LOGICAL useCoriolis
151        LOGICAL tempDiffusion        LOGICAL tempDiffusion
152        LOGICAL tempAdvection        LOGICAL tempAdvection
# Line 81  C                     and off. Line 154  C                     and off.
154        LOGICAL saltDiffusion        LOGICAL saltDiffusion
155        LOGICAL saltAdvection        LOGICAL saltAdvection
156        LOGICAL saltForcing        LOGICAL saltForcing
157          LOGICAL implicitFreeSurface
158          LOGICAL rigidLid
159          LOGICAL momStepping
160          LOGICAL tempStepping
161          LOGICAL saltStepping
162          LOGICAL metricTerms
163          LOGICAL useConstantF
164          LOGICAL useBetaPlaneF
165          LOGICAL useSphereF
166          LOGICAL implicitDiffusion
167          LOGICAL doThetaClimRelax
168          LOGICAL doSaltClimRelax
169          LOGICAL periodicExternalForcing
170    
171  C--   COMMON /PARM_R/ "Real" valued parameters used by the model.  C--   COMMON /PARM_R/ "Real" valued parameters used by the model.
172  C     cg2dTargetResidual  C     cg2dTargetResidual
173  C               - Target residual for cg2d solver.  C               - Target residual for cg2d solver.
174  C     delZ      - Vertical grid spacing ( m ) - delZ is the distance  C     cg2dpcOffDFac - Averaging weight for preconditioner off-diagonal.
175  C                 between "w" surfaces.  C     Note. 20th May 1998
176    C           I made a weird discovery! In the model paper we argue
177    C           for the form of the preconditioner used here ( see
178    C           A Finite-volume, Incompressible Navier-Stokes Model
179    C           ...., Marshall et. al ). The algebra gives a simple
180    C           0.5 factor for the averaging of ac and aCw to get a
181    C           symmettric pre-conditioner. By using a factor of 0.51
182    C           i.e. scaling the off-diagonal terms in the
183    C           preconditioner down slightly I managed to get the
184    C           number of iterations for convergence in a test case to
185    C           drop form 192 -> 134! Need to investigate this further!
186    C           For now I have introduced a parameter cg2dpcOffDFac which
187    C           defaults to 0.51 but can be set at runtime.
188    C     delP      - Vertical grid spacing ( Pa ).
189    C     delZ      - Vertical grid spacing ( m  ).
190    C     delR      - Vertical grid spacing ( units of r ).
191  C     delX      - Separation between cell faces (m) or (deg), depending  C     delX      - Separation between cell faces (m) or (deg), depending
192  C     delY        on input flags.  C     delY        on input flags.
193  C     gravity   - Accel. due to gravity ( m/s^2 )  C     gravity   - Accel. due to gravity ( m/s^2 )
194    C     gBaro     - Accel. due to gravity used in barotropic equation ( m/s^2 )
195  C     ronil     - Reference density  C     ronil     - Reference density
196    C     rhoConst  - Vertically constant reference density
197  C     startTime - Start time for model ( s )  C     startTime - Start time for model ( s )
198  C     phiMin    - Latitude of southern most cell face.  C     phiMin    - Latitude of southern most cell face.
199  C     thetaMin  - Longitude of western most cell face (this  C     thetaMin  - Longitude of western most cell face (this
200  C                 is an "inert" parameter but it is included  C                 is an "inert" parameter but it is included
201  C                 to make geographical references simple.)  C                 to make geographical references simple.)
202  C     rSphere   - Radius of sphere for a spherical polar grid ( m ).  C     rSphere   - Radius of sphere for a spherical polar grid ( m ).
203    C     recip_RSphere  - Reciprocal radius of sphere ( m ).
204  C     f0        - Reference coriolis parameter ( 1/s )  C     f0        - Reference coriolis parameter ( 1/s )
205  C                 ( Southern edge f for beta plane )  C                 ( Southern edge f for beta plane )
206  C     beta      - df/dy ( s^-1.m^-1 )  C     beta      - df/dy ( s^-1.m^-1 )
207    C     omega     - Angular velocity ( rad/s )
208  C     viscAh    - Eddy viscosity coeff. for mixing of  C     viscAh    - Eddy viscosity coeff. for mixing of
209  C                 momentum laterally ( m^2/s )  C                 momentum laterally ( m^2/s )
210  C     viscAz    - Eddy viscosity coeff. for mixing of  C     viscAz    - Eddy viscosity coeff. for mixing of
211  C                 momentum vertically ( m^2/s )  C                 momentum vertically ( m^2/s )
212    C     viscAr    - Eddy viscosity coeff. for mixing of
213    C                 momentum vertically ( units of r^2/s )
214  C     viscA4    - Biharmonic viscosity coeff. for mixing of  C     viscA4    - Biharmonic viscosity coeff. for mixing of
215  C                 momentum laterally ( m^4/s )  C                 momentum laterally ( m^4/s )
216  C     diffKhT   - Laplacian diffusion coeff. for mixing of  C     diffKhT   - Laplacian diffusion coeff. for mixing of
217  C                 heat laterally ( m^2/s )  C                 heat laterally ( m^2/s )
218  C     diffKzT   - Laplacian diffusion coeff. for mixing of  C     diffKzT   - Laplacian diffusion coeff. for mixing of
219  C                 heat vertically ( m^2/s )  C                 heat vertically ( m^2/s )
220    C     diffKrT   - Laplacian diffusion coeff. for mixing of
221    C                 heat vertically ( units of r^2/s )
222  C     diffK4T   - Biharmonic diffusion coeff. for mixing of  C     diffK4T   - Biharmonic diffusion coeff. for mixing of
223  C                 heat laterally ( m^4/s )  C                 heat laterally ( m^4/s )
224  C     diffKhS  -  Laplacian diffusion coeff. for mixing of  C     diffKhS  -  Laplacian diffusion coeff. for mixing of
225  C                 salt laterally ( m^2/s )  C                 salt laterally ( m^2/s )
226  C     diffKzS   - Laplacian diffusion coeff. for mixing of  C     diffKzS   - Laplacian diffusion coeff. for mixing of
227  C                 salt vertically ( m^2/s )  C                 salt vertically ( m^2/s )
228    C     diffKrS   - Laplacian diffusion coeff. for mixing of
229    C                 salt vertically ( units of r^2/s )
230  C     diffK4S   - Biharmonic diffusion coeff. for mixing of  C     diffK4S   - Biharmonic diffusion coeff. for mixing of
231  C                 salt laterally ( m^4/s )  C                 salt laterally ( m^4/s )
 C     tAlpha    - Linear EOS thermal expansion coefficient ( 1/degree ).  
 C     sBeta     - Linear EOS haline contraction coefficient.  
232  C     deltaT    - Default timestep ( s )  C     deltaT    - Default timestep ( s )
233    C     deltaTClock  - Timestep used as model "clock". This determines the
234    C                    IO frequencies and is used in tagging output. It can
235    C                    be totally different to the dynamical time. Typically
236    C                    it will be the deep-water timestep for accelerated runs.
237    C                    Frequency of checkpointing and dumping of the model state
238    C                    are referenced to this clock. ( s )
239  C     deltaTMom    - Timestep for momemtum equations ( s )  C     deltaTMom    - Timestep for momemtum equations ( s )
240  C     deltaTtracer - Timestep for tracer equations ( s )  C     deltaTtracer - Timestep for tracer equations ( s )
241  C     tauCD     - CD scheme coupling timescale ( 1/s )  C     freesurfFac  - Parameter to turn implicit free surface term on or off
242  C     rCD       - CD scheme normalised coupling parameter ( 0-1 )  C                    freesurfac = 1. uses implicit free surface
243  C     startTime - Starting time for this integration ( s ).  C                    freesurfac = 0. uses rigid lid
244  C     endTime   - Ending time for this integration ( s ).  C     hFacMin      - Minimum fraction size of a cell (affects hFacC etc...)
245  C     chkPtFreq - Frequency of check pointing ( s ).  C     hFacMinDz    - Minimum dimesional size of a cell (affects hFacC etc..., m)
246  C     dumpFreq  - Frequency with which model state is written to  C     hFacMinDr    - Minimum dimesional size of a cell (affects hFacC etc..., units of r)
247    C     tauCD        - CD scheme coupling timescale ( 1/s )
248    C     rCD          - CD scheme normalised coupling parameter ( 0-1 )
249    C     GMmaxslope   - max. slope allowed in GM/Redi tensor
250    C     GMlength     - Length to use in Visbeck et al. formula for K (m)
251    C     GMalpha      - alpha to use in Visbeck et al. formula for K
252    C     GMdepth      - Depth over which to integrate Richardson # (Visbeck et al.)
253    C     GMkbackground - background value of GM/Redi diffusion coefficient ( m^2/s )
254    C     GMmaxval      - max. value of KapGM allowed in GM/Redi scheme ( m^2/s )
255    C     startTime     - Starting time for this integration ( s ).
256    C     endTime       - Ending time for this integration ( s ).
257    C     chkPtFreq     - Frequency of rolling check pointing ( s ).
258    C     pChkPtFreq    - Frequency of permanent check pointing ( s ).
259    C     dumpFreq      - Frequency with which model state is written to
260    C                     post-processing files ( s ).
261    C     afFacMom      - Advection of momentum term tracer parameter
262    C     vfFacMom      - Momentum viscosity tracer parameter
263    C     pfFacMom      - Momentum pressure forcing tracer parameter
264    C     cfFacMom      - Coriolis term tracer parameter
265    C     foFacMom      - Momentum forcing tracer parameter
266    C     mtFacMom      - Metric terms tracer parameter
267    C     cAdjFreq      - Frequency of convective adjustment
268    C
269    C     taveFreq  - Frequency with which time-averaged model state is written to
270  C                 post-processing files ( s ).  C                 post-processing files ( s ).
271        COMMON /PARM_R/ cg2dTargetResidual, delZ, delX, delY, deltaT,  C     tauThetaClimRelax - Relaxation to climatology time scale ( s ).
272       & deltaTmom, deltaTtracer, abeps, startTime, phiMin, thetaMin,  C     lambdaThetaClimRelax - Inverse time scale for relaxation ( 1/s ).
273       & rSphere, f0, fCori, beta, viscAh, viscAz, viscA4, diffKhT, diffKzT,  C     tauSaltClimRelax - Relaxation to climatology time scale ( s ).
274       & diffK4T, diffKhS, diffKzS, diffK4S, delT, tauCD, rCD,  C     lambdaSaltClimRelax - Inverse time scale for relaxation ( 1/s ).
275       & tAlpha, sBeta, gravity, rhonil, tRef, sRef,  C     externForcingPeriod - Is the period of which forcing varies (eg. 1 month)
276       & endTime, chkPtFreq, dumpFreq  C     externForcingCycle - Is the repeat time of the forcing (eg. 1 year)
277        REAL cg2dTargetResidual  C                          (note: externForcingCycle must be an integer
278        REAL delZ(Nz)  C                           number times externForcingPeriod)
279        REAL delX(Nx)        COMMON /PARM_R/ cg2dTargetResidual, cg2dpcOffDFac,
280        REAL delY(Ny)       & delP, delZ, delR, delX, delY,
281        REAL deltaT       & deltaT,deltaTmom, deltaTtracer, deltaTClock,abeps, startTime, phiMin,
282        REAL deltaTmom       & thetaMin, rSphere, recip_RSphere, f0, fCori, beta,
283        REAL deltaTtracer       & viscAh,  viscAz,  viscA4,  viscAr,
284        REAL abeps       & diffKhT, diffKzT, diffK4T, diffKrT,
285        REAL phiMin       & diffKhS, diffKzS, diffK4S, diffKrS,
286        REAL thetaMin       & delT, tauCD, rCD, freeSurfFac, hFacMin, hFacMinDz,
287        REAL rSphere       & GMmaxslope,GMlength,GMalpha,GMdepth,GMkbackground,GMmaxval,
288        REAL f0       & gravity, gBaro, rhonil, recip_rhonil,
289        _RL  beta       & recip_rhoConst, rhoConst, tRef, sRef, theta_S, specVol_S,
290        REAL viscAh       & endTime, chkPtFreq, pchkPtFreq, dumpFreq, taveFreq,
291        REAL viscAz       & afFacMom, vfFacMom, pfFacMom, cfFacMom, foFacMom, mtFacMom,
292        REAL viscA4       & cAdjFreq, omega, tauThetaClimRelax, lambdaThetaClimRelax,
293        REAL diffKhT       & tauSaltClimRelax, lambdaSaltClimRelax,
294        REAL diffKzT       & externForcingCycle, externForcingPeriod
295        REAL diffK4T        _RL cg2dTargetResidual
296        REAL diffKhS        _RL cg2dpcOffDFac
297        REAL diffKzS        _RL delZ(Nr)
298        REAL diffK4S        _RL delP(Nr)
299        REAL delt        _RL delR(Nr)
300        REAL tauCD        _RL delX(Nx)
301        REAL rCD        _RL delY(Ny)
302        REAL tAlpha        _RL deltaT
303        REAL sBeta        _RL deltaTClock
304        REAL gravity        _RL deltaTmom
305        REAL rhonil        _RL deltaTtracer
306        REAL tRef(Nz)        _RL abeps
307        REAL sRef(Nz)        _RL phiMin
308        real Fcori(1-OLx:sNx+OLx,1-OLy:sNy+OLy,nSx,nSy)        _RL thetaMin
309        REAL startTime        _RL rSphere
310        REAL endTime        _RL recip_RSphere
311        REAL chkPtFreq        _RL f0
312        REAL dumpFreq        _RL freeSurfFac
313          _RL hFacMin
314          _RL hFacMinDz
315          _RL beta
316          _RL viscAh
317          _RL viscAz
318          _RL viscAr
319          _RL viscA4
320          _RL diffKhT
321          _RL diffKrT
322          _RL diffKzT
323          _RL diffK4T
324          _RL diffKhS
325          _RL diffKrS
326          _RL diffKzS
327          _RL diffK4S
328          _RL delt
329          _RL tauCD
330          _RL rCD
331          _RL GMmaxslope
332          _RL GMlength
333          _RL GMalpha
334          _RL GMdepth
335          _RL GMkbackground
336          _RL GMmaxval
337          _RL gravity
338          _RL gBaro
339          _RL rhonil
340          _RL recip_rhonil
341          _RL rhoConst
342          _RL recip_rhoConst
343          _RL specVol_S(Nr)
344          _RL tRef(Nr)
345          _RL theta_S(Nr)
346          _RL sRef(Nr)
347          _RS Fcori(1-OLx:sNx+OLx,1-OLy:sNy+OLy,nSx,nSy)
348          _RL startTime
349          _RL endTime
350          _RL chkPtFreq
351          _RL pChkPtFreq
352          _RL dumpFreq
353          _RL taveFreq
354          _RL afFacMom
355          _RL vfFacMom
356          _RL pfFacMom
357          _RL cfFacMom
358          _RL foFacMom
359          _RL mTFacMom
360          _RL cAdjFreq
361          _RL omega
362          _RL tauThetaClimRelax
363          _RL lambdaThetaClimRelax
364          _RL tauSaltClimRelax
365          _RL lambdaSaltClimRelax
366          _RL externForcingCycle
367          _RL externForcingPeriod
368    
369        COMMON /PARM_A/ HeatCapacity_Cp,        COMMON /PARM_A/ HeatCapacity_Cp,
370       &                Lamba_theta       &                Lamba_theta
371        REAL HeatCapacity_Cp        _RL HeatCapacity_Cp
372        REAL Lamba_theta        _RL Lamba_theta
373    
374    C Equation of State (polynomial coeffients)
375          COMMON /PARM_EOS_NL/ eosC,eosSig0,eosRefT,eosRefS
376          _RL eosC(9,Nr+1),eosSig0(Nr+1),eosRefT(Nr+1),eosRefS(Nr+1)
377    C Linear equation of state
378    C     tAlpha    - Linear EOS thermal expansion coefficient ( 1/degree ).
379    C     sBeta     - Linear EOS haline contraction coefficient.
380          COMMON /PARM_EOS_LIN/ tAlpha,sBeta,eosType
381          _RL tAlpha
382          _RL sBeta
383          character*(6) eosType
384    

Legend:
Removed from v.1.4  
changed lines
  Added in v.1.26

  ViewVC Help
Powered by ViewVC 1.1.22