/[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.171 - (hide annotations) (download)
Sun Jul 13 20:32:42 2003 UTC (20 years, 9 months ago) by jmc
Branch: MAIN
Changes since 1.170: +2 -1 lines
fix bug in dxV,dyU definition of cubed-sphere grid (ini_curvilinear_grid)

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

  ViewVC Help
Powered by ViewVC 1.1.22