/[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.12 - (hide annotations) (download)
Thu Nov 7 17:23:42 2002 UTC (21 years, 6 months ago) by heimbach
Branch: release1
CVS Tags: release1_p7
Changes since 1.53.2.11: +23 -1 lines
Preparing release1_p7

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

  ViewVC Help
Powered by ViewVC 1.1.22