/[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.131 - (hide annotations) (download)
Sun Feb 9 03:01:58 2003 UTC (21 years, 2 months ago) by jmc
Branch: MAIN
Changes since 1.130: +3 -1 lines
o New S/R for diagnostic of bottom pressure (phi0surf was missing in c48d_post)

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

  ViewVC Help
Powered by ViewVC 1.1.22