/[MITgcm]/MITgcm/doc/tag-index
ViewVC logotype

Annotation of /MITgcm/doc/tag-index

Parent Directory Parent Directory | Revision Log Revision Log | View Revision Graph Revision Graph


Revision 1.134 - (hide annotations) (download)
Tue Feb 18 05:33:53 2003 UTC (21 years, 2 months ago) by dimitri
Branch: MAIN
CVS Tags: checkpoint48f_post
Changes since 1.133: +29 -1 lines
Merging from release1_p12:
o Modifications for using pkg/exf with pkg/seaice
  - improved description of the various forcing configurations
  - added basic radiation bulk formulae to pkg/exf
  - units/sign fix for evap computation in exf_getffields.F
  - updated verification/global_with_exf/results/output.txt
o Added pkg/sbo for computing IERS Special Bureau for the Oceans
  (SBO) core products, including oceanic mass, center-of-mass,
  angular, and bottom pressure (see pkg/sbo/README.sbo).
o Lower bound for viscosity/diffusivity in pkg/kpp/kpp_routines.F
  to avoid negative values in shallow regions.
  - updated verification/natl_box/results/output.txt
  - updated verification/lab_sea/results/output.txt
o MPI gather, scatter: eesupp/src/gather_2d.F and scatter_2d.F
o Added useSingleCpuIO option (see PARAMS.h).
o Updated useSingleCpuIO option in mdsio_writefield.F to
  work with multi-field files, e.g., for single-file pickup.
o pkg/seaice:
  - bug fix in growth.F: QNET for no shortwave case
  - added HeffFile for specifying initial sea-ice thickness
  - changed SEAICE_EXTERNAL_FLUXES wind stress implementation
o Added missing /* */ to CPP comments in pkg/seaice, pkg/exf,
  kpp_transport_t.F, forward_step.F, and the_main_loop.F
o pkg/seaice:
  - adjoint-friendly modifications
  - added a SEAICE_WRITE_PICKUP at end of the_model_main.F

1 dimitri 1.134 $Header: /u/gcmpack/MITgcm/doc/tag-index,v 1.133 2003/02/12 17:06:01 jmc Exp $
2 cnh 1.1
3     Notes on tags used in MITgcmUV
4     ==============================
5 dimitri 1.134
6     checkpoint48f_post
7     Merging from release1_p12:
8     o Modifications for using pkg/exf with pkg/seaice
9     - improved description of the various forcing configurations
10     - added basic radiation bulk formulae to pkg/exf
11     - units/sign fix for evap computation in exf_getffields.F
12     - updated verification/global_with_exf/results/output.txt
13     o Added pkg/sbo for computing IERS Special Bureau for the Oceans
14     (SBO) core products, including oceanic mass, center-of-mass,
15     angular, and bottom pressure (see pkg/sbo/README.sbo).
16     o Lower bound for viscosity/diffusivity in pkg/kpp/kpp_routines.F
17     to avoid negative values in shallow regions.
18     - updated verification/natl_box/results/output.txt
19     - updated verification/lab_sea/results/output.txt
20     o MPI gather, scatter: eesupp/src/gather_2d.F and scatter_2d.F
21     o Added useSingleCpuIO option (see PARAMS.h).
22     o Updated useSingleCpuIO option in mdsio_writefield.F to
23     work with multi-field files, e.g., for single-file pickup.
24     o pkg/seaice:
25     - bug fix in growth.F: QNET for no shortwave case
26     - added HeffFile for specifying initial sea-ice thickness
27     - changed SEAICE_EXTERNAL_FLUXES wind stress implementation
28     o Added missing /* */ to CPP comments in pkg/seaice, pkg/exf,
29     kpp_transport_t.F, forward_step.F, and the_main_loop.F
30     o pkg/seaice:
31     - adjoint-friendly modifications
32     - added a SEAICE_WRITE_PICKUP at end of the_model_main.F
33 jmc 1.131
34 jmc 1.133 checkpoint48e_post
35 jmc 1.131 o New S/R for diagnostic of bottom pressure (phi0surf was missing in c48d_post)
36 jmc 1.132 o dynamics: change definition of computational domain & adapt mom_fluxform
37     accordingly ; when viscA4=0, allows to run the dynamics with Olx=Oly=2.
38     o following exp works with Olx=Oly=2 (and pass through checkbounds option):
39     adjust_nlfs.cs-32x32x1 adjustment.128x64x1 adjustment.cs-32x32x1
40 jmc 1.133 exp0 exp1 exp2 exp4 exp5 hs94.cs-32x32x5 hs94.128x64x5 hs94.1x64x5
41 jmc 1.132 global_ocean.90x40x15 global_with_exf global_ocean_pressure
42     inverted_barometer solid-body.cs-32x32x1
43     (high order AdvScheme and/or multiDimAd works with Olx=Oly=2 ? not sure)
44 jmc 1.130
45     checkpoint48d_post
46     o in preparation for r*:
47     a) use pre-computed gradient of hydrostatic potential:
48     changes in timestep.F & mom_cdscheme.F affects results of ideal_2D_oce
49     b) move phi0surf from calc_phi_hyd to calc_grad_phi_hyd:
50     => affects results of glob_oce_pressure (different truncation error)
51     update output.txt of ideal_2D_oce & global_ocean_pressure
52 jmc 1.129
53     checkpoint48d_pre
54     o in preparation for r*:
55     new S/R (calc_grad_phi_hyd.F) to compute Hydrostatic potential gradient.
56     pass the 2 comp. of the grad. as arguments to momentum S/R.
57     but for the moment, only used if it does not change the results.
58     o add finite volume form of calc_phi_hyd for buoyancyRelation OCEANIC & OCEANICP
59 jmc 1.126
60 heimbach 1.128 checkpoint48c_post
61     Modifications in treatment of initial flux forcing controls
62     to avoid extra storing of flux fields.
63    
64     checkpoint48c_pre
65 adcroft 1.127 o Added tidal_basin_2d experiment (currently 1D!)
66 jmc 1.126 o can use r* Coordinate with OBC (but Orlanski Rad. BC not yet implemented)
67 jmc 1.124
68 jmc 1.125 checkpoint48b_post
69 jmc 1.124 o r* coordinate added in #ifdef NONLIN_FRSURF block.
70     (modification to pressure gradient not yet implemented)
71     o mom_fluxform: new S/R mom_calc_rtrans.F computes vertical transports
72     (for U & V) that are used for vertical advection of momentum.
73 jmc 1.123
74     checkpoint48a_post
75     o In preparation for r*, use temp. array to compute vertical transport
76     in flux-form momentum pkg. => change results of few test-exp.
77     Update output of: exp4, exp5, front_relax, global_ocean_pressure,
78     lab_sea, natl_box & plume_on_slope
79 jmc 1.122
80     checkpoint48
81     o fix small bug that was causing lot of warning (TIMER_STOP 'UPDATE_CG2D')
82 heimbach 1.121
83     checkpoint47j_post
84 jmc 1.120 o add new exp. (ideal_2D_oce) to test "exotic" parameters and options.
85 heimbach 1.121 o moved adexch from forward_step to addummy_in_stepping
86     o added exch in ctrl_map_...
87     o aveFreq.=0. at end of cost_final to avoid overwrite in
88     reverse checkpointing loop
89     o Yet more changes in gmredi:
90     * adgmredi_calc_tensor
91     avoiding all recomputation of gmredi_slope_limit
92     * adgmredi_x/y/rtransport
93     added flag for excessive storing to avoid recomp. of
94     u/v/rtans, dTdx/y/z
95     -> this is not really necessary and very memory-consuming
96     * adgmredi_slope_psi:
97     consistency with gmredi_slope_limit in treatment of GM_slopeSqCutoff
98     * gmredi_slope_limit
99     re-activated full calculation of taperfct for case 'ac02'
100     o updating verification/ adjoints of carbon, global_ocean.90x40x15
101 heimbach 1.116
102 jmc 1.119 checkpoint47i_post
103     o GM_EXCLUDE_() replace GM_TAPER_(): by default, all the code is compiled.
104     o add GM_Small_Number & GM_slopeSqCutoff as run-time parameters (data.gmredi)
105     default values = 1.D-12 & 1.D+48 (=> give same results as checkpoint47f_post)
106     o cg2dTargetResWunit: define tolerance using deltaTmom (and not deltaTfreesurf)
107     o gmredi: fix few bugs.
108    
109 adcroft 1.118 checkpoint47h_post (duplicate tag for PH's c48 tag, in order to move c48)
110 heimbach 1.116 This will be a good checkpoint to plug into the ecco-branch.
111     o few modif.'s to get latest version adjointed
112     (mainly kick out code in ini_linear_phisurf)
113     o modif's to run adjoint with exactConserv
114     o case GM_BOLUS_ADVEC should be cleaned
115     S/R gmredi_slope_psi should be cleaned
116     o verification/carbon now has exactConserv=.TRUE.
117 jmc 1.114
118 heimbach 1.115 checkpoint47g_post
119 jmc 1.114 o time-average AIM output: becomes independent from statvars time-average
120     (can be used with #undef ALLOW_TIMEAVE) ; add new variables (e.g., RH)
121 heimbach 1.115 o After TAF bug fix:
122     Tested adjoint of gmredi package.
123     Tests were done with checkpoint47 rather than with latest
124     checkpoint47f_post since the latter is broken for the adjoint
125     verification/carbon/ contains both ADM and TLM gradient checks.
126     Here they are, before they get changed/lost/stolen.
127     Mostly modif.'s to fix numerical sensitivities.
128     Gradient checks OK for
129     - GM_taper_scheme:
130     * clipping
131     * ac02
132     * linear
133     * glw91
134     * dm95
135     * ldd97
136     - GMREDI_OPTIONS:
137     * GM_VISBECK_VARIABLE_K
138     * GM_NON_UNITY_DIAGONAL
139     * GM_EXTRA_DIAGONAL
140     * GM_BOLUS_ADVEC
141     in conjunction with data.gmredi parameters to be checked in
142     in a few minutes under verification/carbon/code/
143 cheisey 1.112
144 dimitri 1.113 checkpoint47f_post
145     Merging from release1_p10:
146     o modifications for using pkg/exf with pkg/seaice
147     - pkg/seaice CPP options SEAICE_EXTERNAL_FORCING
148     and SEAICE_EXTERNAL_FLUXES
149     - pkg/exf CPP options EXF_READ_EVAP and
150     EXF_NO_BULK_COMPUTATIONS
151     - usage examples are Experiments 8 and 9 in
152     verification/lab_sea/README
153     - verification/lab_sea default experiment now uses
154     pkg/gmredi, pkg/kpp, pkg/seaice, and pkg/exf
155    
156 cheisey 1.112 checkpoint47e_post
157     o created a tag prior to creating a branch
158    
159 mlosch 1.111 checkpoint47d_post
160     o fixed bug in the oceanic pressure coordinates code: vertical viscosity
161     at the bottom boundary had an erroneous half slip boundary condition
162     o added bottom drag and no slip boundary condition capabilities to
163     oceanic pressure coordinates code
164     o added new verification experiment global_ocean_pressure, this experiment is
165     also described in the tutorial section of the manual
166     checkpoint47d_pre
167 cheisey 1.110
168     checkpoint47c_post
169     o Added a verification experiment for a global cubed-sphere ocean run
170     - verification/global_ocean.cubed32x32x30
171     - uses pkg/therm_seaice and pkg/bulk_forcing
172 jmc 1.109
173     o allow to run AIM physics with SPEEDY input files (from Franco Molteni)
174     o allow a more accurate definition of Ro_Surf (selectFindRoSurf=1)
175     when using P-coordinate; only implemented for atmospheric config.
176     o OCEANICP & realFreshWater: include P-E direct effect on wVel ;
177     NOTES: requires option NONLIN_FRSURF to be "#define".
178     o update advect_xz/results/output.txt (left from checkpoint44g_post)
179 dimitri 1.108
180     checkpoint47b_post
181     Merging from release1_p9:
182     o pkg/seaice
183     - removed GOTO's and added taf directives
184     - double precision constants to reduce the g77 (Linux)
185     to F77 (SGI) differences reported in release1_p8
186     o tools/genmake
187     - added SGI options
188     o verification/testscript
189     - updated to that of checkpoint47a_post
190     o verification/global_ocean.90x40x15/input/eedata
191     - modified for SGI f77 compatibility
192     o verification/lab_sea
193     - added description of sea-ice model
194     - added missing matlab routines
195     - added test of thermodynamics parallelization
196 jmc 1.105
197 jmc 1.106 checkpoint47a_post
198 jmc 1.105 o new pkg: aim_v23
199     = F. Molteni atmos.physics (SPEEDY, ver23) adapted to MITgcm.
200     for now, keep the same surface forcing as before.
201     - Part-Cell implemented into AIM; check that Heat & Water are conserved
202     - aim.5l_cs: use new aim pkg (run 10yr & get better results than before)
203     - aim.5l_LatLon & aim.5l_Equatorial_Channel are still using old aim pkg
204     o add diagnostic of surface correction term in monitor output
205 jmc 1.106
206     o bulk_force and therm_seaice
207 cheisey 1.107 - Two packages: bulk_force (Bulk forcing)
208     and therm_seaice (thermodynamic_seaice) - adopted from LANL CICE.v2.0.2
209     - Earlier integration from Stephaine Dutkiewicz
210     and Patrick Heimbach.
211     - Two ifdef statements for compile time,
212     ALLOW_THERM_SEAICE and ALLOW_BULK_FORCE
213 heimbach 1.104
214     checkpoint47
215     differentiable version of checkpoint46n_post
216     o bug fix in quasihydrostaticterms
217     o * "clean" adjoint code (in terms of extensive recomputations)
218     can now be obtained for all GMREDI options (i.e. for
219     - GM_VISBECK_VARIABLE_K
220     - GM_NON_UNITY_DIAGONAL
221     - GM_EXTRA_DIAGONAL
222     - GM_BOLUS_ADVEC )
223     * However, wrong gradient check problem remains unsolved.
224     * New CPP options have been introduced for different
225     tapering schemes
226     o external_fields_load now part of differentiation list
227     o pressure needs multiple storing;
228     would be nice to have store_pressure at beginning or
229     end of forward_step, e.g. by having phiHyd global (5-dim.)
230     (NB: pressure is needed for certain cases in find_rho,
231     which is also invoked through convective_adjustment).
232     o recomputations in find_rho for cases
233     'JMD95'/'UNESCO' or 'MDJWF' are OK.
234     o #define ATMOSPHERIC_LOADING should be differentiable
235     o ini_forcing shifted to begining of initialise_varia
236     o Incorporating QNVS line search routines into MITgcm
237     (this is separate code, and therefore not under pkg)
238     lsopt/, optim/
239     o Updated verification/carbon/
240     - #define GM_VISBECK_VARIABLE_K
241     - GM_taper_scheme = 'ldd97'
242 heimbach 1.103
243     checkpoint46n_post
244     Merging from release1_p8:
245     o verification/natl_box:
246     updating new external_fields_load routine
247     o New package: pkg/seaice
248     Sea ice model by D. Menemenlis (JPL) and Jinlun Zhang (Seattle).
249     The sea-ice code is based on Hibler (1979-1980).
250     Two sea-ice dynamic solvers, ADI and LSR, are included.
251     In addition to computing prognostic sea-ice variables and diagnosing
252     the forcing/external data fields that drive the ocean model,
253     SEAICE_MODEL also sets theta to the freezing point under sea-ice.
254     The implied surface heat flux is then stored in variable
255     surfaceTendencyTice, which is needed by KPP package (kpp_calc.F and
256     kpp_transport_t.F) to diagnose surface buoyancy fluxes and for the
257     non-local transport term. Because this call precedes model
258     thermodynamics, temperature under sea-ice may not be "exactly" at
259     the freezing point by the time theta is dumped or time-averaged.
260     N.B.: fairly large differences in accuracy occur across
261     different platforms/compilers; comparison between
262     g77 (Linux) and F77 (SGI Origin 2000/MIPSpro)
263     generated output gives:
264     T S U V
265     C D M c m s m s m s m s
266     n p a R g m m e . m m e . m m e . m m e .
267     f n k u 2 i a a d i a a d i a a d i a a d
268     g d e n d n x n . n x n . n x n . n x n .
269    
270     Y Y Y Y 5 5 7 7 7 8 10 9 6 6 6 6 7 5 7 5 7 FAIL lab_sea
271     o GAD:
272     - generated new common blocks to account for call of
273     same gad routines with differing traceridentities
274     (needed to modify tracerIdentity indices in GAD.h)
275     - generated separate common blocks for case useCubedSphereExchange
276     (Department of Futurology)
277     - parameter lists to gmredi_?transport: added tracerIdentity
278     - added new key indices to tamc.h
279     o external_fields_load:
280     - added this routine to TAF list
281     - needed to make some common blocks global and additional storing
282     along the same lines as exf package (checkpoint_lev?_directives.h)
283     o exf:
284     updated external forcing package
285     - bug fixes carried over from ecco-branch
286     (missing OBCS_OPTIONS.h in two routines)
287     - enable easy to use "no forcing".
288     - added exf I/O for atmospheric loading
289     - added exf I/O for runoff data
290     - transfered scaling between exf <-> MITgcm to exf namelist
291     o Adding new verification experiment global_with_exf.
292     This verification experiment is almost identical to the
293     global_ocean.90x40x15 experiment, except that it uses
294     the exf (and cal) package instead of the
295     external_fields_load routine (cf README file).
296 adcroft 1.94
297 adcroft 1.102 checkpoint46m_post
298 adcroft 1.101 o modified testscript to return -- when there are no lines of "%MON" output
299 adcroft 1.100 o added new flag "quasiHydrostatic" for QH mode
300     and new routine quasihydrostaticterms()
301 adcroft 1.99 o added 2*Omega*Cos(phi)*W to u equations (non-hydrostatic Coriolis term)
302     New routine: mom_u_coriolis_nh()
303 adcroft 1.98 o fixed sign of non-hydrostatic metric terms in u and v equations.
304     Depend on correct sign of gravitySign.
305 adcroft 1.97 o added work.pc* to .cvsignore in aim directories using ifc
306 adcroft 1.96 o introduced flag for controllin non-hydrostatic metric terms
307 adcroft 1.95 o removed gravitySign from PARM04
308 adcroft 1.94 o switched to g77/ifc from pgf77 in aim experiments
309 mlosch 1.93
310     checkpoint46l_post
311     o made convective adjustment work with pressure coordinates:
312     - changed the direction of k-loop in convective_adjustment.F for the
313     case of pressure coordinates (OCEANICP,ATMOSPHERIC buoyancyRelation)
314     - adjusted the reference pressure k-index in convective_adjustment.F
315     - adjusted the convection condition in convect.F (in analogy to
316     calc_ivdc.F)
317     - convective_adjustment no longer computes anything on the halos
318     - removed the warnings about negative salinity from find_rho.F and
319     find_alpha.F; instead the new routine look_for_neg_salinity, called
320     at the beginning of find_rho, find_alpha, and find_beta, does a
321     check of the entire slice, if CPP-option
322     CHECK_SALINITY_FOR_NEGATIVE_VALUES is defined
323     checkpoint46l_pre
324 mlosch 1.91
325 mlosch 1.92 checkpoint46k_post
326 mlosch 1.91 o fixed the verification/global_ocean.90x40x15 experiment:
327     - new bathymetry (the world according to A., JMC, and M.)
328     - new initial fields and forcing fields (*.bin files)
329     - new POLY3.COEFFS (for the next release one should switch to a full
330     equation of state: JMD95P or MDJWF)
331     - fixed several errors and redundancies in the data file
332     - experiment uses looped cells
333     - added matlab directory with diagnostic scripts for plotting of output
334 jmc 1.90
335     o S/R aim_initialise.F replace S/R aim_init from file aim_do_inphys.F:
336     - read AIM physics parameters from a file (data.aimphys)
337     - set defaults values = F.Molteni paper (Clim.Dyn., 2002)
338 jmc 1.89
339     checkpoint46j_post
340     o split calc_exact_eta in 2 S/R : integr_continuity & update_etaH
341     o move wVel computation at the end of the time step, in S/R integr_continuity
342     o create specific S/R to exchange T,S before DYNAMICS (for stagger time step)
343     o update timeave pkg for wVel diagnostic.
344     checkpoint46j_pre
345 mlosch 1.87
346 jmc 1.88 checkpoint46i_post
347     o Clean up AIM package (and keep the results unchanged):
348     include CPP_OPTION and use IMPLICT NONE in all routines ;
349     declare all the variables _RL ; use _d 0 for all numerical constants.
350     use ifdef ALLOW_AIM everywhere. And now AIM can be used with g77 !
351 mlosch 1.87
352     checkpoint46h_post
353     o cleaned up the use of rhoNil and rhoConst.
354     - rhoNil should only appear in the LINEAR equation of state, everywhere
355     else rhoNil is replaced by rhoConst, e.g. find_rho computes rho-rhoConst
356     and the dynamical equations are all divided by rhoConst
357     o introduced new parameter rhoConstFresh, a reference density of fresh
358     water, to remove the fresh water flux's dependence on rhoNil. The default
359     value is 999.8 kg/m^3
360     o cleanup up external_forcing.F and external_forcing_surf.F
361     - can now be used by both OCEANIC and OCEANICP
362     checkpoint46h_pre
363    
364     Added code to convert surface volume flux (fresh water) into
365     a mass flux when using P coordinates in the ocean (OCEANICP).
366     Note: It assumes you have set rho0=rhoConst=density of fresh water.
367 mlosch 1.86
368     checkpoint46g_post
369     o Include a new diagnostic variable phiHydLow for the ocean model
370     - in z-coordinates, it is the bottom pressure anomaly
371     - in p-coordinates, it is the sea surface elevation
372     - in both cases, these variable have global drift, reflecting the mass
373     drift in z-coordinates and the volume drift in p-coordinates
374     - included time averaging for phiHydLow, be aware of the drift!
375     o depth-dependent computation of Bo_surf for pressure coordinates
376     in the ocean (buoyancyRelation='OCEANICP')
377     - requires a new routine (FIND_RHO_SCALAR) to compute density with only
378     Theta, Salinity, and Pressure in the parameter list. This routine is
379     presently contained in find_rho.F. This routine does not give the
380     correct density for 'POLY3', which would be a z-dependent reference
381     density.
382     o cleaned up find_rho
383     - removed obsolete 'eqn' from the parameter list.
384     o added two new verification experiments: gop and goz
385     (4x4 degree global ocean, 15 layers in pressure and height coordinates)
386     checkpoint46g_pre
387 heimbach 1.85
388     checkpoint46f_post
389     o Enable tangent linear (forward mode) gradient checks:
390     - extended active file handling to g_... files
391     - added TANGENT_SIMULATION to theSimulationMode
392     - extended grdchk package accordingly
393     o added tangent linear setup in verification/carbon/code_ftl
394     o added adjoint setup in verification/front_relax/code_ad
395 mlosch 1.82
396 cnh 1.84 checkpoint46e_post
397 mlosch 1.83 o Added new equation of state -> MDJWF
398     - EOS of McDougall et al., 2002, JAOT, submitted
399     - caveat: the equation of state is only valid for a smaller (more
400     realistic?) range of values than JMD95P/Z and UNESCO
401     - added masks to the calculation of pressure in store_pressure
402     - added more check values for density in check_eos (ini_eos.F), some of
403     the old check values are out of the range of the MDJWF-eos, so don't
404     expect perfect matches for those
405 cnh 1.84 checkpoint46e_pre
406 mlosch 1.83
407 mlosch 1.82 checkpoint46d_post
408     o fixed store_pressure to work with both buoyancy relation = 'OCEANIC' and
409     'OCEANICP', also initialised field pressure correctly in ini_eos in the
410     case of pressure coordinates. eosType='JMD95Z' in
411     combination with buoyancyRelation='OCEANICP' now causes an error.
412     o Changed p = pressure(i,j,k,bi,bj) to p = pressure(i,j,kRef,bi,bj)
413     in find_alpha/beta.
414     checkpoint46d_pre
415    
416     o Changed p = pressure(i,j,k,bi,bj) to p = pressure(i,j,kRef,bi,bj)
417     so that JMD95Z and JMD95P give approptiate static stability in find_rho.
418 adcroft 1.81
419     checkpoint46c_post
420     o Changes necessary for ocean in p-coordinates
421     - Added new buoyancy relation = 'OCEANICP'
422     - Added new parameters = gravitySign (this used to be contained inside
423     the factor dRdZ which I added when we first switched to R coordinates).
424     X GM/Redi is not compatible (yet)
425     X bottom drag and no-slip need to be debugged.
426     checkpoint46c_pre
427 mlosch 1.80
428     checkpoint46b_post
429     o Added new equation of state -> JMD95Z and JMD95P
430 mlosch 1.83 - EOS of Jackett and McDougall, 1995, JAOT
431 mlosch 1.80 - moved all EOS parameters into EOS.h
432     - new routines ini_eos.F, store_pressure.F
433     o Added UNESCO EOS, but not recommended because it requires
434     in-situ temperature (see JMD95)
435     o Modified formatting for knudsen2.f in utils/knudsen2 and added
436     unesco.f to be used with POLY3
437     checkpoint46b_pre
438 mlosch 1.79
439     checkpoint46a_post
440     o Added (atmospheric) pressure loading
441     - new field in FFIELDS.h, etc...
442     - new cpp flag ATMOSPHERIC_LOADING
443     o Changed hFacC to _hFacC in calc_phi_hyd.F
444     o Added SHORTWAVE_HEATING to some files for consistency
445     checkpoint46a_pre
446 heimbach 1.78
447     checkpoint46
448     further merges from release1_p5
449     o new ctrl package
450     - adopted from ECCO environment to enable optimization
451     - added Eliassen Palm fluxes to controls
452     o added Eliassen Palm flux controls to gradient check package
453     o cost package
454     - Compatible with new ctrl package
455     - added Eliassen Palm cost hooks
456     - modif's of existing cost functions
457     o Adjoint-related bug fixes in kpp:
458     - kpp_calc: sore of kpphbl avoids recomputation/call to S/R kppmix
459     - kpp_routines: store of Rib avoids partial recomputation bug of TAF.
460     o autodiff package
461     - flow directives:
462     + new for S/R do_the_model_io
463     + enhanced for S/R checkpoint
464     + new gmredi.flow
465     - Introduced CPP option ALLOW_AUTODIFF_MONITOR to
466     disable adcommon.h/g_common.h by default.
467     - fixed problem for adjoint of global_max
468     o modified verification/carbon/
469     o New setup for adjoint of global_ocean
470     o added hooks for Eliassen Palm fluxes (dynamics.F, ini_fields.F)
471     o cleaned TAF keys iikey, idkey (dynamics.F, thermodynamics.F)
472     o incorporated hooks for sponge layer code (external_forcing.F)
473    
474 jmc 1.77 checkpoint45d_post
475     o import 2 fixes from release1_p5 (CG2D.h & packages_readparms.F)
476 jmc 1.76 o use recip_dx*,recip_dy* instead of /dx*,/dy* in orlanski_E,W,N,S
477     (affects plume_on_slope "cg2d" output)
478 jmc 1.77 o add new parameter deltaTfreesurf for free-surface time stepping
479     o exchange gT,gS when using staggerTimeStep & GM & Oly<4
480 jmc 1.75 o NONLIN_FRSURF: rescale gNm1 to get a better conservation with A-B
481 jmc 1.74 o change phiMin in exp1 (to agree with documentation)
482     o add new flags:
483     - T,S forcing inside/outside Adams-Bashforth
484     - turn off temp,salt advection and/or forcing
485     - for each tracer, define internal flag for multiDimAdvection & A-B
486     o monitor: change definition of KE to check conservation of Energy
487 heimbach 1.73
488     checkpoint45c_post
489     o Removed f90 comments ("!")
490     o Modified initialisations to enable exf package for MITgcm
491     (without invoking ECCO_PACKAGE).
492     o modifications to gradient check package (Martin Losch)
493     - enable centered differences
494     - modified format of standard output
495 heimbach 1.72
496     checkpoint45b_post
497     o cleaned exchange calls in cg2d
498     o Included CPP option ALLOW_AUTODIFF_MONITOR in forward_step
499     o included CPP option SINGLE_LAYER_MODE in thermodynamics
500     to configure barotropic setup (Martin Losch)
501     o moved some initialisations within bi,bj loop in dynamics
502     (TAF flow dependency)
503     o in initialise_varia, moved call packages_init_variables
504     before convective_adjustment_init
505     (corresponding adjustment of TAF tape initialisation).
506     o in calc_diffusivity/calc_viscosity extended domain to full overlap.
507 jmc 1.70
508 jmc 1.71 checkpoint45a_post
509     o compute Rho over the whole domain (extend iMin,jMin indices)
510     o specific exchange for X-slice domain (case Ny=1)
511 jmc 1.70 o argument futureIter of S/R obcs_calc missing in exp4 & internal_wave /code
512     o solve_for_pressure : set cg2d_x to zero where OBCS are applied
513 jmc 1.67
514 heimbach 1.69 checkpoint44h_post = checkpoint45
515     o Fix to restore differentiability:
516     place at which packages_init_variables is called in
517     initialise_varia is crucial for reverse control flow.
518     o modifications in GMRedi to enable stable adjoint
519     (corresponding modif's in thermodynamics, dynamics)
520     o added missing hook for sponge layer code in external_forcing
521     o modified test cost functions
522     o storing in gad_advection (plus removal of write(0,*)!
523     o missing headers TR1.h added in convective_adjustment routines
524     o errorMessageUnit set non-equal zero in eeboot
525     (conflict on some platforms, e.g. IBM SP3)
526     o modified carbon verif.
527    
528     checkpoint44h_pre
529 jmc 1.68 o vertical grid option: allow to put the Interface at the middle between
530     2 cell-centers ; replace delZ in pkg/kpp by drF.
531 jmc 1.67 o GM Advective form: Tracers are advected using the residual transport (=
532     Euler+GM-bolus); set param GM_AdvSeparate=T to return to previous form.
533 jmc 1.66
534     checkpoint44g_post
535     o fix surface correction term in multiDimAdvection (affects plume_on_slope
536     results) ; ifdef missing in thermodynamics.F
537 adcroft 1.65
538     checkpoint44f_pre,checkpoint44f_post
539     o added PTRACERS package
540     This allows an arbitrary number of passive tracers to be integrated
541     forward simultaneously with the dynamicaly model.
542     + Implemented so far:
543     - basic forward algorithm (time-stepping, advection, diffusion, convection)
544     - I/O and checkpointing
545     - GM/Redi *but* using the GM/Redi coefficient of Salt
546     + Not implemented so far:
547     - KPP
548     - OBCS
549     + No specific example supplied (yet) but global_ocean.90x40x15 has the
550     necessary data.ptracer file. Simply use -enable=ptracers and uncomment
551     line in data.pkg.
552     + This package is disabled by default since it increases storage.
553    
554 jmc 1.60
555 adcroft 1.64 o testscript: added -cleanup option
556 jmc 1.63 o Shap_filt: a) new shap_filt S/R to use no-slip BC with S2 filter
557     b) enable to filter 2D fields.
558 adcroft 1.62
559     checkpoint44e_pre,post
560     o re-wrote convective adjustment to use pre-calculated weights
561     Affects: model/src/convective_adjustment.F, convective_adjustment_ini.F
562     Adds: model/src/convective_weights.F, convectively_mixtracer.F
563     Original calls to convect() still in place.
564 heimbach 1.61
565     chkpt44d_pre,post
566     o added missing EXCLUDE_MONITOR flags
567     o changed "e" to "_d" in gmredi_slope_limit, gmredi_slope_psi
568     (incompatible typ in MIN/MAX expressions caused problems
569     on IBM SP3)
570     o in genmake added variable MAKEDEPEND
571     plus resetting for case SunOS
572     o added timer_stats.c routine for IBM SP3
573     o removed variables in dynamics
574     !!! I forgot to create tag chkpt44d_pre !!!
575     !!! But chkpt44d_pre = chkpt44c_post !!!
576 jmc 1.63
577     o real fresh water flux implemented with non-linear free-surface.
578 heimbach 1.58
579 jmc 1.59 chkpt44c_pre,post
580     o few fix (mask in shap_s2, EmPmR in external_field_load,
581     USE_NATURAL_BCS in solve_for_P);
582     o add arguments myIter & myTime to S/R obcs_calc & solve_for_P
583    
584 heimbach 1.58 checkpoint44b_pre/_post
585     o merge of relevant stuff from the ecco-branch:
586     - genmake: removed $S64 overwrite for case SunOS
587     - pkg/exf: update and corrections for field swapping and obcs
588     - pkg/ecco: parameter lists for the_model_main, the_main_loop
589     harmonized between ECCO and MITgcm
590     - pkg/autodiff: added flow directives for obcs, mdsio_gl_slice
591     updated checkpointing_lev... lists for obcs
592     - model/src: minor changes in forward_step, plot_field
593     added directive for divided adjoint in the_main_loop
594     - pkg/mdsio: added mdsio_gl_slice
595 jmc 1.57
596     o check parameters & config (chkpt44a_pre,post)
597 jmc 1.56 o OBC and NonLin_FrSurf.
598    
599 heimbach 1.55 checkpoint44
600 jmc 1.54 o fix bug in mom_vi_del2uv
601 jmc 1.56 o select when filters are applied ; add options to zonal_filter (data.zonfilt)
602     o gmredi: fix Pb in the adiabatic form ; add options (.e.g. Bolus advection)
603     o update AIM experiments (NCEP input files)
604     o improve and extend diagnostics (Monitor, TimeAve with NonLin-FrSurf)
605 heimbach 1.55 o added some stuff for AD
606 adcroft 1.53
607     checkpoint43
608     o added two new advection tests
609     o added global 4x4 degree ocean test
610     o added test of H&S94 with free surface on cube
611     o some final mods for gradient check, adjoint,...
612 heimbach 1.52
613     checkpoint42
614     Fixed AD-related problems:
615     o Store directives up-to-date with re-arranged Adams-Bashforth
616     (mainly thermodynamics.F)
617     o New store directives for multi-dim. advection schemes
618     * new CPP flag ALLOW_MULTI_DIM_ADVECTION
619     * new common block and key passkey
620     (mainly gad_advection.F)
621     o Modified store directives for split of dynamics/thermodynamics
622     for the case ALLOW_KPP
623     o Cleaned argument list for timestep_tracer.F
624 adcroft 1.51
625     checkpoint41
626     o re-formatted/added comments in prologues of key subroutines
627     to work with protex
628 heimbach 1.47
629 adcroft 1.50 checkpoint40
630     o moved calc_gs, calc_gt and calc_tr1 back to model/src
631     o added FLT (floats) package from Arne along with demo. experiment
632     o re-arranged Adams-Bashforth scheme for tracers to allow easier
633     implementation of forward-in-time forcing terms
634     o more mods for non-linear free-surface including new variable
635     o modified multi-dim method to work on cube
636     o bug fix in KPP (from DM)
637    
638 adcroft 1.49 checkpoint40pre9
639     o added DST advection schemes
640     o fix MPI bug on SGI's
641     o modifications for non-linear free-surface
642     o fixed conditionals for fixed flow/passive tracer only mode
643     o added tension/strain form of stress tensor
644     o changes to commenting of arguments for TAF/TAMC
645     o added/updated many matlab scripts
646 adcroft 1.50 o added multi-dimensional advection method for tracers
647 adcroft 1.49
648 adcroft 1.48 checkpoint40pre8
649 heimbach 1.47 o new package rw/
650     Added method for dumping intermediate local arrays:
651     mdsio_writetile - same as mdsio_writefield except works from inside
652     bi,bj loop
653     mdsio_writelocal - same as mdsio_writetile except works for local
654     arrays
655     write_local_r? - higher-level wrapper for mdsio_writelocal
656     Controlled by diagFreq. Defaults to zero (ie. no dumps)
657     Example given at end of mom_vecinv.F that dumps some local arrays.
658     o replaced calc_mom_rhs.F by mom_fluxform.F/mom_vecinc.F to
659     control flux-form versus vector invariant code.
660     Switch is runtime flag vectorInvariantMomentum (defaults to false)
661     or genmake -DISABLE ...
662     o TAMC-related update to cope with mom_fluxform.F/mom_vecinc.F
663     (additional storing is now needed for case vecinv;
664     currently nothing implemented to switch this storing off
665     in case fluxform is used since no CPP flag available).
666 heimbach 1.46
667     checkpoint40pre7
668     o bug fix in dynamics.F
669     calc_viscosity called before k=1,Nr loop.
670     o added some #ifdef's ALLOW_PASSIVE_TRACER
671     o cleaned initialisations in ctrl_map_ini
672     related to TAF
673 heimbach 1.45
674     checkpoint40pre6
675     o split dynamics into thermodynamics & dynamics
676     o corresponding split of calc_diffusivity into
677     calc_diffusivity, calc_viscosity
678     (kpp_calc_diff, kpp_calc_visc).
679     o Added diffkr, kapgm to control variables
680     o bug fix in gmredi_slope_limit for ldd97
681 adcroft 1.44
682     checkpoint40pre5
683     o proper initialization of Adams-Bashforth time stepping
684     + uses forward step for very first step of model (iter=0)
685     o re-generated *all* output since almost all output is modified by this
686     change (sorry but we've been putting this one off for about 2 years)
687     + natl_box, aim.5l_Equatorial_Channel and aim.5l_zon-ave were
688     *not* regenerated since they are already out of date and I don't
689     want to create the impression that they are suddenly working.
690     o removed KAP stuff for DEC's
691     o modified/added many .cvsignore files in */code and */input
692     o added new expt "solid-body.cs-32x32x1"
693     + this uses an alternative form of ini_curvilinear_grid.F which
694     is not necessarily any better than the current one...
695 heimbach 1.43
696     checkpoint40pre4
697     o added re-initialisations of utrans,vtrans,rtrans in
698     calc_common_factors which are crucial for TAF.
699     o extended iMin,jMin range for calc_common_factors,
700     calc_diffusivity
701     o added option ALLOW_PASSIVE_TRACER
702     o a few minor updates and fixes
703    
704 heimbach 1.42 checkpoint40pre3
705     o created calc_gtr1.F for gad package
706     o split the_main_loop and re-introduced forward_step
707     o some recomputations of nIter0 for TAMC
708    
709 heimbach 1.41 checkpoint40pre2
710     o Updated to latest branch of AJA, JMC
711     o Added gradient check package
712     o Added routines for passive tracer handling
713     o Added carbon sequestration sensitivity experiment
714    
715 heimbach 1.39 checkpoint39
716     o Modifications and fixes to support TAMC
717     (mainly missing or wrong directives)
718     o Corrected common blocks when fooling TAMC to produce adjoint I/O
719     in addummy_in_stepping
720     o Updated verification/vero/ (bug fixes in code/, correct pickups in input/)
721     o Enabled "sliced" (xz-,yz-) exchanges, needed for obcs.
722     o Included following packages:
723     cal: calendar
724     exf: external forcing
725     ecco: essential routines to control use of cal, exf
726     (NB: this is not the full ECCO environment)
727 heimbach 1.40 o disabled some packages by default in genmake
728 heimbach 1.39
729 heimbach 1.38 checkpoint38
730     o see notes_c37_adj.txt
731     o corrected wrong layer index in external_forcing_t
732     o replaced the_main_loop/forward_step by the_main_loop
733     o removed forceoutput from write_state
734     (replaced criteria for initial/final state)
735     o added runtime flag for pre-C35 pickups: usePickupBeforeC35
736 jmc 1.36
737 jmc 1.37 checkpoint37
738     o mdsio.F routine split and packaged in pkg/mdsio
739     (mdsio.F and mdsio_gl.F still exist in eesupp/src but are not
740     used unless genmake -disable=mdsio)
741     o allow a more precise surface-geopotential gradient for the atmosphere
742     taking into account the change in space of Alpha (=1/rho) at the surface.
743     o variable "etaN" (replace cg2d_x) is the surface R-anomaly [r unit]
744     (ocean: sea surface height [m] / atmos: surface pressure anomaly [Pa])
745     o Change units: Phi_Hydrostatic (=phiHyd), Phi_Surface(=cg2d_x) and
746     Phi_NonHydrostatic (=cg3d_x), all have now the dimension of a potential
747     [m2/s2] (pressure/rhoConst in the ocean ; Geo-Potential in the atmosphere).
748     o Time-Average diagnostics defined as a pseudo package "timeave".
749     o pickup files : old pickup (before c35) did not work with new code (c35
750     and after) unless activating 2 commented lines in initialise-varia.
751     o Non-Hydrostatic pickup file Pb fixed.
752     o bug with Rigid-lid version (since c35) fixed.
753    
754 jmc 1.36 checkpoint36
755 jmc 1.37 o implement Crank-Nickelson barotropic time-stepping
756 jmc 1.36 o recover Time-Average diagnostics
757     o fix Pb in checkpoint (PR#19)
758     o AIM become a standard package ; clean unused CPP_kees
759 jmc 1.35
760     checkpoint35
761     o subtantial rewrite of dynamics.f
762     o allows staggered time-stepping
763     o packaged obcs, aim (Atmospheric Physics), zonal_filt, shap_filt
764     o added bottom drag (linear + quadratic)
765 heimbach 1.33
766     checkpoint34
767     o Modified exchange routines for correct reverse simulation.
768     o Added verification output to comply with bug fix in impldiff.F
769     as of c33 (exp2, natl_box).
770     o Corrected store directives in dynamics.F
771     o Corrected array boundaries in impldiff.F
772     o Corrected array dimensions in gmredi.
773     Added temporary scalars to avoid storage by TAMC (gmredi, kpp).
774 heimbach 1.34 o Added routine GLOBAL_SUM_INT to global_sum.F
775 heimbach 1.33 o Added mdsio_gl.F for ECCO purposes.
776 adcroft 1.32
777     checkpoint33
778     o Fixed bug in lower BC in impldiff.F
779     o Fixed confusion about units of forcing arrays in FFIELDS.h
780     namely Fu,Fv,Qnet,Qsw,EmPmR:
781     - Removed verification/natl_box/code/external_fields_scale.F
782     (did not differ from that in model/src)
783     - Changed units of fu,fv,Qnet,Qsw,EmPmR back to proper units
784     (see FFIELDS.h for description)
785     - Scale fu,fv,Qnet,Qsw,EmPmR when used in external_forcing_surf.F,
786     kpp_calc.F and kpp_transport_t.F
787     - Removed model/src/external_fields_scale.F and calls to it
788     - verification/natl_box uses flux data with "atmospheric" sign so
789     a special version of external_fields_load.F is used to
790     change the data as it's read in. This way, the arrays
791     have the right units and signs at all times tha a user could
792     possibly use them.
793     o Corrected genmake to delete a temporary file during configuration
794 heimbach 1.31
795     checkpoint32
796     o Scaling of forcing fields moved from external_forcing.F to
797     external_fields_scale.F, called directly after loading fields.
798     o Surface relaxation terms added to surface tendency fields in
799     extra subroutine.
800     o impldiff.F changed to avoid storing by TAMC of huge intermediate
801     fields.
802     o Changes in GMRedi to comply with packaging structure.
803     o Modifications and bug fixes in KPP package.
804     o Verification experiment for KPP added (verification/nat_box/)
805 heimbach 1.30
806     checkpoint31
807     o Packages interface brought in line with defined standard
808     -> new routines packages_...F
809     -> changes in initialise_fixed.F, initialise_varia.F
810     -> enables initialisation interface for ECCO package
811     o Rescaling of external forcing fields immediately after read
812     (removed from external_forcing.F)
813     -> new: surface_fields_scale.F
814     -> affects ini_foorcing.F, external_fields_load.F
815     o Computation of surface tendencies before tendency updates.
816     -> new: external_forcing_surf.F
817     o Change of variable names useGMRedi, useKPP, useECCO
818     o Further changes in dynamics.F, impldiff.F for TAMC
819     o Tested for experiments 0, 2, 4.
820     - not yet tested for GMRedi.
821     - not yet tested for KPP.
822 adcroft 1.29
823     checkpoint30
824     o Updates for OBCs
825     o New experiment for test OBCs (internal_wave)
826     o New output.txt in verification/exp4/results/
827     o Updates for KPP: calculation of viscosity corrected, new variables
828     kpp_dumpFreq and kpp_taveFreq
829     o CPP'd calls to system routines for TARGET_CRAY_VECTOR (P.H.)
830     and entry for T90 in genmake
831 adcroft 1.28
832     checkpoint29
833     o packaged KPP and GM/Redi
834 heimbach 1.27
835     checkpoint28
836     o Corrected initialization of hFacMin for difference vertical coordinates
837     o Modified calculation of partial cell thickness to more robust algorithm
838     o config_summary.F: replaced write_1D_... by write_0D_...
839     read_write.F: added subroutines write_0D_...
840     o routines calc_common_factors, calc_gs, calc_gt, calc_phi_hyd, find_rho:
841     included some initialisations required for TAMC.
842     o routine calc_isoslopes: modified sqrt computation to make it
843     differentiable for zero argument.
844     o routines dynamics, impldiff:
845     included store directives and tape key computations required for TAMC.
846     o ALL TAMC related changes are between ifdef ALLOW_AUTODIFF_TAMC
847 adcroft 1.26
848     checkpoint27
849     o fixed calc_isoslopes() to so that cancellation of terms in tensor
850     formulation works properly with variable resolution.
851     o restructured the calling tree between the_model_main() and dynamics()
852     o split initialise() into initialise_fixed() and initialise_varia()
853     o introduced initialization file pSurfInitFile for free surface (cg2d_x)
854     in new routine ini_psurf()
855 adcroft 1.25
856     checkpoint26
857     o moved some #ifdef in optional routines to encompass everything
858     except the argument declarations. This was using up some memory.
859     o fixed macros like _ADT to work with both versions of Linux cpp
860     o cleaned up some unused and uninitialized variables
861     (helps when debugging with strict compile options)
862     o split up CPP_EEOPTIONS.h into options and macros
863     (macros are now in eesupp/inc/CPP_EEMACROS.h)
864     o patch for 2 processor JAM mode
865 adcroft 1.24
866     checkpoint25
867     o updates for OBCs and NH
868     o dramatically reduced memory usage
869     o added "JAM" routines for use on Artic network
870     o parameterization of convection by implicit vertical diffusion
871     o added a diagnostic of convective index
872     o moved call to calc_divg_hat() from dynamics() to solve_for_pressure()
873     (this is was partly for OBCs and NH but also in anticipation of
874     an explicit free-surface option)
875     o initial state input files for U and V
876 adcroft 1.23
877     checkpoint24
878     o Removed some spurious "REAL"s
879     o Updated KPP to latest version from JPL
880     o Added a COS(latitude) in horizontal viscosity
881 adcroft 1.22
882     checkpoint23
883     o Added del^4 diffusion for salt and temperature
884     o Multiple minor fixes (implicit none's, arguments to global_sum, etc.)
885 adcroft 1.21
886     checkpoint22
887     o Made many small changes: implicit none, format(i5), etc...
888     o Introduced KPP mixing scheme (compiles and runs but *not* tested)
889 adcroft 1.20
890     checkpoint21
891     o Introduced new I/O package that supports direct-access records (mdsio.F)
892     o Split-up mid-level I/O routines
893     o Updated input data for experiments 0,1,2,4 and 5
894     o Finally removed the genmake.* scripts (everyone seems happy with genmake)
895 adcroft 1.18
896 adcroft 1.19 checkpoint20
897     o Tidied up open-boundaries some more
898     o Added non-hydrostatic code
899     o Fixed some input data
900     o Modified MPI start-up to work in "coupled" context.
901    
902 adcroft 1.18 checkpoint19
903     o Tidied up directory structure for verification experiments.
904     o Added new code for open boundaries.
905     o Corrected advective terms near boundaries.
906     o Added CPP flag for "old UV" geometry and corrected spherical geometry.
907     o Implemented free-slip/no-slip BCs and del^4 dissipation.
908 adcroft 1.19 o Split default parameters out of ini_parms.F into set_defaults.F.
909 cnh 1.17
910     checkpoint18
911     o Further changes for optional code generation with
912     CPP - ugh!
913 cnh 1.16
914     checkpoint17
915     o Beginning to incorporating modularity
916     for supporting atmos. and ocean configs.
917     o Small changes for TAMC complinace
918     o New ultra simple test case. Barotropic box
919     configuration "exp0".
920 cnh 1.15
921     checkpoint16
922     o Minor changes to exchange routines to support
923     accumulation in reverse mode. Adjoint of an
924     assignment is an addition.
925     o Changes to support compilation by TAMC (LR(1)
926     syntax) and by g77 under Linux ( 72 character
927     limit ).
928 cnh 1.14
929     checkpoint15
930     Rewrote exchange routines to allow
931     o General tile <-> tile connectivity.
932     o TAMC reverse mode flag ( is this really needed? )
933     o Variable width overlap and exchange region widths.
934     o Hooks for sharing data via DMA, Arctic, Memory Channel,
935     shmput/shmget, VIA, SYSV shmem and every other cool
936     communication method.
937 cnh 1.13
938     checkpoint14
939     Consistent isomorphism chages made. These allow dynamical core
940     to support both pressure and meters as a vertical coordinate.
941 cnh 1.12
942     checkpoint13
943     Release which corrects global_max problem and a couple
944     of KGM time-averaging diagnostic errors. Also contains
945     a double-gyre experiment setup as well as the baseline
946     4 degree global template. The double gyre template is
947     organised to allow it to be applied automatically to
948     the baseline configuration.
949 adcroft 1.11
950     branch-point-rdot
951     A few tidy-ups have been made bt the real point of this
952     check-point (excuse the pun) is to allow a branch to be
953     made for the purposes of adding the rDot alterations.
954     I don't want to commit the rDot to the main-trunk until
955     we've actually tested it...
956 cnh 1.10
957     checkpoint12
958     Tidy up and added generic genmake script (formerly
959     configure script).
960     Released to testers.
961 adcroft 1.9
962     checkpoint11
963     Re-arranged initialise() and introduced ini_vertical_grid()
964     and ini_masks_etc().
965 adcroft 1.8
966     checkpoint10
967     Introduced the configure script.
968     Separated out the diags package.
969     Added template for writing time-averages of tile/intermediate quantities.
970     Updated SIZE.h in exp2 and made the data big-endian.
971 adcroft 1.7
972     checkpoint9
973     MPI fix. Filename changes (meta/data). salbin*y stuff.
974     General tidy-up.
975     SST.bin SSS.bin added to verification/exp2
976 adcroft 1.6
977     checkpoint8
978     Inludes time-dependant forcing and time-averaging.
979     Works at 4x4 and 2.8125x2.8125 global
980    
981     checkpoint7-4degree-ref
982     Branch from checkpoint7. Released for application to
983     global modeling and general modeling - process studies, regional
984     model etc..
985     Configured for verification/exp2 - 4 degree global, two process.
986 cnh 1.5
987     checkpoint7
988     Created by cnh
989     Simple 4 degree global simulation
990     configuration.
991     Includes climatological wind,
992     hydrography, bathymetry etc
993     Does not include Heat Flux and E-P
994 cnh 1.4
995     checkpoint6
996     Created by cnh
997     merged checkpoint5 with CD and
998     spherical polar code.
999     Still some problems with GM Redi
1000     abd full topography.
1001 cnh 1.3
1002     checkpoint5
1003     Created by AJA
1004     contains updates to GM Redi
1005     and reordered timestepping loop
1006     for Implicit Diffusion.
1007 cnh 1.2
1008     checkpoint4
1009     Created by cnh
1010     Contains memory saving macros ( _rdxc etc..) for when
1011     grid variations are limited.
1012     Contains polynomial coeffs for EOS and knudsen program
1013     for generation.
1014    
1015 cnh 1.1 checkpoint3
1016     Created by cnh
1017     Added extra flags for runtime options
1018     Added this file
1019     Added implicit free-surface
1020     Added pre-conditioner
1021     Put compare01 into repository ( compare01/... )
1022     Put data and eedata into repository ( verification/exp1 )
1023    
1024     checkpoint2
1025     Created by AJA
1026     Added GM/Redi
1027    
1028     checkpoint1
1029     Created by AJA
1030     Restructured kloop in dynamics.F
1031     Added non-linear EOS
1032    
1033 cnh 1.2 baseline
1034     Original checked in code
1035 cnh 1.1

  ViewVC Help
Powered by ViewVC 1.1.22