/[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.121 - (hide annotations) (download)
Tue Jan 21 19:44:45 2003 UTC (21 years, 3 months ago) by heimbach
Branch: MAIN
CVS Tags: checkpoint48c_pre, checkpoint47j_post
Changes since 1.120: +19 -1 lines
tagging checkpoint47j_post

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

  ViewVC Help
Powered by ViewVC 1.1.22