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

Diff of /MITgcm/doc/tag-index

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

revision 1.3 by cnh, Mon Jun 8 19:25:25 1998 UTC revision 1.53.2.25 by dimitri, Fri Feb 7 07:23:41 2003 UTC
# Line 3  $Header$ Line 3  $Header$
3      Notes on tags used in MITgcmUV      Notes on tags used in MITgcmUV
4      ==============================      ==============================
5    
6    untagged modifications
7    o Updated useSingleCpuIO option in mdsio_writefield.F to
8      work with multi-field files, e.g., for single-file pickup.
9    o pkg/seaice:
10      - bug fix in growth.F: QNET for no shortwave case
11      - added HeffFile for specifying initial sea-ice thickness
12    
13    release1_p11
14    o Modifications for using pkg/exf with pkg/seaice
15      - improved description of the various forcing configurations
16      - added basic radiation bulk formulae to pkg/exf
17      - units/sign fix for evap computation in exf_getffields.F
18      - updated verification/global_with_exf/results/output.txt
19    o Added pkg/sbo for computing IERS Special Bureau for the Oceans
20      (SBO) core products, including oceanic mass, center-of-mass,
21      angular, and bottom pressure (see pkg/sbo/README.sbo).
22    o Lower bound for viscosity/diffusivity in pkg/kpp/kpp_routines.F
23      to avoid negative values in shallow regions.
24      - updated verification/natl_box/results/output.txt
25      - updated verification/lab_sea/results/output.txt
26    o MPI gather, scatter: eesupp/src/gather_2d.F and scatter_2d.F
27    o Added useSingleCpuIO option (see PARAMS.h).
28    
29    release1_p10
30    o modifications for using pkg/exf with pkg/seaice
31      - pkg/seaice CPP options SEAICE_EXTERNAL_FORCING
32        and SEAICE_EXTERNAL_FLUXES
33      - pkg/exf CPP options EXF_READ_EVAP and
34        EXF_NO_BULK_COMPUTATIONS
35      - usage examples are Experiments 8 and 9 in
36        verification/lab_sea/README
37      - verification/lab_sea default experiment now uses
38        pkg/gmredi, pkg/kpp, pkg/seaice, and pkg/exf
39    
40    release1_p9
41    o pkg/seaice
42      - removed GOTO's and added taf directives
43      - double precision constants to reduce the g77 (Linux)
44        to F77 (SGI) differences reported in release1_p8
45    o tools/genmake
46      - added SGI options
47    o verification/testscript
48      - updated to that of checkpoint47a_post
49    o verification/global_ocean.90x40x15/input/eedata
50      - modified for SGI f77 compatibility
51    o verification/lab_sea
52      - added description of sea-ice model
53      - added missing matlab routines
54      - added test of thermodynamics parallelization
55    
56    release1_p8
57    o verification/natl_box:
58      updating new external_fields_load routine
59    o New package: pkg/seaice
60      Sea ice model by D. Menemenlis (JPL) and Jinlun Zhang (Seattle).
61      The sea-ice code is based on Hibler (1979-1980).
62      Two sea-ice dynamic solvers, ADI and LSR, are included.
63      In addition to computing prognostic sea-ice variables and diagnosing
64      the forcing/external data fields that drive the ocean model,
65      SEAICE_MODEL also sets theta to the freezing point under sea-ice.
66      The implied surface heat flux is then stored in variable
67      surfaceTendencyTice, which is needed by KPP package (kpp_calc.F and
68      kpp_transport_t.F) to diagnose surface buoyancy fluxes and for the
69      non-local transport term.  Because this call precedes model
70      thermodynamics, temperature under sea-ice may not be "exactly" at
71      the freezing point by the time theta is dumped or time-averaged.
72      N.B.: fairly large differences in accuracy occur across
73            different platforms/compilers; comparison between
74            g77 (Linux) and F77 (SGI Origin 2000/MIPSpro)
75            generated output gives:
76       T           S           U           V
77      C D M    c        m  s        m  s        m  s        m  s
78      n p a R  g  m  m  e  .  m  m  e  .  m  m  e  .  m  m  e  .
79      f n k u  2  i  a  a  d  i  a  a  d  i  a  a  d  i  a  a  d
80      g d e n  d  n  x  n  .  n  x  n  .  n  x  n  .  n  x  n  .
81    
82      Y Y Y Y  5  5  7  7  7  8 10  9  6  6  6  6  7  5  7  5  7 FAIL  lab_sea
83    
84    release1_p7
85    o GAD:
86      - generated new common blocks to account for call of
87        same gad routines with differing traceridentities
88        (needed to modify tracerIdentity indices in GAD.h)
89      - generated separate common blocks for case useCubedSphereExchange
90        (Department of Futurology)
91      - parameter lists to gmredi_?transport: added tracerIdentity
92      - added new key indices to tamc.h
93    o external_fields_load:
94      - added this routine to TAF list
95      - needed to make some common blocks global and additional storing
96        along the same lines as exf package (checkpoint_lev?_directives.h)
97    o exf:
98      updated external forcing package
99      - bug fixes carried over from ecco-branch
100        (missing OBCS_OPTIONS.h in two routines)
101      - enable easy to use "no forcing".
102      - added exf I/O for atmospheric loading
103      - added exf I/O for runoff data
104      - transfered scaling between exf <-> MITgcm to exf namelist
105    o Adding new verification experiment global_with_exf.
106      This verification experiment is almost identical to the
107      global_ocean.90x40x15 experiment, except that it uses
108      the exf (and cal) package instead of the
109      external_fields_load routine (cf README file).
110    
111    release1_p6
112    o fixed the verification/global_ocean.90x40x15 experiment:
113     - new bathymetry (the world according to A., JMC, and M.)
114     - new initial fields and forcing fields (*.bin files)
115     - new POLY3.COEFFS (for the next release one should switch to a full
116       equation of state)
117     - fixed several errors and redundancies in the data file
118     - experiment uses looped cells
119     - added matlab directory with diagnostic scripts for plotting of output
120    
121    release1_p5
122    o import recent fix from MAIN branch:
123      - use recip_dx*,recip_dy* instead of /dx*,/dy* in orlanski_E,W,N,S
124      - change phiMin in exp1 (to agree with documentation)
125     from checkpoint45 to checkpoint45a_post:
126      - specific exchange for X-slice domain (case Ny=1)
127      - argument futureIter of S/R obcs_calc missing in
128        exp4 & internal_wave /code
129      - solve_for_pressure : set cg2d_x to zero where OBCS are applied
130     from checkpoint44f_post to checkpoint44g_post:
131      - fix surface correction term in multiDimAdvection
132        (affects plume_on_slope results
133    o bug fix in packages_readparms (missing ALLOW_CALENDAR)
134    o bug fix in CG2D.h (correct array size for LETS_MAKE_JAM
135    o Adjoint-related bug fixes in kpp:
136      - kpp_calc: sore of kpphbl avoids recomputation/call to S/R kppmix
137      - kpp_routines: store of Rib avoids partial recomputation bug of TAF.
138    o added Eliassen-Palm flux hooks (dynamics,ini_fields)
139    o removed unused TAF keys iikey, idkey (dynamics,thermodynamics)
140    o flow directives:
141      - new for S/R do_the_model_io
142      - enhanced for S/R checkpoint
143    o added Eliassen Palm flux controls to gradient check package
144    o new ctrl package
145      - adopted from ECCO environment to enable optimization
146      - added Eliassen Palm fluxes to controls
147      - adjusted global_ocean.90x40x15/ and carbon/ accordingly
148    
149    release1_p4
150    o Removed f90 comments ("!")
151    o Modified initialisations to enable exf package for MITgcm
152      (without invoking ECCO_PACKAGE).
153    o modifications to gradient check package (Martin Losch)
154      - enable centered differences
155      - modified format of standard output
156    
157    release1_p3
158    o added tangent linear setup to verification/carbon/
159    o added adjoint sensitivity setup to verification/global_ocean...
160    o moved packages_init_variables before convective_adjustment
161    o output of verif. which use GMRedi brought up-to-date with
162      MAIN trunk (those were re-created after changes in GMRedi)
163    o included CPP option SINGLE_LAYER_MODE
164      to configure barotropic setup (Martin Losch).
165    o Removed auxiliary variable in impldiff
166      (caused numerical differences with MAIN trunk routine).
167    o Introduced CPP option ALLOW_AUTODIFF_MONITOR to
168      disable adcommon.h/g_common.h by default.
169    o Cleaned exchange calls in cg2d.
170    
171    release1_p2
172    o fixed array boundary problem for adjoint
173      (related to partial recomputation within subroutine
174      related to dynamics -> calc_viscosity -> mom_...
175    o fixed recomputation in thermodynamics
176    o prepare (but not complete) recomputation problem in impldiff
177    o fixed problem for adjoint of global_max
178    o switched off sponge layer code in external_forcing
179    
180    release1_p1
181    o merged necessary patches:
182      - AD-related changes for GMRedi
183      - fixes i KPP (delZ -> drF)
184      - hook to OBCS songe layer code in external_forcing
185      - errorMessageUnit non-zero in eeboot.F
186      - modified test cost function and carbon verif.
187    
188    release1_chkpt44d_post = chkpt44d_post
189    
190    chkpt44d_pre,post
191    o added missing EXCLUDE_MONITOR flags
192    o changed "e" to "_d" in gmredi_slope_limit, gmredi_slope_psi
193      (incompatible typ in MIN/MAX expressions caused problems
194      on IBM SP3)
195    o in genmake added variable MAKEDEPEND
196      plus resetting for case SunOS
197    o added timer_stats.c routine for IBM SP3
198    o removed variables in dynamics
199    
200    o real fresh water flux implemented with non-linear free-surface.
201    
202    chkpt44c_pre,post
203    o few fix (mask in shap_s2, EmPmR in external_field_load,
204      USE_NATURAL_BCS in solve_for_P);
205    o add arguments myIter & myTime to S/R obcs_calc & solve_for_P
206    
207    checkpoint44b_pre/_post
208    o merge of relevant stuff from the ecco-branch:
209      - genmake: removed $S64 overwrite for case SunOS
210      - pkg/exf: update and corrections for field swapping and obcs
211      - pkg/ecco: parameter lists for the_model_main, the_main_loop
212                  harmonized between ECCO and MITgcm
213      - pkg/autodiff: added flow directives for obcs, mdsio_gl_slice
214                      updated checkpointing_lev... lists for obcs
215      - model/src: minor changes in forward_step, plot_field
216                   added directive for divided adjoint in the_main_loop
217      - pkg/mdsio: added mdsio_gl_slice
218    
219    o check parameters & config (chkpt44a_pre,post)
220    o OBC and NonLin_FrSurf.
221    
222    checkpoint44
223    o fix bug in mom_vi_del2uv
224    o select when filters are applied ; add options to zonal_filter (data.zonfilt)
225    o gmredi: fix Pb in the adiabatic form ; add options (.e.g. Bolus advection)
226    o update AIM experiments (NCEP input files)
227    o improve and extend diagnostics (Monitor, TimeAve with NonLin-FrSurf)
228    o added some stuff for AD
229    
230    checkpoint43
231    o added two new advection tests
232    o added global 4x4 degree ocean test
233    o added test of H&S94 with free surface on cube
234    o some final mods for gradient check, adjoint,...
235    
236    checkpoint42
237      Fixed AD-related problems:
238    o Store directives up-to-date with re-arranged Adams-Bashforth
239      (mainly thermodynamics.F)
240    o New store directives for multi-dim. advection schemes
241      * new CPP flag ALLOW_MULTI_DIM_ADVECTION
242      * new common block and key passkey
243      (mainly gad_advection.F)
244    o Modified store directives for split of dynamics/thermodynamics
245      for the case ALLOW_KPP
246    o Cleaned argument list for timestep_tracer.F
247    
248    checkpoint41
249    o re-formatted/added comments in prologues of key subroutines
250      to work with protex
251    
252    checkpoint40
253    o moved calc_gs, calc_gt and calc_tr1 back to model/src
254    o added FLT (floats) package from Arne along with demo. experiment
255    o re-arranged Adams-Bashforth scheme for tracers to allow easier
256      implementation of forward-in-time forcing terms
257    o more mods for non-linear free-surface including new variable
258    o modified multi-dim method to work on cube
259    o bug fix in KPP (from DM)
260    
261    checkpoint40pre9
262    o added DST advection schemes
263    o fix MPI bug on SGI's
264    o modifications for non-linear free-surface
265    o fixed conditionals for fixed flow/passive tracer only mode
266    o added tension/strain form of stress tensor
267    o changes to commenting of arguments for TAF/TAMC
268    o added/updated many matlab scripts
269    o added multi-dimensional advection method for tracers
270      
271    checkpoint40pre8
272    o new package rw/
273      Added method for dumping intermediate local arrays:
274      mdsio_writetile - same as mdsio_writefield except works from inside
275                        bi,bj loop
276      mdsio_writelocal - same as mdsio_writetile except works for local
277                         arrays
278      write_local_r? - higher-level wrapper for mdsio_writelocal
279      Controlled by diagFreq. Defaults to zero (ie. no dumps)
280      Example given at end of mom_vecinv.F that dumps some local arrays.
281    o replaced calc_mom_rhs.F by mom_fluxform.F/mom_vecinc.F to
282      control flux-form versus vector invariant code.
283      Switch is runtime flag vectorInvariantMomentum (defaults to false)
284      or genmake -DISABLE ...
285    o TAMC-related update to cope with mom_fluxform.F/mom_vecinc.F
286      (additional storing is now needed for case vecinv;
287      currently nothing implemented to switch this storing off
288      in case fluxform is used since no CPP flag available).
289    
290    checkpoint40pre7
291    o bug fix in dynamics.F
292      calc_viscosity called before k=1,Nr loop.
293    o added some #ifdef's ALLOW_PASSIVE_TRACER
294    o cleaned initialisations in ctrl_map_ini
295      related to TAF
296    
297    checkpoint40pre6
298    o split dynamics into thermodynamics & dynamics
299    o corresponding split of calc_diffusivity into
300      calc_diffusivity, calc_viscosity
301      (kpp_calc_diff, kpp_calc_visc).
302    o Added diffkr, kapgm to control variables
303    o bug fix in gmredi_slope_limit for ldd97
304    
305    checkpoint40pre5
306    o proper initialization of Adams-Bashforth time stepping
307      + uses forward step for very first step of model (iter=0)
308    o re-generated *all* output since almost all output is modified by this
309      change (sorry but we've been putting this one off for about 2 years)
310      + natl_box, aim.5l_Equatorial_Channel and aim.5l_zon-ave were
311        *not* regenerated since they are already out of date and I don't
312        want to create the impression that they are suddenly working.
313    o removed KAP stuff for DEC's
314    o modified/added many .cvsignore files in */code and */input
315    o added new expt "solid-body.cs-32x32x1"
316      + this uses an alternative form of ini_curvilinear_grid.F which
317        is not necessarily any better than the current one...
318    
319    checkpoint40pre4
320    o added re-initialisations of utrans,vtrans,rtrans in
321      calc_common_factors which are crucial for TAF.
322    o extended iMin,jMin range for calc_common_factors,
323      calc_diffusivity
324    o added option ALLOW_PASSIVE_TRACER
325    o a few minor updates and fixes
326    
327    checkpoint40pre3
328    o created calc_gtr1.F for gad package
329    o split the_main_loop and re-introduced forward_step
330    o some recomputations of nIter0 for TAMC
331    
332    checkpoint40pre2
333    o Updated to latest branch of AJA, JMC
334    o Added gradient check package
335    o Added routines for passive tracer handling
336    o Added carbon sequestration sensitivity experiment
337    
338    checkpoint39
339     o Modifications and fixes to support TAMC
340       (mainly missing or wrong directives)
341     o Corrected common blocks when fooling TAMC to produce adjoint I/O
342       in addummy_in_stepping
343     o Updated verification/vero/ (bug fixes in code/, correct pickups in input/)
344     o Enabled "sliced" (xz-,yz-) exchanges, needed for obcs.
345     o Included following packages:
346       cal: calendar
347       exf: external forcing
348       ecco: essential routines to control use of cal, exf
349             (NB: this is not the full ECCO environment)
350     o disabled some packages by default in genmake
351    
352    checkpoint38
353     o see notes_c37_adj.txt
354     o corrected wrong layer index in external_forcing_t
355     o replaced the_main_loop/forward_step by the_main_loop
356     o removed forceoutput from write_state
357       (replaced criteria for initial/final state)
358     o added runtime flag for pre-C35 pickups: usePickupBeforeC35
359    
360    checkpoint37
361     o mdsio.F routine split and packaged in pkg/mdsio
362       (mdsio.F and mdsio_gl.F still exist in eesupp/src but are not
363        used unless genmake -disable=mdsio)
364     o allow a more precise surface-geopotential gradient for the atmosphere
365       taking into account the change in space of Alpha (=1/rho) at the surface.
366     o variable "etaN" (replace cg2d_x) is the surface R-anomaly [r unit]
367       (ocean: sea surface height [m] / atmos: surface pressure anomaly [Pa])
368     o Change units: Phi_Hydrostatic (=phiHyd), Phi_Surface(=cg2d_x) and
369       Phi_NonHydrostatic (=cg3d_x), all have now the dimension of a potential
370       [m2/s2] (pressure/rhoConst in the ocean ; Geo-Potential in the atmosphere).
371     o Time-Average diagnostics defined as a pseudo package "timeave".
372     o pickup files : old pickup (before c35) did not work with new code (c35
373       and after) unless activating 2 commented lines in initialise-varia.
374     o Non-Hydrostatic pickup file Pb fixed.
375     o bug with Rigid-lid version (since c35) fixed.  
376    
377    checkpoint36
378     o implement Crank-Nickelson barotropic time-stepping
379     o recover Time-Average diagnostics
380     o fix Pb in checkpoint (PR#19)
381     o AIM become a standard package ; clean unused CPP_kees
382    
383    checkpoint35
384     o subtantial rewrite of dynamics.f
385     o allows staggered time-stepping
386     o packaged obcs, aim (Atmospheric Physics), zonal_filt, shap_filt
387     o added bottom drag (linear + quadratic)
388    
389    checkpoint34
390     o Modified exchange routines for correct reverse simulation.
391     o Added verification output to comply with bug fix in impldiff.F
392       as of c33 (exp2, natl_box).
393     o Corrected store directives in dynamics.F
394     o Corrected array boundaries in impldiff.F
395     o Corrected array dimensions in gmredi.
396       Added temporary scalars to avoid storage by TAMC (gmredi, kpp).
397     o Added routine GLOBAL_SUM_INT to global_sum.F
398     o Added mdsio_gl.F for ECCO purposes.
399    
400    checkpoint33
401     o Fixed bug in lower BC in impldiff.F
402     o Fixed confusion about units of forcing arrays in FFIELDS.h
403       namely Fu,Fv,Qnet,Qsw,EmPmR:
404       - Removed verification/natl_box/code/external_fields_scale.F
405         (did not differ from that in model/src)
406       - Changed units of fu,fv,Qnet,Qsw,EmPmR back to proper units
407         (see FFIELDS.h for description)
408       - Scale fu,fv,Qnet,Qsw,EmPmR when used in external_forcing_surf.F,
409         kpp_calc.F and kpp_transport_t.F
410       - Removed model/src/external_fields_scale.F and calls to it
411       - verification/natl_box uses flux data with "atmospheric" sign so
412         a special version of external_fields_load.F is used to
413         change the data as it's read in. This way, the arrays
414         have the right units and signs at all times tha a user could
415         possibly use them.
416     o Corrected genmake to delete a temporary file during configuration
417    
418    checkpoint32
419     o Scaling of forcing fields moved from external_forcing.F to
420       external_fields_scale.F, called directly after loading fields.
421     o Surface relaxation terms added to surface tendency fields in
422       extra subroutine.
423     o impldiff.F changed to avoid storing by TAMC of huge intermediate
424       fields.
425     o Changes in GMRedi to comply with packaging structure.
426     o Modifications and bug fixes in KPP package.
427     o Verification experiment for KPP added (verification/nat_box/)
428    
429    checkpoint31
430     o Packages interface brought in line with defined standard
431       -> new routines packages_...F
432       -> changes in initialise_fixed.F, initialise_varia.F
433       -> enables initialisation interface for ECCO package
434     o Rescaling of external forcing fields immediately after read
435       (removed from external_forcing.F)
436       -> new: surface_fields_scale.F
437       -> affects ini_foorcing.F, external_fields_load.F
438     o Computation of surface tendencies before tendency updates.
439       -> new: external_forcing_surf.F
440     o Change of variable names useGMRedi, useKPP, useECCO
441     o Further changes in dynamics.F, impldiff.F for TAMC
442     o Tested for experiments 0, 2, 4.
443       - not yet tested for GMRedi.
444       - not yet tested for KPP.
445    
446    checkpoint30
447     o Updates for OBCs
448     o New experiment for test OBCs (internal_wave)
449     o New output.txt in verification/exp4/results/
450     o Updates for KPP: calculation of viscosity corrected, new variables
451       kpp_dumpFreq and kpp_taveFreq
452     o CPP'd calls to system routines for TARGET_CRAY_VECTOR (P.H.)
453       and entry for T90 in genmake
454    
455    checkpoint29
456     o packaged KPP and GM/Redi
457    
458    checkpoint28
459     o Corrected initialization of hFacMin for difference vertical coordinates
460     o Modified calculation of partial cell thickness to more robust algorithm
461     o config_summary.F: replaced write_1D_... by write_0D_...
462       read_write.F: added subroutines write_0D_...
463     o routines calc_common_factors, calc_gs, calc_gt, calc_phi_hyd, find_rho:
464       included some initialisations required for TAMC.
465     o routine calc_isoslopes: modified sqrt computation to make it
466       differentiable for zero argument.
467     o routines dynamics, impldiff:
468       included store directives and tape key computations required for TAMC.
469     o ALL TAMC related changes are between ifdef ALLOW_AUTODIFF_TAMC
470    
471    checkpoint27
472     o fixed calc_isoslopes() to so that cancellation of terms in tensor
473       formulation works properly with variable resolution.
474     o restructured the calling tree between the_model_main() and dynamics()
475     o split initialise() into initialise_fixed() and initialise_varia()
476     o introduced initialization file pSurfInitFile for free surface (cg2d_x)
477       in new routine ini_psurf()
478    
479    checkpoint26
480     o moved some #ifdef in optional routines to encompass everything
481       except the argument declarations. This was using up some memory.
482     o fixed macros like _ADT to work with both versions of Linux cpp
483     o cleaned up some unused and uninitialized variables
484       (helps when debugging with strict compile options)
485     o split up CPP_EEOPTIONS.h into options and macros
486       (macros are now in eesupp/inc/CPP_EEMACROS.h)
487     o patch for 2 processor JAM mode
488    
489    checkpoint25
490     o updates for OBCs and NH
491     o dramatically reduced memory usage
492     o added "JAM" routines for use on Artic network
493     o parameterization of convection by implicit vertical diffusion
494     o added a diagnostic of convective index
495     o moved call to calc_divg_hat() from dynamics() to solve_for_pressure()
496       (this is was partly for OBCs and NH but also in anticipation of
497        an explicit free-surface option)
498     o initial state input files for U and V
499    
500    checkpoint24
501     o Removed some spurious "REAL"s
502     o Updated KPP to latest version from JPL
503     o Added a COS(latitude) in horizontal viscosity
504    
505    checkpoint23
506     o Added del^4 diffusion for salt and temperature
507     o Multiple minor fixes (implicit none's, arguments to global_sum, etc.)
508    
509    checkpoint22
510     o Made many small changes: implicit none, format(i5), etc...
511     o Introduced KPP mixing scheme (compiles and runs but *not* tested)
512    
513    checkpoint21
514     o Introduced new I/O package that supports direct-access records (mdsio.F)
515     o Split-up mid-level I/O routines
516     o Updated input data for experiments 0,1,2,4 and 5
517     o Finally removed the genmake.* scripts (everyone seems happy with genmake)
518    
519    checkpoint20
520     o Tidied up open-boundaries some more
521     o Added non-hydrostatic code
522     o Fixed some input data
523     o Modified MPI start-up to work in "coupled" context.
524    
525    checkpoint19
526     o Tidied up directory structure for verification experiments.
527     o Added new code for open boundaries.
528     o Corrected advective terms near boundaries.
529     o Added CPP flag for "old UV" geometry and corrected spherical geometry.
530     o Implemented free-slip/no-slip BCs and del^4 dissipation.
531     o Split default parameters out of ini_parms.F into set_defaults.F.
532    
533    checkpoint18
534     o Further changes for optional code generation with
535       CPP - ugh!
536    
537    checkpoint17
538     o Beginning to incorporating modularity
539       for supporting atmos. and ocean configs.
540     o Small changes for TAMC complinace
541     o New ultra simple test case. Barotropic box
542       configuration "exp0".
543    
544    checkpoint16
545     o Minor changes to exchange routines to support
546       accumulation in reverse mode. Adjoint of an
547       assignment is an addition.
548     o Changes to support compilation by TAMC (LR(1)
549       syntax) and by g77 under Linux ( 72 character
550       limit ).
551    
552    checkpoint15
553     Rewrote exchange routines to allow
554     o General tile <-> tile connectivity.
555     o TAMC reverse mode flag ( is this really needed? )
556     o Variable width overlap and exchange region widths.
557     o Hooks for sharing data via DMA, Arctic, Memory Channel,
558       shmput/shmget, VIA, SYSV shmem and every other cool
559       communication method.
560    
561    checkpoint14
562     Consistent isomorphism chages made. These allow dynamical core
563     to support both pressure and meters as a vertical coordinate.
564    
565    checkpoint13
566     Release which corrects global_max problem and a couple
567     of KGM time-averaging diagnostic errors. Also contains
568     a double-gyre experiment setup as well as the baseline
569     4 degree global template. The double gyre template is
570     organised to allow it to be applied automatically to
571     the baseline configuration.
572    
573    branch-point-rdot
574     A few tidy-ups have been made bt the real point of this
575     check-point (excuse the pun) is to allow a branch to be
576     made for the purposes of adding the rDot alterations.
577     I don't want to commit the rDot to the main-trunk until
578     we've actually tested it...
579    
580    checkpoint12
581     Tidy up and added generic genmake script (formerly
582     configure script).
583     Released to testers.
584    
585    checkpoint11
586     Re-arranged initialise() and introduced ini_vertical_grid()
587     and ini_masks_etc().
588    
589    checkpoint10
590     Introduced the configure script.
591     Separated out the diags package.
592     Added template for writing time-averages of tile/intermediate quantities.
593     Updated SIZE.h in exp2 and made the data big-endian.
594    
595    checkpoint9
596     MPI fix. Filename changes (meta/data). salbin*y stuff.
597     General tidy-up.
598     SST.bin SSS.bin added to verification/exp2
599    
600    checkpoint8
601     Inludes time-dependant forcing and time-averaging.
602     Works at 4x4 and 2.8125x2.8125 global
603    
604    checkpoint7-4degree-ref
605     Branch from checkpoint7. Released for application to
606     global modeling and general modeling - process studies, regional
607     model etc..
608     Configured for verification/exp2 - 4 degree global, two process.
609    
610    checkpoint7
611     Created by cnh
612     Simple 4 degree global simulation
613     configuration.
614     Includes climatological wind,
615     hydrography, bathymetry etc
616     Does not include Heat Flux and E-P
617    
618    checkpoint6
619     Created by cnh
620     merged checkpoint5 with CD and
621     spherical polar code.
622     Still some problems with GM Redi
623     abd full topography.
624    
625  checkpoint5  checkpoint5
626   Created by AJA   Created by AJA
627   contains updates to GM Redi   contains updates to GM Redi

Legend:
Removed from v.1.3  
changed lines
  Added in v.1.53.2.25

  ViewVC Help
Powered by ViewVC 1.1.22