--- MITgcm/doc/tag-index 2011/06/27 22:45:33 1.1466 +++ MITgcm/doc/tag-index 2012/02/13 23:45:41 1.1596 @@ -1,9 +1,738 @@ -$Header: /home/ubuntu/mnt/e9_copy/MITgcm/doc/tag-index,v 1.1466 2011/06/27 22:45:33 jmc Exp $ +$Header: /home/ubuntu/mnt/e9_copy/MITgcm/doc/tag-index,v 1.1596 2012/02/13 23:45:41 gforget Exp $ $Name: $ Notes on tags used in MITgcmUV ============================== +o pkg/seaice : + - simplify McPhee tapering, and allow to use it with SEAICEturbFluxFormula.EQ. + 1 or 2, using newly added run time parameter SEAICE_availHeatTaper. + - fix d_AREAbyATM, d_AREAbyOCN, d_AREAbyICE diags I broke in r1.148. + - add permanent SItflux diag that corresponds to TFLUX but includes + ice+snow. Hence SItflux-TFLUX should match the ice+snow heat budget. + - allow activation/testing of a fix for suspected missing term in + ocn-ice heat budget (to be confirmed). To test this, you want to + undef SEAICE_DISABLE_HEATCONSFIX, and then set the run time param + SEAICEheatConsFix to .TRUE. that also allows the 'SIaaflux' diagnostic. + - no change in results, fwd or ad. +o global_ocean.cs32x15/results: three changes following from the pkg/seaice commit below. + - switch to variable freezing point. + Results change : cg2d -> 1 digits; ad -> 3-6-6 digits. + - bug fix : the sublimation term that was missing is now activated. + Results change : cg2d -> 2 digits; ad -> 8-6-6 digits. + - bug fix : flooding sign term for SIsal0.NE.0. + Result change : cg2d -> 8 digits; ad -> 11-12-9 digits. +o pkg/seaice: + - unified freezing point treatment : the old SEAICE_VARIABLE_FREEZING_POINT + is now the default, and the old default constant freezing point is recovered with + SEAICE_tempFrz0 = -1.96, + SEAICE_dTempFrz_dS = 0., + - retire SEAICE_freeze that was the old way of specifycing the constant freezing point. + - remove ALLOW_SEAICE_FLOODING brackets; run time switch is already there. + - bug fix (thanks to M. Losch) : the sublimation term that was missing is now + activated. To reproduce old results that had this bug define SEAICE_DISABLE_SUBLIM. + - bug fix (silly me) : flooding sign term (seaice_growth.F r 1.149line 1211) + was wrong for SIsal0.NE.0. Changes cs32x15 results (see above item for detail). + - bug fix (thanks to O. Jahn) : area loss for melting got messed up in + seaice_growth r149 for legacy branch (no results change). + - introduce SEAICE_CAP_SUBLIM : caps sublimation heat flux in solve4temp (code from I. Fenty). + - results did not change except for global_ocean.cs32x15, mostly due to the switch + to variable freezing point (see above item for detail). +o pkg/thsice: + - fix and simplify interface to salt_plume pkg ; diagnose directly amount of + seawater freezing in thsice_calc_thickn (not used). +o pkg/seaice: turbulent flux term specification via run time params. + - replace CPP switches with run time switches to facilitate testing + - retired CPPs : MCPHEE_OCEAN_ICE_HEAT_FLUX, GRADIENT_MIXED_LAYER_TURBULENCE_FACTOR + - added runtime parameter : SEAICEturbFluxFormula + - move Mcphee constants to SEAICE_PARAMS.h + - seaice_readparms.F : read turbulent flux term params (SEAICEturbFluxFormula; + SEAICE_availHeatFrac/Frz, or SEAICE_gamma_t/_frz if apply); remove + seaice_summary call (moved to seaice_init_fixed) + - seaice_init_fixed.F : set SEAICE_availHeatFrac/Frz depending on + SEAICEturbFluxFormula, and seaice_summary call (moved from seaice_readparms) + - seaice_summary.F : add missing report of read turbulent flux term set up (and SITRACER). + - seaice_check.F : check range; inform and stop if retired CPPs are used (incl. SEAICE_AGE). + - seaice_growth.F : unified use of SEAICE_availHeatFrac/Frz, without + CPP switch, same computation as before for the different options. + - change results at the truncation level. +o pkg/seaice: + - remove un-used parameters LAD & MAX_TICE ; add new run-time parameters: + useMaykutSatVapPoly (default=F), postSolvTempIter (default=2) and + SEAICE_wetAlbTemp (default=-1e-3). Remove option SEAICE_SOLVE4TEMP_LEGACY. + - update verification/*/input*/data.seaice: + to reproduce previous results with former #defined SEAICE_SOLVE4TEMP_LEGACY + code, set useMaykutSatVapPoly=T & postSolvTempIter=0 ; + and to reproduce previous results with former non-SOLVE4TEMP_LEGACY code, + set SEAICE_wetAlbTemp=0 & SEAICE_snowThick=0. +o pkg/seaice/seaice_solve4temp.F (SOLVE4TEMP_LEGACY): + - remove LEGACY code for solving for tsurf (A1,A2,A3) but maintain the same + algorithm (same choice: useMaykutPolySatVap=T, postSolvTempIter=0); + difference in results only due to machine truncation. + - remove MAX_TICE (tsurf is always =< TMELT anyway); keep MIN_TICE if using + MaykutPolySatVap; keep MIN_LWDOWN. + - adapt SEAICE_MODIFY_GROWTH_ADJ code (untested) to non-legacy formulation. + - update output of verification exp. lab_sea (4 fwd: 11 cg2d digits except hb87, + + 3 AD: 6 digits except evp) and offline_exf_seaice.seaice (12 digits). +o pkg/salt_plume: + - isolate saltPlumeFlux array exch into a specific S/R called from + do_oceanic_phys.F + - add interface to pkg/salt_plume (filling of saltPlumeFlux) in pkg/thsice. +o verification: + - move untested set-up to MITgcm_contrib/verification_other. +o pkg/seaice: + - retire old way of SEAICE_AGE. Now replaced with ALLOW_SITRACER. +o pkg/seaice: + - seaice_solve4temp.F (keeping results unchanged): + * add 2 future run-time params to select which saturation vapor pressure + formula is used and how post-iteration fluxes are set. + Temporary set these 2 params according to option SOLVE4TEMP_LEGACY; + * New piece of code (not used) to update surf. atmos. heat flux F_ia using + the linearized expression to stay consistent with tsurf finding. + - seaice_freedrift.F avoid floating exception in sqrt(y) since y=sqrt(x*x)-x + can be < 0. +o pkg/seaice/seaice_solve4temp.F (SOLVE4TEMP_LEGACY undef): + - remove from F_ia (and from it's derivative dFiDTs1) the contribution of + conductive heat flux F_c , and add it explicitly when updating tsurf as + solution of: Fc = Fia + d/dT(Fia - Fc) *delta.tsurf + so that now F_ia has a consistent meaning through the entire routine. + This causes differences at truncation level: update output of fwd exp. + global_ocean.cs32x15.seaice. +o pkg/seaice: + - lots of editing/cleaning in seaice_solve4temp.F + better documentation + of arrays, sign/direction of fluxes; no effect on results. + - replace hard coded 273.16 (=previous value of celsius2K) by celsius2K + in seaice_budget_ocean.F & seaice_solve4temp.F (SOLVE4TEMP_LEGACY part); + note: this should have been done before changing celsius2K default. + - to keep results unchanged, add back old value of celsius2K in verification + exp. input*/data : lab_sea (AD), offline_exf_seaice (fwd+AD) & seaice_obcs + - replace hard coded seawater freezing temp in seaice_solve4temp.F (part + SOLVE4TEMP_LEGACY) of 271.20 (=previous value of celsius2K + default + value of SEAICE_freeze) by celsius2K+SEAICE_freeze so that seawater + freezing temp is consistent with value in seaice_growth.F ; this causes + differences at machine truncation level: update lab_sea AD output (3/4). +o pkg/seaice: + - mask (in exf_init_fixed.F) atemp,aqh,evap,precip,runoff,lwflx,areamask + and climsst/sss even when using seaice (to prevent calculation that might + use SST on land); does not affect any verification exp. + - apply mask to taux,tauy (in seaice_get_dynforcing.F); update output + of lab_sea.fd & lab_sea.hb87 and global_ocean.cs32x15.seaice_dynmix. +o pkg/seaice/seaice_growth.F: add mask to avoid non-zero ice thickness + over land (non-legacy code) +o vectorize salt_plume package: + - add extra code to salt_plume_frac and salt_plume_tendency_apply_s + - this code computes plumebk everywhere (also over land), thus requires + code to avoid divisions by zero and catch the case of kLev=Nr. + - efficiency of salt_plume_frac is still sub-optimal +o tools (genmake2): + - fix makefile NAME specification (option: -makefile NAME) by adding + "-f $MAKEFILE" in few places where it was missing including makedepend + command (contribution from Paul). + +checkpoint63i (2012/01/24) +o model/src: + - add factorized versions of some EOS code to find_rho.F, + define USE_FACTORIZED_EOS to turn it on (default for TARGET_NEC_SX) +o model/src: + - add celsius2K to namelist PARM01; remove unused recip_rhoNil from PARAMS.h; + - change default celsius2K from 273.16 to 273.15 + - to keep results unchanged, add back old value of celsius2K in verification + exp. input*/data : aim.5l_cs, 1D_ocean_ice_column, lab_sea (fwd), + global_ocean.cs32x15(seaice) & cpl_aim+ocn(input_atm). +o model/src: add a little initialisation trick to find_rho.F and find_alpha.F + to make TAF generate vectorizable code +o pkg/seaice/seaice_evp.F: add code (copied from CICE) that avoids underflows. + Turn on by defining SEAICE_EVP_ELIMINATE_UNDERFLOWS. Most compilers + have flags that do this more efficiently. +o pkg/diagnostics/diagstats_calc.F + - for TARGET_NEC_SX fix the treatment of the scaling factor tmpFac=scaleFact +o pkg/obcs (with exch2): + - derive OB indices in overlap region from OB-InsideMask (in obcs_init_fixed.F) + and remove code (in obcs_readparms.F) which was based on EXCH of indices + (through buffer) and did not account for exch2 (e.g., CS-grid) topology. +o pkg/exf and seaice exp: + - change offline_exf_seaice.seaicetd test exp. to use default DIFF1 value (=0) + so that switching off area & heff advection flags does not affect results. + - change default EXF_LWDOWN_WITH_EMISSIVITY to #define in EXF_OPTIONS.h + - keep exp. seaice_obcs & 1D_ocean_ice_column(ad) unchanged (using #undef + EXF_LWDOWN_WITH_EMISSIVITY) and, using pkg/exf default emissivities, update + results of verification experiments: 1D_ocean_ice_column(fwd), + global_ocean.cs32x15.seaice(fwd+ad) & seaice_dynmix(ad), lab_sea (all 8) + and offline_exf_seaice (all 4). +o pkg/seaice: + - remove array YNEG, RIVER, TMIX (replaced by local var) from common block; + remove also areaNm1 & hEffNm1 when SEAICE_GROWTH_LEGACY is undef. + - fix bug: areaNm1 & hEffNm1 are needed in seaice_growth (SEAICE_GROWTH_LEGACY) + but were not filled when resp. SEAICEadvArea=F & SEAICEadvHeff=F and + not multi-dim advection; + - fix seaice_growth.F to compile with both SEAICE_GROWTH_LEGACY and + SHORTWAVE_HEATING #undef. +o optim: make Makefile more robust (?) +o pkg/obcs: + * fix treatment of obcs_read_pickup for TAF +o pkg/shelfice: + * add missing initialisation of num_shifwflx + * new adjoint verification exp. for isomip + * change Prandtl and Schmidt numbers from generic formulations + (in terms of model diffus. and visc.) to separate runtime + parameters, with Holland and Jenkins (1999) default values. +o pkg/exf (interpolation): + - extended input field (2 rows) near the N & S poles: + * fill in with the symetric value (when even Nb of data in longitude) + * add average value at the poles only for scalar quantities ; for vector + component interpolation, skip the averaging and keep duplicated values, + unless the 2 components have same location (uvInterp=T) in which case + interpolate the 2 components together using S/R EXF_INTERP_UV. + - new S/R EXF_INTERP_UV to interpolate the 2 components of a vector field + together: this allows to account properly for local orientation when + averaging at N & S pole. + - add CPP option EXF_USE_OLD_INTERP_POLE to recover old results regarding + exf-interpolation near N & S poles. Undef by default. + - add debug check/print on 1rst iter if debugLevel >=2. +o pkg/exf: + - change masking flags definition (no longer "parameter"), put them in + common block and set them in S/R EXF_INIT_FIXED. + - change recognized masking flag from s,u,v to c,w,s since the mask + to use (maskC,W,S) depends on position on model grid and has little to + do with scalar/vector difference; fix masking if using P-coordinates. + - fix masking of wind-stress (was wrong if interpolated or read on A-grid) + and update results of exp. global_with_exf (x2). + - fix setting of zenith-angle table when SHORTWAVE_HEATING is undef. +o pkg/obcs + - S/R obcs_calc_stevens: fix a small bug (gammat -> gammas where appropriate) +o pkg/exf (interpolation): + - assume periodicity in X only if input field cover full longitude range. + - improve search for lat. index (supposed to be faster, in ~log2(ny) steps, + and should vectorise). + - fix input lat of the 2 added row (in case we provide N.pole data). + +checkpoint63h (2011/12/30) +o pkg/seaice: + - change declaration of UVM from _RL to _RS in order to get B-grid + uIce,vIce monitor when _RS = real*4 +o pkg/offline: + - new S/R OFFLINE_RESET_PARMS for resetting main-model params (switch off flags); + - compute vertical velocity if not read from file (switch on exactConserv + & staggerTimeStep); + - fix output of ptracer monitor iter & time for default PTRACERS_monitorFreq. +o verification: + - update grid-files (in tutorial_held_suarez_cs/input and fizhi-cs-32x32x40/input) + with grid-angle generated using "utils/matlab/cs_grid/cubeCalcAngle.m": + fix Pb in yG definition @ 2 missing corners (previously yG was averaged); + - update output of exp. global_ocean.cs32x15.viscA4 after changing + grid-file angles (used here for coriolis-3d); + - remove (or gzip) few files not needed to run fizhi-cs experiments. +o pkg/exf (vector interpolation): + - rotate vector component toward local grid-axis orientation using grid-angles + (stored in GRID.h) instead of locally computed rotation angle; keep old code + available with exf option EXF_USE_OLD_VEC_ROTATION (undef by default). +o pkg/seaice: + - allow to compile with exf options ALLOW_ATM_TEMP or ALLOW_DOWNWARD_RADIATION + undefined. Fix and remove the stop when ALLOW_RUNOFF is undefined. +o pkg/PKG_OPTIONS.h files: + - move #include "CPP_OPTIONS.h" just after #include "PACKAGES_CONFIG.h", + outside of the #ifdef ALLOW_THISPKG / #endif block. + - update verification/*/code/PKG_OPTIONS.h files. +o add a verification experiment (offline_exf_seaice/input.seaice) that test + the B-grid LSOR solver +o pkg/seaice: sort out emissivity and long wave radiation step 2: + - add emissivity for snow and ice as new run-time parameters + (unfortunately) that default to the corresponding exf values; this + changes results in most verification experiments so that for backward + compatibility these parameter have to be set explicitly to inconsistent + values (ugly); + - the exf-flag EXF_LWDOWN_WITH_EMISSIVITY then gets rid off the hard-wired + emissivities of 0.97 associated with lwdownloc in S/R seaice_solve4temp + until we agree how to handle this bug properly +o pkg/exf (interpolation): + - add a set of run-time param ({inputfield}_interpMethod), one for + each interpolated input field, to select the interpolation method + with a value of zero switching off the interpolation; + - print interpolation parameters to standard output; + - refine exf_check.F accordingly ; stop if USE_NO_INTERP_RUNOFF is defined + (to use instead runoff_interpMethod=0 in data.exf). + - simplify default setting of interpolation parameters (for all fields, + set position to match model grid cell-center position, leading to trivial + interpolation in case of regular Lat-Lon grid) and fix for the case of + non-uniform delY. +o pkg/exf/exf_radiation.F: add the factor ocean_emissivity to lwdown, for + within #ifdef EXF_LWDOWN_WITH_EMISSIVITY/#endif. Unless ocean_emissivity=1. + this factor is absolutely required, because the lw exitance (= out-going + long wave radiation) is emissivity*stefanBoltzmann*T^4 + rho*lwdown, + where the reflectivity rho = 1-emissivity for conservation reasons. Once + this is established, we can remove the CPP-Flag (if we want to). +o pkg/seaice: + - qualify a stop statement in S/R seaice_check: EXF_READ_EVAP and + ALLOW_BULKFORMULAE are only required if SEAICE_EXTERNAL_FLUXES is defined + - sort out emissivity and long wave radiation, step 1: make SEAICE_emissivity + what the name implies (and not emissivity*BoltzmannConstant), this means + the old default value of 5.5e-8 now means + 5.5e-8/5.670e-8 = 0.97001763668430343479 as ocean_emissivity in + S/R exf_readparms + - FV-discretization of the B-grid LSOR solver, turn on with + SEAICE_LSRBNEW. This new solver also involves a slight re-organization + of the calling routine dynsolver, so that B and C-grid code look a + little more alike. + - fix index bugs in ostres.F (B-grid code) +o pkg/seaice/seaice_ocean_budget.F: change (unused) code to make it look better +o pkg/seaice/seaice_readparms.F: make ocean_emissivity*stefanBoltzmann the + default for SEAICE_emissivity, if useEXF; requires setting a wrong + parameter value in global_ocean.cs32x15/input.seaice/data.seaice for + backward compatiblity +o model/src: use sigmaR in calc_ivdc + +checkpoint63g (2011/12/16) +o pkg/seaice/seaice_growth.F: + fix heat conservation of the coupled ocean-seaice system. + when SEAICE_HEAT_CONSERV_FIX is defined, the mismatch of + solid vs liquid water treatment is resolved via QNET. +o pkg/seaice/seaice_growth.F: + add missing term for sublimation in saltFlux, which was breaking conservation. +o pkg/seaice/seaice_model.F: + Remove this patholigical case treatment in evolution branch, + where it is un-necessary and breaks conservation. + Update global_ocean.cs32x15/results accordingly for + output.seaice.txt output_adm.seaice.txt and output_adm.seaice_dynmix.txt +o model/src: + useRealFreshWaterFlux: remove masking of EmPmP (using maskInC) in + external_forcing_surf.F and apply mask directly in S/R SOLVE_FOR_PRESSURE. +o pkg/obcs: + modify Stevens boundary conditions so that S/R obcs_calc_stevens computes + tendency for temperature and salinity that is then applied to update + theta and salt in S/R obcs_apply_ts; this requires proper masking of all + horizontal advection and diffusion contributions on the boundary (in + S/Rs gad_advection, gad_calc_rhs, gmredi_rtransport, gmredi_calc_diff), and + removing the mask in S/R timestep_tracer. The advantage of this approach is + that the updated tracer values include contributions from the surface + forcing and vertical diffusion. + This modification changes exp4.stevens because of vertical diffusion. +o model/src: + change non-curvilinear grid setting to also work with exch2 + blank tiles: + - move delX,delY to new header file (SET_GRID.h) and adjust length to 1rst + face dimensions. + - new S/R INI_LOCAL_GRID to define model tile-local grid (using same units + as delX,delY) and called from S/R INI_CARTESIAN_GRID, INI_CYLINDER_GRID + and INI_SPHERICAL_POLAR_GRID. + change test-experiment global_ocean.90x40x15: + - split the domain in many more tiles (9x4 tiles of 10x10 each); + - switch to exch2 and remove 1 blank-tile (but only for MPI test). + - update results of both test (std & dwnslp). +o pkg/diagnostics/diagstat_calc.F: fix problem with non-initialised halos in + tmp-fields for TARGET_NEC_SX at the cost of extra loops and less vectorisation +o model/src: + - take sigma-coords related code out of update_etah.F into new S/R UPDATE_ETAWS + and fix initialisation when using sigma-coords. +o model/src: + - improve Gael's changes from Jan 14, 2011 "addition of an 'update' of hfacc etc. + to their current value at the beginning of forward_step.F": add a new run-time + switch "doResetHFactors" (default=false) and use it to do (or not) the resetting. + - set doResetHFactors=T in the following test exp: + global_ocean.90x40x15/input (rStar) & input.dwnslp (linFS), + global_ocean.cs32x15/input.seaice (rStar), hs94.cs-32x32x5/input.impIGW (linFS) + and tutorial_global_oce_in_p (nonLinFS in p) +o pkg/ecco + - added IES cost term +o verification/advect_xz + - scale down the depth by 1/100 (from 200 km to just 2.km) + - add secondary test using divergent flow, r-star and implicit vertical advection. + - add note (check_conserve_TS.txt) and matlab script to check global + conservation of T & S with NonLin-FreeSurf and Adams-Bashforth. +o pkg/rbcs: + - add missing relaxUFile & relaxVFile in namelist (in rbcs_readparms.F). +o pkg/obcs (Stevens BCs): + - fix various problems in the phase speed computations of the Stevens + boundary conditions: + - sign error for western and southern boundaries, + - time tendencies were underestimated by factor of dTracerLev and some just + zero (for multidim advection schemes) -> now estimate time tendencies + from difference between previous (n) time level and the one before (n-1); + this requires storing a field per tracer per boundary, also in the pickup + files. + - replace deltaTmom in cflMer/Zon computation with dTracerLev + - set default phase velocity to cflMer/Zon + - update verification experiment exp4.stevens +o pkg/generic_advdiff (implicit_r): + - fix implicit vertical advection conservation with AB and/or NonLin-FreeSurf + (remove Tr*d/dz(w) in gad_implicit_r.F and add it in gad_calc_rhs.F); + - fix implicit vertical diffusion or advection with NonLin FreeSurf + (was using current recip_hFacC instead of future recip_hFacC): set future + recip_hFac in thermodynamics.F and pass & use it in all vertical implicit + solver S/R ; + - fill diagnostics of vertical advective fluxes (computed from tendency) + when using implicit vert. advection; + - update output of exp that uses NonLin-FreeSurf & implicit vertical diffusion: + global_ocean.90x40x15 (fwd+AD), global_ocean.cs32x15 (4 fwd +4 AD), + tutorial_global_oce_in_p (fwd), tutorial_tracer_adjsens (AD) + and cpl_aim+ocn (used in ocean); to be fixed: bottom_ctrl_5x5. +o pkg/diagnostics: + - add diags for T & S tendency which goes through Adams-Bashforth. + +checkpoint63f (2011/11/30) +o pkg/obcs/obcs_calc_stevens.F: + - join some loops to reduce number of if-statements + - fix a bug in code for northern and southern boundaries. +o pkg/seaice/seaice_init_varia.F + - undo resetting UVM=0 that has slipped in unnoticed in r1.49 and + caused zero ice-velocities for the B-grid code +o pkg/seaice/seaice_init_fixed.F + - fix a bug in the initialisation of the second metric terms + k2AtC and k2AtZ: k2AtC was set to the value of k2AtZ and k2AtZ was 0. + - this affects all seaice configurations with useCurviLinearGrid = .true. + and SEAICEuseDynamics = .true. (default) and SEAICEuseMetricTerms + = .true. (default) + - the only verification experiment affected is global_ocean.cs32x15: + icedyn, seaice, and seaice_dynmix (AD) +o pkg/thsice/thsice_diagnostics_state.F + - only for TARGET_NEC_SX: initialise all of tmpFld, so that overlap does + not contain garbage that can lead to surprises in diagstats_calc.F +o model/src: + - move bi,bj loops inside INTEGR_CONTINUITY ; + - call INTEGR_CONTINUITY directly from forward_step.F + (previously called from momentum_correction_step.F) + - call UPDATE_ETAH from integr_continuity.F and update initialise_varia.F, + forward_step.F and pkg/ecco/the_main_loop.F +o model/src/do_oceanic_phys.F: + - reset addMass to zero only if useICEFRONT ; + - separated k-loop for rhoInSitu calculation ; + - add 2 diagnostics for wVel*delta^k(Rho) at constant pressure (= WdRHO_P) + and at constant T,S (= WdRHOdP); + NOTE: change diagnostics WRHOMASS : this is now simply the Vertical transport + of In-Situ Density (Anomaly) (=wVel*rho^bar-k) (previously was Vertical + transport of locally-referenced potential density); + to recover old diag: (WRHOMASS)_old = (WRHOMASS)_new -1/2 * (WdRHOdP) +o gluemnc: + - replace ncrcat with ncks when adding variables to *.glob.nc + - change the way variables without record dimensions are handled so that + files that have variables with and without record variables can be glued: + add a record dimension with a new unique name to be able to differentiate + between variable with and without a-prior record dimensions. Remove + this record dimension before adding the variable to the *.glob.nc file. + This procedure automatically works also for grid.*.nc files that do not + have any record dimension. +o verification/cpl_aim+ocn: + - generate new reference output on baudelaire (gfortran, mpich2) (previously + from old aces-grid cluster, ao + ifort) and update 'run_cpl_test' script. +o pkg/obcs/obcs_calc_stevens.F: + - add code for northern and southern boundaries. + - reorder some loops to save some operations and so that drFBar can be scalar +o model/src: + - re-arrange extrapolation calculation in Adams-Bashforth S/R (affects machine + truncation) and add diagnostics for Adams-Bashforth tendency increment. + - update test-exp. AD output: + 1D_ocean_ice_column, bottom_ctrl_5x5, lab_sea.noseaicedyn, obcs_ctrl; + and FWD output: exp4 (x3), fizhi-cs-32x32x40, fizhi-cs-aqualev20, + front_relax (x3), global_ocean.90x40x15 (x2), global_ocean.cs32x15 (x5), + global_ocean_ebm, ideal_2D_oce, internal_wave, isomip (x3), lab_sea (x4), + matrix_example, MLAdjust (x5), natl_box (x2), tutorial_advection_in_gyre, + tutorial_global_oce_in_p, tutorial_global_oce_latlon and + tutorial_plume_on_slope. +o pkg/diagnostics/diagstats_calc.F: add special code for TARGET_NEC_SX + that vectorises. This code uses 3 extra 2D fields, F90 array assignments + and F90 intrinsic routines SUM, MINVAL, MAXVAL, but since TARGET_NEC_SX + does not even come with an F77 compiler anymore, this should not be + a limitation + +checkpoint63e (2011/11/06) +o pkg/seaice adjoint of LSR: + - substantially rework STORE dirs. + - add new flag SEAICE_LSR_ADJOINT_ITER and parameter SOLV_MAX_FIXED + this flag will do SOLV_MAX_ITERS but only store SOLV_MAX_FIXED fields + and only perform SOLV_MAX_FIXED adjoint iters. + If flag SEAICE_LSR_ADJOINT_ITER is undef-ined, the store in the iteration + always goes to same record, meaning that the last forward field will be + the one used in the adjoint - an approximation. + - now produces non-zero LSR-related gradients, and acceptable gradients for + An's zonal (x-z) test case (to be checked in) + - lab_sea: produces acceptable gradients for lab_sea with forward/backward LSR + (but these are screwed up by the thermodynamics in the first place); + reduce from 4 to 3 timesteps to avoid t.d. issue as temporary solution; + output_adm.txt also reflects changes to seaice_lsr + - global_ocean.cs32x15: + * the "default" input_ad.seaice has been re-defined to always exclude dynamics + (output_adm.seaice.txt was updated) + * new input_ad.seaice_dynmix tests a forward LSR / backward free-drift + (output_adm.seaice_dynmix.txt) +o test-exp. exp4+stevens: + - switch off pTracers and nonHydrostatic (restart problems with NH); update output +o pkg/seaice (lsr solver): + - put coriolis term into FORCEX,Y (as in seaice_evp.F; previously in rhsU,V only); + update output (change truncation) of FWD test exp lab_sea & global_ocean.cs32x15 + - fix SEAICEuseFREEDRIFT for new OBCS version (ndef OBCS_UVICE_OLD) + - new parameter "LSR_mixIniGuess" allows (if=2,4) to mix free-drift solution + into initial guess for linearised solver; use weight ~ (1/err)^2,4. + - compute (with new S/R) and print initial (+ free-driff sol. if available) + and final residual of linearised system. +o pkg/pp81: add diagnostics for vertical eddy viscosity and diffusivity + (requires new subroutines pp81_init_fixed.F/pp81_diagnostics_init.F) +o pkg/obcs: Stevens BCs (still only for east and west) + - fix Stevens BCs by using intermediate velocities of previous + time step as "baroclinic" contribution rather velocity of one grid cell + inside the boundaries; more consistent but makes the entire treatment + more complicated, requires new pickup files and two new S/Rs: + obcs_copy_uv_n and obcs_save_uv_n + keep old version with flag OBCS_STEVENS_USE_INTERIOR_VELOCITY + (undefined by default) + - silently move computation of some grid factors into separate loops to + save some recomputations + - add a hack for non-linear free surface + - add a verification experiment to exp4 that tests this code +o make gluemnc/xplodemnc work with (moron) non-GNU shell tools + +checkpoint63d (2011/10/25) +o pkg/obcs + seaice-dynamics: + - new implementation calls OBCS_APPLY_UVICE (in seaice_dynsolver.F) before + solving for uIce,vIce and prevent SEAICE_LSR or SEAICE_EVP to modify OB + values (consistent with an implicit method). + - add option OBCS_UVICE_OLD (in OBCS_OPTIONS.h, defined by default) to + return to older implementation (same results as before); note that none of + the "experimental" OBCS_SEAICE options are implemented in the new version. + - switch test exp. seaice_obcs to use new version (update output). +o pkg/seaice: + - add few stop (B-grid & CS-exch, B-grid & obcs, AUTODIFF & SEAICE_maskRHS) + - add parenthesis in Water-Ice drag calculations (evp & lsr); + - in seaice_lsr.F, simplify and fix AA3 setting in case sNx or sNy=1; + and fix case SEAICE_waterDrag=0 (but unstable if no or little seaice) + - update output of test exp lab_sea that uses evp or lsr (fwd+ad) + and global_ocean.cs32x15 (icedyn & seaice fwd+ad). +o pkg/layers: + - Include potential density as new coordinate (Thanks to David Munday) +o pkg/dic: + - Remove subroutine CALC_PCO2_APPROX_CO3 from carbon_chem.F and add + carbonate computation/output to CALC_PCO2_APPROX +o pkg/generic_advdiff + - make TAF generate code that vectorizes: + gad_dst3fl_adv_*.F, gad_u3c4_impl_r.F +o model/src: + - improve vectorization also for adjoint code of + solve_tridiagonal and solve_pentadiagonal. As this requires up to + 5 new 3D-fields, this code is only turned on for the combination of + ALLOW_AUTODIFF_TAMC and TARGET_NEC_SX. Also remove error message + for singular matrix check (only for TARGET_NEC_SX). + - remove hard-wiring of CPP-flag ALLOW_SOLVERS_KLOOPINSIDE to + ALLOW_AUTODIFF. This flag now needs to be set outside of + solve_tri/pentadiagonal.F +o pkg/exf: + - fix previous modif in exf_readparms.F (revision 1.66: treatment of + optional namelist EXF_NML_OBCS). + - add many debug-print (to trace down where pkg/cal error msg comes from) +o pkg/mom_vecinv/mom_vi_hdissip.F + - rearrange loops so that vectorization is improved and in particular + the adjoint routine vectorizes. The code is a little longer now, but I + think easier to read. + Note: CPP-flag MOM_VI_ORIGINAL_VISCA4 is not tested. +o pkg/seaice: + - allow to specify initial seaice velocity from files (uIceFile,vIceFile) +o pkg/exch2: + - alternative code (without tile x tile matrix) for cumulated (global) sum; + used as default; keep using matrix version in adjustment.cs-32x32x1. +o tools/build_options: + - after merging some MPI and/or multi-threads specific optfiles so that + the modified default optfile support both built (using genmake2 -mpi + for the MPI built, using genmake2 -omp for OpenMP built), + move now obsolete optfiles to tools/build_options/unsupported/ + (add copy of email sent to support list in doc/optfiles_changes.txt) + +checkpoint63c (2011/09/28) +o pkg/ebm: + - fix ebm_zonalmean.F for several procs in Ydir (nPy > 1); update output of + test exp. global_ocean_ebm (affects machine truncation, 12 digits for cg2d) +o pkg/seaice (SItracer pickup) +* Simple code for pickup of SItracer fields (#define ALLOW_SITRACER) + To be done: + - thorough testing of missing fields in S/R seaice_read_pickup + - thorough matching between generic tracers and specific fields used + (e.g. volume-weighted age, area-weighted age, salinity, ...) +o pkg/grdchk: + - all procs calculate and print finite-difference gradient (for testreport) + - change description output used by testreport; + - AD testing: also compare and report Finite-difference gradient; + => update all output_adm*.txt +o test exp. global_ocean_ebm: + - switch back useRealFreshWaterFlux (no problem anymore with run-off); + and turn on exactConserve; update (fwd) output. +o pkg/seaice (LSR): + - print to STDOUT number of solver iterations at SEAICE_monFreq interval. + - modify solver to deal cleanly with u/v switch at face edges (CS-grid): + * identical results with non-CS topology (but save up to half of EXCH calls) + * no much changes in cs-32 verification tests since no ice at face edges + (differences due to convergence criteria, since nb of iterations changed) + * expect some differences on lat-lon-cap grid. + update FWD results of global_ocean.cs32x15 test exp. (icedyn & seaice) +o pkg/exch2: + - add new CPP option to disable Cumul-Sum matrix (to save storage when using + many tiles); until alternative coding is added, just add a stop. +o pkg/kpp: + - move ptracer/salt correction to KPP diffusivity from calc_3d_diffusivity.F + to S/R KPP_CALC_DIFF_PTR (+ add tracer-index to argument list). +o optfiles: + - merged few MPI specific (*+mpi*) and multi-threads specific (*+mth) optfiles + into corresponding standard one, which now support different build: + (when using "genmake2 -mpi" for MPI built, "genmake2 -omp" for OpenMP built) + - add "darwin_amd64_gfortran" optfile (initially from Constantinos, tested by Gael) +o pkg/obcs (seaice): + - add missing EXCH for uIce,vIce after applying OBCS; + - remove S/R EXF_SWAPFFIELDS_X/Y , disable S/R EXF_SET_OBCS_X/Y by adding + argument = number of levels to S/R EXF_SWAPFFIELDS_XZ/YZ and S/R + EXF_SET_OBCS_XZ/YZ ; update obcs_exf_load.F; + - fix EXF_SET_OBCS_XZ/YZ for multi-threaded (assuming loaded arrays are shared) + - verification exp. seaice_obcs: split domain in 2 tiles ; add SIZE.h_mpi + and eedata.mth for MPI and mutlti-threaded testing. +o pkg/flt: + - make FLT EXCH working with multi-threads (and MPI + multi-threads); + - use buffer for floats IO (trajectories & profiles); size set in FLT_SIZE.h; + - fix pickup and trajectories + profiles output with multi-threads; + - add parameter to select group of fields to write along trajectory and + profile (default unchanged); + - only call PORT_RAND* function when flt_noise <> 0; + - add multi-threaded test for verification exp. flt_example. +o eesupp/src: + - fix S/R ALL_PROC_DIE for MPI+multi-threads. + - USE_OMP_THREADING: check that number of threads (from eedata) matches + actual number (from env.var. setting). +o pkg/ebm: + - fix multi-threading in ebm_area_t.F ; clean-up EBM.h header file. + - add multi-threaded test for verification exp. global_ocean_ebm + +checkpoint63b (2011/08/29) +o pkg/ebm: + - fix sign of runoff; + - update directly forcing fields (Qnet,EmPmR) to use standard + external_forcing_surf.F (remove ebm_forcing_surf.F); + - avoid loading forcing fields a 2nd time (1rst time from ini_forcing.F); + - set either tauThetaClimRelax (in data) or tauThetaZonRelax (in data.ebm) + and apply relaxation towards corresponding SST field (2-D map or ZonAver). + - update global_ocean_ebm parameters file data and update output (fwd+ad). +o verification/matrix_example: + - split domain in 8 tiles (2x4); add SIZE.h_mpi and eedata.mth for + MPI and mutlti-threaded testing. +o pkg/matrix: + - change name of S/R MATRIX_INIT to S/R MATRIX_INIT_VARIA ; + - fix for multi-tiles (add bi,bj indices to exp/impMatrixCounter); + - fix for multi-threaded (remove DATA statement); + - use standard DIFFERENT_MULTIPLE function; + - add MATRIX_OPTIONS.h +o verification/matrix_example: + To allow to split the domain in several tiles, change the domain size + from 31x31 to 32x32 by adding 1 row (on Southern side) + 1 column (on + Western side) of land points. +o (*_)write_pickup: + - fix few bugs in mypackage_read/write_pickup.F + - in MDS_WR_METAFILES calls, replace "myTime" by a local copy into + array of length 1 (was caught by compiler syntax-check). +o pkg/diagnostics (velocity potential solver): + - fix initialisation of main diagonal matrix (for overlap values) +o tools/build_options: + - towards single optfile for MPI and non-MPI built: merge few +mpi optfile + into previously non MPI one (linux_am64 pgf77,open64,pathf90,ifort11) + - linux_amd64_gfortran: merge +mpi_generic version into standard optfile: + * move IEEE flags to DEVEL section; take IEEE flags from +mpi_generic ; + * FAST case: for now, keep -O3 with ini_masks_etc.F in NOOPTFILES list; + and use "-devel" testreport option for standard testing on baudelaire. +o pkg/grdchk: + - Assume that all gradient-check position are within the same tile + corresponding to global indices (iGloTile,jGloTile) and that + positions (i,j indices or nbeg) are local to this tile; + - set tile local-indices and proc. number according to tile global-indices; + - remove grdchkwhichproc from namelist (retired param); + - send adjoint gradient to all procs so that all procs print it to STDOUT; + - switch on MPI test for global_ocean.90x40x15 AD test experiment. +o adding package bbl (Bottom Boundary Layer) + description in MITgcm/pkg/bbl/bbl_description.tex + example/test experiment in MITgcm_contrib/bbl +o adjoint verifications + - changed 5 experiments to multi-tiles + * global_ocean.90x40x15 + * obcs_ctrl + * offline_exf_seaice + * tutorial_dic_adjoffline + * tutorial_tracer_adjsens + changed reference output for those that crossed tile boundaries + (changed choices of gradient check positions) + - with same tiling, switch on MPI test for the last 4 (add SIZE.h_mpi) + - temporary bug fix in grdchk_loc.F for obcs +o genmake2 & testreport + - add target "obj" (just for OBJFILES files) to Makefile; + - add option to specify FEXTRAFLAGS on command line. +o pkg/mypackage: + - remove bi,bj arguments from argument list of S/R MYPACKAGE_CALC_RHS + +checkpoint63a (2011/08/02) +o pkg/diagnostics (velocity potential): + - fix velocity-potential calculation when using OBCS: balance net inflow + at each level (new S/R OBCS_DIAG_BALANCE). + - fix some of the problems with OBCS in stream-function calculation. +o pkg/exf/exf_readparms.F + - make treatment of optional namelists (EXF_NML_04, EXF_NML_SGRUNOFF, + EXF_NML_OBCS) more consistent, so that you need not have these lists + in data.exf when they are not used. +o optim/optim_readdata.F: + - add some output about obcs variables that might help debugging + - add a check about nvarlength +o pkg/ctrl: once again, fix computation of endrec in s/r ctrl_init_rec +o pkg/diagnostics (velocity potential): + - fix mask for OBCS (still problems in stream-function with OBCS); + - add specific parameter (default = main code CG2D params) for solver; + - in case of poor convergence, use solution corresponding to lowest residual. +o pkg/seaice/seaice_growth.F: small changes that permit vectorizable + adjoint code. In general statements like tmpscal=fld(i,j) are problematic + and should be avoided where possible. +o model/src (rStar): + - include r* effect on reference-state (PhiRef) in totPhiHyd + (so that it's really the potential anomaly at the cell center); + affect solution only if z* with full pressure in EOS. + - test-exp global_ocean.90x40x15: reduce viscA4 (was not stable) and + update output (because of z* in totPhiHyd and viscA4 changes); + - keep the previous diagnostics as "PHIHYDcR" (closer to potential anomaly + @ constant r) until interpolation at constant r is implemented. +o pkg/diagnostics + - fix RCENTER diagnostics in case cell center is not at interface middle +o add code for TEOS-10 (www.teos-10.org, McDougall et al. 2011). Use + this eos with eosType = 'TEOS10', in data (PARM01). This eos implies + that THETA and SALT are "conservative temperature" and "absolute + salinity" +o pkg/ctrl + - fix computation of endrec in s/r ctrl_init_rec + - ctrl_pack/unpack_*: remove unused variables and some obsolete code +o pkg/seaice/seaice_growth.F + - fix recomputation with FENTY_AREA_EXPANSION_CONTRACTION code, + remove then obsolete STORE directives + - fix STORE directives for tice and tices, so that only the + appropriate part of the fields are stored (and not the entire + field); update global_ocean.cs32x15.seaice AD output. + - cosmetic changes: adjust CPP flags and indentation for better + legibilty +o pkg/autodiff: add mnc-output of adBottomDragFld (code contributed by + Chris Wilson) +o pkg/gmredi: + Add Sub-Meso Eddies parameterisation from Baylor (for now, disabled with TAF), + and test it in verification exp. "front_relax.bvp" (update output.bvp.txt) + +checkpoint63 (2011/07/11) +o pkg/exch2: + - rename+move: nTiles in W2_EXCH2_PARAMS.h --> exch2_nTiles in W2_EXCH2_TOPOLOGY.h + - exch2 version of Cumul-Sum routine: S/R W2_SET_MAP_CUMSUM set up the + (2*nTiles)x(nTiles) Cumul-Sum matrix and Master Proc collects all tiles X,Y + increments, calculates Cumul-Sum @ tile origin and sends results to each tile. +o pkg/diagnostics: + - deal with pairs of post-processed diags which are computed together; in + particular, re-order list of diags within 1 file to save 2nd computation. + - add S/R to compute velocity stream-function (called after velocity-potential + calculation) from divergence free transport -> new diagnostics "PsiVEL". + - add parameter to select grid-point location where PsiVEL == 0. +o eesupp/src: + new S/R to calculate cumulated sum on tiled array, corner grid-cell location + (specific S/R needed with exch2 topology - for now, just print an error msg) +o pkg/shelfice + - Implement friction velocity-dependent transfer coefficients following + Holland and Jenkins, JPO, 1999 + Original code by M. Losch with small modifs. + Enable with CPP option SHI_ALLOW_GAMMAFRICT + and runtime flag SHELFICEuseGammaFrict +o verification lab_sea & global_ocean.cs32x15: + - use tools/xmakedepend (instead of cyrus_makedepend, in genmake_local): + does not miss some dependencies (but is slower) and also works with many files + (default makedepend limitation for AD built). + - use cyrus_makedepend in adjustment.128x64x1 (so that it still tested). o pkg/diagnostics: - add run-time parameter "useMissingValue" (def=False) to fill land-point (i.e., where mask=0) with MissingValue ; used only in MNC output file. @@ -12,6 +741,12 @@ of counter-diagnostics (where fraction-weight is zero). This applies both to MNC and MDS output files. o pkg/seaice/seaice_growth.F: + - add 'a priori' cap of latent heat flux based on actual mass considerations + when SEAICE_ADD_SUBLIMATION_TO_FWBUDGET is used in conjunction with the + non-legacy seaice_solve4temp. + - add diagnostic of the residual sublimation freshwater flux (the freshwater + flux taken from the ocean if the total actual latent heat fluxes exceed + the maximum) - remove the CPP switch around the *_FWbySublim unit change and move diagnostic fill for SIatmQnt, SIfwSubl, SIatmFW to the end of seaice_growth.F. - add diagnostic of the actual sublimation freshwater flux (that is 0. ifndef