/[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.53.2.15 - (hide annotations) (download)
Mon Nov 11 22:12:51 2002 UTC (21 years, 6 months ago) by heimbach
Branch: release1
Changes since 1.53.2.14: +4 -3 lines
Preparing release1_p8.

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

  ViewVC Help
Powered by ViewVC 1.1.22