[Rivet-svn] r3348 - in trunk: . src/Analyses

blackhole at projects.hepforge.org blackhole at projects.hepforge.org
Mon Sep 12 23:42:51 BST 2011


Author: buckley
Date: Mon Sep 12 23:42:50 2011
New Revision: 3348

Log:
Removing uses of getLog, cout, cerr, and endl from all standard analyses, except in a very few special cases.

Modified:
   trunk/ChangeLog
   trunk/src/Analyses/ALEPH_1991_S2435284.cc
   trunk/src/Analyses/ALEPH_1996_S3486095.cc
   trunk/src/Analyses/ALEPH_2004_S5765862.cc
   trunk/src/Analyses/ATLAS_2010_S8894728.cc
   trunk/src/Analyses/BELLE_2006_S6265367.cc
   trunk/src/Analyses/CDF_1996_S3349578.cc
   trunk/src/Analyses/CDF_1997_S3541940.cc
   trunk/src/Analyses/CDF_2001_S4751469.cc
   trunk/src/Analyses/CDF_2004_S5839831.cc
   trunk/src/Analyses/CDF_2005_S6217184.cc
   trunk/src/Analyses/CDF_2006_S6653332.cc
   trunk/src/Analyses/CDF_2008_LEADINGJETS.cc
   trunk/src/Analyses/CDF_2008_NOTE_9351.cc
   trunk/src/Analyses/CDF_2008_S7540469.cc
   trunk/src/Analyses/CDF_2008_S7782535.cc
   trunk/src/Analyses/CDF_2008_S8095620.cc
   trunk/src/Analyses/CDF_2009_S8057893.cc
   trunk/src/Analyses/CDF_2009_S8383952.cc
   trunk/src/Analyses/CDF_2010_S8591881_DY.cc
   trunk/src/Analyses/CDF_2010_S8591881_QCD.cc
   trunk/src/Analyses/D0_1996_S3214044.cc
   trunk/src/Analyses/D0_2001_S4674421.cc
   trunk/src/Analyses/D0_2007_S7075677.cc
   trunk/src/Analyses/D0_2008_S7554427.cc
   trunk/src/Analyses/D0_2008_S7662670.cc
   trunk/src/Analyses/D0_2008_S7719523.cc
   trunk/src/Analyses/D0_2008_S7837160.cc
   trunk/src/Analyses/D0_2008_S7863608.cc
   trunk/src/Analyses/D0_2009_S8202443.cc
   trunk/src/Analyses/D0_2009_S8349509.cc
   trunk/src/Analyses/DELPHI_1995_S3137023.cc
   trunk/src/Analyses/DELPHI_1996_S3430090.cc
   trunk/src/Analyses/DELPHI_2002_069_CONF_603.cc
   trunk/src/Analyses/DELPHI_2003_WUD_03_11.cc
   trunk/src/Analyses/H1_1994_S2919893.cc
   trunk/src/Analyses/JADE_1998_S3612880.cc
   trunk/src/Analyses/MC_JetAnalysis.cc
   trunk/src/Analyses/MC_LEADINGJETS.cc
   trunk/src/Analyses/MC_PHOTONJETUE.cc
   trunk/src/Analyses/MC_SUSY.cc
   trunk/src/Analyses/OPAL_1993_S2692198.cc
   trunk/src/Analyses/OPAL_1998_S3780481.cc
   trunk/src/Analyses/PDG_Hadron_Multiplicities_Ratios.cc
   trunk/src/Analyses/SFM_1984_S1178091.cc
   trunk/src/Analyses/STAR_2006_S6500200.cc
   trunk/src/Analyses/STAR_2006_S6860818.cc
   trunk/src/Analyses/STAR_2006_S6870392.cc
   trunk/src/Analyses/STAR_2008_S7993412.cc
   trunk/src/Analyses/STAR_2009_UE_HELEN.cc
   trunk/src/Analyses/TASSO_1990_S2148048.cc
   trunk/src/Analyses/UA5_1986_S1583476.cc
   trunk/src/Analyses/ZEUS_2001_S4815815.cc

Modified: trunk/ChangeLog
==============================================================================
--- trunk/ChangeLog	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/ChangeLog	Mon Sep 12 23:42:50 2011	(r3348)
@@ -1,3 +1,8 @@
+2011-09-12  Andy Buckley  <andy at insectnation.org>
+
+	* Removing uses of getLog, cout, cerr, and endl from all standard
+	analyses, except in a very few special cases.
+
 2011-09-10  Andy Buckley  <andy at insectnation.org>
 
 	* Changing the behaviour and interface of the MissingMomentum

Modified: trunk/src/Analyses/ALEPH_1991_S2435284.cc
==============================================================================
--- trunk/src/Analyses/ALEPH_1991_S2435284.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/ALEPH_1991_S2435284.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -36,7 +36,7 @@
     /// Do the analysis
     void analyze(const Event& event) {
       const Multiplicity& m = applyProjection<Multiplicity>(event, "Mult");
-      getLog() << Log::DEBUG << "Total charged multiplicity = " << m.totalMultiplicity() << endl;
+      MSG_DEBUG("Total charged multiplicity = " << m.totalMultiplicity());
       _histChTot->fill(m.totalMultiplicity(), event.weight());
     }
 

Modified: trunk/src/Analyses/ALEPH_1996_S3486095.cc
==============================================================================
--- trunk/src/Analyses/ALEPH_1996_S3486095.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/ALEPH_1996_S3486095.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -138,10 +138,10 @@
 
       // Even if we only generate hadronic events, we still need a cut on numCharged >= 2.
       if (numParticles < 2) {
-        getLog() << Log::DEBUG << "Failed leptonic event cut" << endl;
+        MSG_DEBUG("Failed leptonic event cut");
         vetoEvent;
       }
-      getLog() << Log::DEBUG << "Passed leptonic event cut" << endl;
+      MSG_DEBUG("Passed leptonic event cut");
 
       // Get event weight for histo filling
       const double weight = e.weight();
@@ -151,17 +151,17 @@
       const ParticlePair& beams = applyProjection<Beam>(e, "Beams").beams();
       const double meanBeamMom = ( beams.first.momentum().vector3().mod() +
                                    beams.second.momentum().vector3().mod() ) / 2.0;
-      getLog() << Log::DEBUG << "Avg beam momentum = " << meanBeamMom << endl;
+      MSG_DEBUG("Avg beam momentum = " << meanBeamMom);
 
       // Thrusts
-      getLog() << Log::DEBUG << "Calculating thrust" << endl;
+      MSG_DEBUG("Calculating thrust");
       const Thrust& thrust = applyProjection<Thrust>(e, "Thrust");
       _hist1MinusT->fill(1 - thrust.thrust(), weight);
       _histTMinor->fill(thrust.thrustMinor(), weight);
       _histOblateness->fill(thrust.oblateness(), weight);
 
       // Jets
-      getLog() << Log::DEBUG << "Calculating differential jet rate plots:" << endl;
+      MSG_DEBUG("Calculating differential jet rate plots:");
       const FastJets& durjet = applyProjection<FastJets>(e, "DurhamJets");
       if (durjet.clusterSeq()) {
         double y3 = durjet.clusterSeq()->exclusive_ymerge_max(2);
@@ -169,18 +169,18 @@
       }
 
       // Sphericities
-      getLog() << Log::DEBUG << "Calculating sphericity" << endl;
+      MSG_DEBUG("Calculating sphericity");
       const Sphericity& sphericity = applyProjection<Sphericity>(e, "Sphericity");
       _histSphericity->fill(sphericity.sphericity(), weight);
       _histAplanarity->fill(sphericity.aplanarity(), weight);
 
       // C param
-      getLog() << Log::DEBUG << "Calculating Parisi params" << endl;
+      MSG_DEBUG("Calculating Parisi params");
       const ParisiTensor& parisi = applyProjection<ParisiTensor>(e, "Parisi");
       _histCParam->fill(parisi.C(), weight);
 
       // Hemispheres
-      getLog() << Log::DEBUG << "Calculating hemisphere variables" << endl;
+      MSG_DEBUG("Calculating hemisphere variables");
       const Hemispheres& hemi = applyProjection<Hemispheres>(e, "Hemispheres");
       _histHeavyJetMass->fill(hemi.scaledM2high(), weight);
 
@@ -191,7 +191,7 @@
       double rapt15 = 0.;
       double rapt20 = 0.;
       //int numChParticles = 0;
-      getLog() << Log::DEBUG << "About to iterate over charged FS particles" << endl;
+      MSG_DEBUG("About to iterate over charged FS particles");
       foreach (const Particle& p, fs.particles()) {
         // Get momentum and energy of each particle.
         const Vector3 mom3 = p.momentum().vector3();

Modified: trunk/src/Analyses/ALEPH_2004_S5765862.cc
==============================================================================
--- trunk/src/Analyses/ALEPH_2004_S5765862.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/ALEPH_2004_S5765862.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -120,20 +120,19 @@
       default:
         _initialisedSpectra=false;
       }
-      if(_initialisedSpectra) {
+      if (_initialisedSpectra) {
         _h_xp = bookHistogram1D( 2+offset, 1, 1);
         _h_xi = bookHistogram1D(11+offset, 1, 1);
         _h_xe = bookHistogram1D(19+offset, 1, 1);
         _h_pTin  = bookHistogram1D(27+offset, 1, 1);
-        _h_pTout = offset!=7 ? NULL : bookHistogram1D(35, 1, 1);
+        _h_pTout = offset != 7 ? NULL : bookHistogram1D(35, 1, 1);
         _h_rapidityT = bookHistogram1D(36+offset, 1, 1);
         _h_rapidityS = bookHistogram1D(44+offset, 1, 1);
       }
 
-      if(!_initialisedSpectra && !_initialisedJets) {
-        getLog() << Log::WARNING
-                 << "CMS energy of events sqrt(s) = " << sqrtS()/GeV
-                 <<" doesn't match any available analysis energy ." << endl;
+      if (!_initialisedSpectra && !_initialisedJets) {
+        MSG_WARNING("CoM energy of events sqrt(s) = " << sqrtS()/GeV
+                    << " doesn't match any available analysis energy .");
       }
     }
 

Modified: trunk/src/Analyses/ATLAS_2010_S8894728.cc
==============================================================================
--- trunk/src/Analyses/ATLAS_2010_S8894728.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/ATLAS_2010_S8894728.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -9,38 +9,6 @@
 namespace Rivet {
 
 
-  namespace {
-
-    inline void _moments_to_stddev(AIDA::IProfile1D* moment_profiles[], AIDA::IDataPointSet* target_dps) {
-      for (int b = 0; b < target_dps->size(); ++b) { // loop over bins
-        /// @todo Assuming unit weights here! Should use N_effective = sumW**2/sumW2? How?
-        const double numentries = moment_profiles[0]->binEntries(b);
-        const double var = moment_profiles[1]->binHeight(b) - intpow(moment_profiles[0]->binHeight(b), 2);
-        const double sd = isZero(var) ? 0 : sqrt(var); //< Numerical safety check
-        target_dps->point(b)->coordinate(1)->setValue(sd);
-        if (sd == 0 || numentries < 3) {
-          cerr << "Need at least 3 bin entries and a non-zero central value to calculate "
-               << "an error on standard deviation profiles (bin " << b << ")" << endl;
-          target_dps->point(b)->coordinate(1)->setErrorPlus(0);
-          target_dps->point(b)->coordinate(1)->setErrorMinus(0);
-          continue;
-        }
-        // c2(y) = m4(x) - 4 m3(x) m1(x) - m2(x)^2 + 8 m2(x) m1(x)^2 - 4 m1(x)^4
-        const double var_on_var = moment_profiles[3]->binHeight(b)
-          - 4 * moment_profiles[2]->binHeight(b) * moment_profiles[0]->binHeight(b)
-          - intpow(moment_profiles[1]->binHeight(b), 2)
-          + 8 * moment_profiles[1]->binHeight(b) * intpow(moment_profiles[0]->binHeight(b), 2)
-          - 4 * intpow(moment_profiles[0]->binHeight(b), 4);
-        const double stderr_on_var = sqrt(var_on_var/(numentries-2.0));
-        const double stderr_on_sd = stderr_on_var / (2.0*sd);
-        target_dps->point(b)->coordinate(1)->setErrorPlus(stderr_on_sd);
-        target_dps->point(b)->coordinate(1)->setErrorMinus(stderr_on_sd);
-      }
-    }
-
-  }
-
-
   class ATLAS_2010_S8894728 : public Analysis {
   public:
 
@@ -286,6 +254,37 @@
 
   private:
 
+
+    inline void _moments_to_stddev(AIDA::IProfile1D* moment_profiles[], AIDA::IDataPointSet* target_dps) {
+      for (int b = 0; b < target_dps->size(); ++b) { // loop over bins
+        /// @todo Assuming unit weights here! Should use N_effective = sumW**2/sumW2? How?
+        const double numentries = moment_profiles[0]->binEntries(b);
+        const double var = moment_profiles[1]->binHeight(b) - intpow(moment_profiles[0]->binHeight(b), 2);
+        const double sd = isZero(var) ? 0 : sqrt(var); //< Numerical safety check
+        target_dps->point(b)->coordinate(1)->setValue(sd);
+        if (sd == 0 || numentries < 3) {
+          MSG_WARNING("Need at least 3 bin entries and a non-zero central value to calculate "
+                      << "an error on standard deviation profiles (bin " << b << ")");
+          target_dps->point(b)->coordinate(1)->setErrorPlus(0);
+          target_dps->point(b)->coordinate(1)->setErrorMinus(0);
+          continue;
+        }
+        // c2(y) = m4(x) - 4 m3(x) m1(x) - m2(x)^2 + 8 m2(x) m1(x)^2 - 4 m1(x)^4
+        const double var_on_var = moment_profiles[3]->binHeight(b)
+          - 4 * moment_profiles[2]->binHeight(b) * moment_profiles[0]->binHeight(b)
+          - intpow(moment_profiles[1]->binHeight(b), 2)
+          + 8 * moment_profiles[1]->binHeight(b) * intpow(moment_profiles[0]->binHeight(b), 2)
+          - 4 * intpow(moment_profiles[0]->binHeight(b), 4);
+        const double stderr_on_var = sqrt(var_on_var/(numentries-2.0));
+        const double stderr_on_sd = stderr_on_var / (2.0*sd);
+        target_dps->point(b)->coordinate(1)->setErrorPlus(stderr_on_sd);
+        target_dps->point(b)->coordinate(1)->setErrorMinus(stderr_on_sd);
+      }
+    }
+
+
+  private:
+
     AIDA::IProfile1D*  _hist_nch_transverse_500[4];
     AIDA::IProfile1D*  _hist_nch_toward_500;
     AIDA::IProfile1D*  _hist_nch_away_500;

Modified: trunk/src/Analyses/BELLE_2006_S6265367.cc
==============================================================================
--- trunk/src/Analyses/BELLE_2006_S6265367.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/BELLE_2006_S6265367.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -50,12 +50,12 @@
         const double mom = cms_boost.transform(p.momentum()).vector3().mod();
 
         const int PdgId = abs(p.pdgId());
-        getLog() << Log::DEBUG << "pdgID = " << PdgId << "  mom = " << mom << endl;
+        MSG_DEBUG("pdgID = " << PdgId << "  mom = " << mom);
 
         switch (PdgId) {
 
           case 421:
-            getLog() << Log::DEBUG << "D0 found" << endl;
+            MSG_DEBUG("D0 found");
             mH2 = 3.47763; // 1.86484^2
             xp = mom/sqrt(s/4.0 - mH2);
             if (onresonance)
@@ -65,7 +65,7 @@
             break;
 
           case 411:
-            getLog() << Log::DEBUG << "D+ found" << endl;
+            MSG_DEBUG("D+ found");
             mH2 = 3.49547; // 1.86962^2
             xp = mom/sqrt(s/4.0 - mH2);
             if (onresonance)
@@ -75,7 +75,7 @@
             break;
 
           case 431:
-            getLog() << Log::DEBUG << "D+_s found" << endl;
+            MSG_DEBUG("D+_s found");
             mH2 = 3.87495; // 1.96849^2
             xp = mom/sqrt(s/4.0 - mH2);
             if (onresonance)
@@ -85,7 +85,7 @@
             break;
 
           case 4122:
-            getLog() << Log::DEBUG << "Lambda_c found" << endl;
+            MSG_DEBUG("Lambda_c found");
             mH2 = 5.22780; // 2.28646^2
             xp = mom/sqrt(s/4.0 - mH2);
             if (onresonance)
@@ -95,7 +95,7 @@
             break;
 
           case 413: {
-            getLog() << Log::DEBUG << "D*+ found" << endl;
+            MSG_DEBUG("D*+ found");
             mH2 = 4.04119; // 2.01027^2
             xp = mom/sqrt(s/4.0 - mH2);
 
@@ -127,16 +127,16 @@
               else
                 _histXpDstarplus2Dplus_C->fill(xp, weight);
             } else {
-              getLog() << Log::WARN << "Unexpected D* decay!" << endl;
+              MSG_WARNING("Unexpected D* decay!");
             }
             break;
             }
 
           case 423:
-            getLog() << Log::DEBUG << "D*0 found" << endl;
+            MSG_DEBUG("D*0 found");
             mH2 = 4.02793; // 2.00697**2
             xp = mom/sqrt(s/4.0 - mH2);
-            getLog() << Log::DEBUG << "xp = " << xp << endl;
+            MSG_DEBUG("xp = " << xp);
             if (onresonance)
               _histXpDstar0_R->fill(xp, weight);
             else

Modified: trunk/src/Analyses/CDF_1996_S3349578.cc
==============================================================================
--- trunk/src/Analyses/CDF_1996_S3349578.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_1996_S3349578.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -117,7 +117,7 @@
 
 
     void _threeJetAnalysis(const Jets& jets, const double& weight) {
-      getLog() << Log::DEBUG << "3 jet analysis" << std::endl;
+      MSG_DEBUG("3 jet analysis");
 
       double sumEt=0.0;
       FourMomentum jetsystem(0.0, 0.0, 0.0, 0.0);
@@ -174,7 +174,7 @@
 
 
     void _fourJetAnalysis(const Jets& jets, const double& weight) {
-      getLog() << Log::DEBUG << "4 jet analysis" << std::endl;
+      MSG_DEBUG("4 jet analysis");
 
       double sumEt=0.0;
       FourMomentum jetsystem(0.0, 0.0, 0.0, 0.0);
@@ -241,7 +241,7 @@
 
 
     void _fiveJetAnalysis(const Jets& jets, const double& weight) {
-      getLog() << Log::DEBUG << "5 jet analysis" << std::endl;
+      MSG_DEBUG("5 jet analysis");
 
       double sumEt=0.0;
       FourMomentum jetsystem(0.0, 0.0, 0.0, 0.0);
@@ -412,7 +412,7 @@
       double mass2=p.mass2();
       if (mass2>0.0) return sqrt(mass2);
       else if (mass2<-1.0e-5) {
-        getLog() << Log::WARNING << "m2 = " << m2 << ". Assuming m2=0." << endl;
+        MSG_WARNING("m2 = " << m2 << ". Assuming m2=0.");
         return 0.0;
       }
       else return 0.0;

Modified: trunk/src/Analyses/CDF_1997_S3541940.cc
==============================================================================
--- trunk/src/Analyses/CDF_1997_S3541940.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_1997_S3541940.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -236,7 +236,7 @@
       double mass2=p.mass2();
       if (mass2>0.0) return sqrt(mass2);
       else if (mass2<-1.0e-5) {
-        getLog() << Log::WARNING << "m2 = " << m2 << ". Assuming m2=0." << endl;
+        MSG_WARNING("m2 = " << m2 << ". Assuming m2=0.");
         return 0.0;
       }
       else return 0.0;

Modified: trunk/src/Analyses/CDF_2001_S4751469.cc
==============================================================================
--- trunk/src/Analyses/CDF_2001_S4751469.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2001_S4751469.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -195,13 +195,8 @@
       }
 
       // Log some event details about pT
-      getLog() << Log::DEBUG
-               << "pT [lead; twd, away, trans] = ["
-               << ptLead << "; "
-               << ptSumToward << ", "
-               << ptSumAway << ", "
-               << ptSumTrans << "]"
-               << endl;
+      MSG_DEBUG("pT [lead; twd, away, trans] = [" << ptLead << "; "
+                << ptSumToward << ", " << ptSumAway << ", " << ptSumTrans << "]");
 
       // Update the pT profile histograms
       _ptsumTowardMB->fill(ptLead/GeV, ptSumToward/GeV, weight);
@@ -214,12 +209,8 @@
       _ptsumAwayJ20->fill(ptLead/GeV, ptSumAway/GeV, weight);
 
       // Log some event details about Nch
-      getLog() << Log::DEBUG
-               << "N [twd, away, trans] = ["
-               << numToward << ", "
-               << numTrans << ", "
-               << numAway << "]"
-               << endl;
+      MSG_DEBUG("N [twd, away, trans] = [" << ptLead << "; "
+               << numToward << ", " << numTrans << ", " << numAway << "]");
 
       // Update the N_track profile histograms
       _numTowardMB->fill(ptLead/GeV, numToward, weight);

Modified: trunk/src/Analyses/CDF_2004_S5839831.cc
==============================================================================
--- trunk/src/Analyses/CDF_2004_S5839831.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2004_S5839831.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -49,9 +49,9 @@
                               const ParticleVector& tracks) {
       const double phiTransPlus = mapAngle0To2Pi(phiLead + PI/2.0);
       const double phiTransMinus = mapAngle0To2Pi(phiLead - PI/2.0);
-      getLog() << Log::DEBUG << "phi_lead = " << phiLead
+      MSG_DEBUG("phi_lead = " << phiLead
                << " -> trans = (" << phiTransPlus
-               << ", " << phiTransMinus << ")" << endl;
+               << ", " << phiTransMinus << ")");
 
       unsigned int numPlus(0), numMinus(0);
       double ptPlus(0), ptMinus(0);
@@ -79,10 +79,10 @@
       rtn.ptMin = (ptPlus >= ptMinus) ? ptMinus : ptPlus;
       rtn.ptDiff = fabs(rtn.ptMax - rtn.ptMin);
 
-      getLog() << Log::DEBUG << "Min cone has " << rtn.numMin << " tracks -> "
-               << "pT_min = " << rtn.ptMin/GeV << " GeV" << endl;
-      getLog() << Log::DEBUG << "Max cone has " << rtn.numMax << " tracks -> "
-               << "pT_max = " << rtn.ptMax/GeV << " GeV" << endl;
+      MSG_DEBUG("Min cone has " << rtn.numMin << " tracks -> "
+               << "pT_min = " << rtn.ptMin/GeV << " GeV");
+      MSG_DEBUG("Max cone has " << rtn.numMax << " tracks -> "
+               << "pT_max = " << rtn.ptMax/GeV << " GeV");
 
       return rtn;
     }
@@ -159,7 +159,7 @@
       const double weight = event.weight();
 
       {
-        getLog() << Log::DEBUG << "Running max/min analysis" << endl;
+        MSG_DEBUG("Running max/min analysis");
         vector<Jet> jets = applyProjection<JetAlg>(event, "Jets").jetsByE();
         if (!jets.empty()) {
           // Leading jet must be in central |eta| < 0.5 region
@@ -167,10 +167,10 @@
           const double etaLead = leadingjet.momentum().eta();
           // Get Et of the leading jet: used to bin histograms
           const double ETlead = leadingjet.EtSum();
-          getLog() << Log::DEBUG << "Leading Et = " << ETlead/GeV << " GeV" << endl;
+          MSG_DEBUG("Leading Et = " << ETlead/GeV << " GeV");
           if (fabs(etaLead) > 0.5 && ETlead < 15*GeV) {
-            getLog() << Log::DEBUG << "Leading jet eta = " << etaLead
-                     << " not in |eta| < 0.5 & pT > 15 GeV" << endl;
+            MSG_DEBUG("Leading jet eta = " << etaLead
+                     << " not in |eta| < 0.5 & pT > 15 GeV");
           } else {
             // Multiplicity & pT distributions for sqrt(s) = 630 GeV, 1800 GeV
             const ParticleVector tracks = applyProjection<FinalState>(event, "TrackFS").particles();
@@ -209,7 +209,7 @@
 
       // Fill min bias total track multiplicity histos
       {
-        getLog() << Log::DEBUG << "Running min bias multiplicity analysis" << endl;
+        MSG_DEBUG("Running min bias multiplicity analysis");
         const ParticleVector mbtracks = applyProjection<FinalState>(event, "MBFS").particles();
         if (fuzzyEquals(sqrtS/GeV, 1800)) {
           _numTracksDbn1800MB->fill(mbtracks.size(), weight);
@@ -236,11 +236,11 @@
       // different set of charged tracks, with |eta| < 1.0, is used here, and all
       // the removed jets must have Et > 5 GeV.
       {
-        getLog() << Log::DEBUG << "Running Swiss Cheese analysis" << endl;
+        MSG_DEBUG("Running Swiss Cheese analysis");
         const ParticleVector cheesetracks = applyProjection<FinalState>(event, "CheeseFS").particles();
         vector<Jet> cheesejets = applyProjection<JetAlg>(event, "Jets").jetsByE();
         if (cheesejets.empty()) {
-          getLog() << Log::DEBUG << "No 'cheese' jets found in event" << endl;
+          MSG_DEBUG("No 'cheese' jets found in event");
           return;
         }
         if (cheesejets.size() > 1 &&
@@ -263,12 +263,12 @@
             // Subtracting 2 leading jets
             const double deltaR1 = deltaR(trackMom, eta1, phi1);
             const double deltaR2 = deltaR(trackMom, eta2, phi2);
-            getLog() << Log::TRACE << "Track vs jet(1): "
+            MSG_TRACE("Track vs jet(1): "
                      << "|(" << trackMom.pseudorapidity() << ", " << trackMom.azimuthalAngle() << ") - "
-                     << "|(" << eta1 << ", " << phi1 << ")| = " << deltaR1 << endl;
-            getLog() << Log::TRACE << "Track vs jet(2): "
+                     << "|(" << eta1 << ", " << phi1 << ")| = " << deltaR1);
+            MSG_TRACE("Track vs jet(2): "
                      << "|(" << trackMom.pseudorapidity() << ", " << trackMom.azimuthalAngle() << ") - "
-                     << "|(" << eta2 << ", " << phi2 << ")| = " << deltaR2 << endl;
+                     << "|(" << eta2 << ", " << phi2 << ")| = " << deltaR2);
             if (deltaR1 > 0.7 && deltaR2 > 0.7) {
               ptSumSub2 += pt;
 
@@ -278,9 +278,9 @@
                 const double eta3 = cheesejets[2].momentum().pseudorapidity();
                 const double phi3 = cheesejets[2].momentum().azimuthalAngle();
                 const double deltaR3 = deltaR(trackMom, eta3, phi3);
-                getLog() << Log::TRACE << "Track vs jet(3): "
+                MSG_TRACE("Track vs jet(3): "
                          << "|(" << trackMom.pseudorapidity() << ", " << trackMom.azimuthalAngle() << ") - "
-                         << "|(" << eta3 << ", " << phi3 << ")| = " << deltaR3 << endl;
+                         << "|(" << eta3 << ", " << phi3 << ")| = " << deltaR3);
                 if (deltaR3 > 0.7) {
                   ptSumSub3 += pt;
                 }

Modified: trunk/src/Analyses/CDF_2005_S6217184.cc
==============================================================================
--- trunk/src/Analyses/CDF_2005_S6217184.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2005_S6217184.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -77,7 +77,7 @@
         for (size_t ijet = 0; ijet < jsipt.numJets(); ++ijet) {
           for (size_t rbin = 0; rbin < jsipt.numBins(); ++rbin) {
             const double r_rho = jsipt.rBinMid(rbin);
-            // cout << ipt << " " << rbin << " (" << r_rho << ") " << jsipt.diffJetShape(ijet, rbin) << endl;
+            MSG_DEBUG(ipt << " " << rbin << " (" << r_rho << ") " << jsipt.diffJetShape(ijet, rbin));
             /// Bin width Jacobian factor of 0.7/0.1 = 7 in the differential shapes plot
             _profhistRho_pT[ipt]->fill(r_rho/0.7, (0.7/0.1)*jsipt.diffJetShape(ijet, rbin), weight);
             const double r_Psi = jsipt.rBinMax(rbin);

Modified: trunk/src/Analyses/CDF_2006_S6653332.cc
==============================================================================
--- trunk/src/Analyses/CDF_2006_S6653332.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2006_S6653332.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -102,10 +102,10 @@
 
       // Get jets
       const FastJets& jetpro = applyProjection<FastJets>(event, "Jets");
-      getLog() << Log::DEBUG << "Jet multiplicity before any pT cut = " << jetpro.size() << endl;
+      MSG_DEBUG("Jet multiplicity before any pT cut = " << jetpro.size());
 
       const PseudoJets& jets = jetpro.pseudoJetsByPt();
-      getLog() << Log::DEBUG << "jetlist size = " << jets.size() << endl;
+      MSG_DEBUG("jetlist size = " << jets.size());
 
       int numBJet = 0;
       int numJet  = 0;
@@ -143,9 +143,9 @@
 
     /// Finalize
     void finalize() {
-      getLog() << Log::DEBUG << "Total sum of weights = " << sumOfWeights() << endl;
-      getLog() << Log::DEBUG << "Sum of weights for Z production in mass range = " << _sumWeightsWithZ << endl;
-      getLog() << Log::DEBUG << "Sum of weights for Z+jet production in mass range = " << _sumWeightsWithZJet << endl;
+      MSG_DEBUG("Total sum of weights = " << sumOfWeights());
+      MSG_DEBUG("Sum of weights for Z production in mass range = " << _sumWeightsWithZ);
+      MSG_DEBUG("Sum of weights for Z+jet production in mass range = " << _sumWeightsWithZJet);
 
       _sigmaBJet->scale(crossSection()/sumOfWeights());
       _ratioBJetToZ->scale(1.0/_sumWeightsWithZ);

Modified: trunk/src/Analyses/CDF_2008_LEADINGJETS.cc
==============================================================================
--- trunk/src/Analyses/CDF_2008_LEADINGJETS.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2008_LEADINGJETS.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -76,24 +76,24 @@
 
       const FinalState& fsj = applyProjection<FinalState>(e, "FSJ");
       if (fsj.particles().size() < 1) {
-        getLog() << Log::DEBUG << "Failed multiplicity cut" << endl;
+        MSG_DEBUG("Failed multiplicity cut");
         vetoEvent;
       }
 
       const Jets& jets = applyProjection<FastJets>(e, "MidpointJets").jetsByPt();
-      getLog() << Log::DEBUG << "Jet multiplicity = " << jets.size() << endl;
+      MSG_DEBUG("Jet multiplicity = " << jets.size());
 
       // We require the leading jet to be within |eta|<2
       if (jets.size() < 1 || fabs(jets[0].momentum().eta()) >= 2) {
-        getLog() << Log::DEBUG << "Failed leading jet cut" << endl;
+        MSG_DEBUG("Failed leading jet cut");
         vetoEvent;
       }
 
       const double jetphi = jets[0].momentum().phi();
       const double jeteta = jets[0].momentum().eta();
       const double jetpT  = jets[0].momentum().pT();
-      getLog() << Log::DEBUG << "Leading jet: pT = " << jetpT
-               << ", eta = " << jeteta << ", phi = " << jetphi << endl;
+      MSG_DEBUG("Leading jet: pT = " << jetpT
+                << ", eta = " << jeteta << ", phi = " << jetphi);
 
       // Get the event weight
       const double weight = e.weight();

Modified: trunk/src/Analyses/CDF_2008_NOTE_9351.cc
==============================================================================
--- trunk/src/Analyses/CDF_2008_NOTE_9351.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2008_NOTE_9351.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -81,7 +81,7 @@
 
       // Even if we only generate hadronic events, we still need a cut on numCharged >= 2.
       if (numParticles < 1) {
-        getLog() << Log::DEBUG << "Failed multiplicity cut" << endl;
+        MSG_DEBUG("Failed multiplicity cut");
         vetoEvent;
       }
 
@@ -92,7 +92,7 @@
       const ParticleVector& leptons = applyProjection<ChargedLeptons>(e, "CL").chargedLeptons();
 
       // We want exactly two leptons of the same flavour.
-      getLog() << Log::DEBUG << "lepton multiplicity = " << leptons.size() << endl;
+      MSG_DEBUG("lepton multiplicity = " << leptons.size());
       if (leptons.size() != 2 || leptons[0].pdgId() != -leptons[1].pdgId() ) vetoEvent;
 
       // Lepton pT > 20 GeV
@@ -101,8 +101,8 @@
       // Lepton pair should have an invariant mass between 70 and 110 and |eta| < 6
       const FourMomentum dilepton = leptons[0].momentum() + leptons[1].momentum();
       if (!inRange(dilepton.mass()/GeV, 70., 110.) || fabs(dilepton.eta()) >= 6) vetoEvent;
-      getLog() << Log::DEBUG << "Dilepton mass = " << mass(dilepton)/GeV << " GeV" << endl;
-      getLog() << Log::DEBUG << "Dilepton pT   = " << pT(dilepton)/GeV << " GeV" << endl;
+      MSG_DEBUG("Dilepton mass = " << mass(dilepton)/GeV << " GeV");
+      MSG_DEBUG("Dilepton pT   = " << pT(dilepton)/GeV << " GeV");
 
       // Calculate the observables
       size_t   numToward(0),     numAway(0);

Modified: trunk/src/Analyses/CDF_2008_S7540469.cc
==============================================================================
--- trunk/src/Analyses/CDF_2008_S7540469.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2008_S7540469.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -51,8 +51,8 @@
       // Skip if the event is empty
       const FinalState& fs = applyProjection<FinalState>(event, "FS");
       if (fs.empty()) {
-        getLog() << Log::DEBUG << "Skipping event " << event.genEvent().event_number()
-                 << " because no final state pair found " << endl;
+        MSG_DEBUG("Skipping event " << event.genEvent().event_number()
+                 << " because no final state pair found ");
         vetoEvent;
       }
 
@@ -86,8 +86,8 @@
         }
       }
       if (Z_candidates.size() != 1) {
-        getLog() << Log::DEBUG << "Skipping event " << event.genEvent().event_number()
-                 << " because no unique electron pair found " << endl;
+        MSG_DEBUG("Skipping event " << event.genEvent().event_number()
+                 << " because no unique electron pair found ");
         vetoEvent;
       }
 
@@ -131,11 +131,11 @@
           jets_cut.push_back(j);
         }
       }
-      getLog() << Log::DEBUG << "Num jets above 30 GeV = " << jets_cut.size() << endl;
+      MSG_DEBUG("Num jets above 30 GeV = " << jets_cut.size());
 
       // Return if there are no jets:
       if (jets_cut.empty()) {
-        getLog() << Log::DEBUG << "No jets pass cuts " << endl;
+        MSG_DEBUG("No jets pass cuts ");
         vetoEvent;
       }
 

Modified: trunk/src/Analyses/CDF_2008_S7782535.cc
==============================================================================
--- trunk/src/Analyses/CDF_2008_S7782535.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2008_S7782535.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -49,7 +49,7 @@
     void analyze(const Event& event) {
       const Jets& jets = applyProjection<FastJets>(event, "Jets").jets(_ptedges.front()*GeV, _ptedges.back()*GeV,
                                                                        0.0, 0.7, RAPIDITY);
-      getLog() << Log::DEBUG << "Jet multiplicity before any pT cut = " << jets.size() << endl;
+      MSG_DEBUG("Jet multiplicity before any pT cut = " << jets.size());
       if (jets.size() == 0) {
         MSG_DEBUG("No jets found in required pT range");
         vetoEvent;

Modified: trunk/src/Analyses/CDF_2008_S8095620.cc
==============================================================================
--- trunk/src/Analyses/CDF_2008_S8095620.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2008_S8095620.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -99,10 +99,10 @@
 
       // Get jets
       const FastJets& jetpro = applyProjection<FastJets>(event, "Jets");
-      getLog() << Log::DEBUG << "Jet multiplicity before any pT cut = " << jetpro.size() << endl;
+      MSG_DEBUG("Jet multiplicity before any pT cut = " << jetpro.size());
 
       const PseudoJets& jets = jetpro.pseudoJetsByPt();
-      getLog() << Log::DEBUG << "jetlist size = " << jets.size() << endl;
+      MSG_DEBUG("jetlist size = " << jets.size());
 
       int numBJet = 0;
       int numJet  = 0;

Modified: trunk/src/Analyses/CDF_2009_S8057893.cc
==============================================================================
--- trunk/src/Analyses/CDF_2009_S8057893.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2009_S8057893.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -32,9 +32,9 @@
     void CDF_2009_S8057893::analyze(const Event& event) {
       const FastJets& jetpro = applyProjection<FastJets>(e, "MidpointJets");
       const Jets& jets = jetpro.jetsByPt();
-      getLog() << Log::DEBUG << "Jet multiplicity = " << jets.size() << endl;
+      MSG_DEBUG("Jet multiplicity = " << jets.size());
       if (jets.size() < 1) {
-        getLog() << Log::DEBUG << "Failed jet multiplicity cut" << endl;
+        MSG_DEBUG("Failed jet multiplicity cut");
         vetoEvent;
       }
 

Modified: trunk/src/Analyses/CDF_2009_S8383952.cc
==============================================================================
--- trunk/src/Analyses/CDF_2009_S8383952.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2009_S8383952.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -59,7 +59,7 @@
         _h_xs->fill(1960.0, weight);
       }
       else {
-        getLog() << Log::DEBUG << "no unique lepton pair found." << endl;
+        MSG_DEBUG("no unique lepton pair found.");
       }
 
     }

Modified: trunk/src/Analyses/CDF_2010_S8591881_DY.cc
==============================================================================
--- trunk/src/Analyses/CDF_2010_S8591881_DY.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2010_S8591881_DY.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -75,7 +75,7 @@
 
       // Even if we only generate hadronic events, we still need a cut on numCharged >= 2.
       if (numParticles < 1) {
-        getLog() << Log::DEBUG << "Failed multiplicity cut" << endl;
+        MSG_DEBUG("Failed multiplicity cut");
         vetoEvent;
       }
 
@@ -86,7 +86,7 @@
       const ParticleVector& leptons = applyProjection<ChargedLeptons>(e, "CL").chargedLeptons();
 
       // We want exactly two leptons of the same flavour.
-      getLog() << Log::DEBUG << "lepton multiplicity = " << leptons.size() << endl;
+      MSG_DEBUG("lepton multiplicity = " << leptons.size());
       if (leptons.size() != 2 || leptons[0].pdgId() != -leptons[1].pdgId() ) vetoEvent;
 
       // Lepton pT > 20 GeV
@@ -95,8 +95,8 @@
       // Lepton pair should have an invariant mass between 70 and 110 and |eta| < 6
       const FourMomentum dilepton = leptons[0].momentum() + leptons[1].momentum();
       if (!inRange(dilepton.mass()/GeV, 70., 110.) || fabs(dilepton.eta()) >= 6) vetoEvent;
-      getLog() << Log::DEBUG << "Dilepton mass = " << mass(dilepton)/GeV << " GeV" << endl;
-      getLog() << Log::DEBUG << "Dilepton pT   = " << pT(dilepton)/GeV << " GeV" << endl;
+      MSG_DEBUG("Dilepton mass = " << mass(dilepton)/GeV << " GeV");
+      MSG_DEBUG("Dilepton pT   = " << pT(dilepton)/GeV << " GeV");
 
       // Calculate the observables
       size_t   numToward(0),     numAway(0);

Modified: trunk/src/Analyses/CDF_2010_S8591881_QCD.cc
==============================================================================
--- trunk/src/Analyses/CDF_2010_S8591881_QCD.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/CDF_2010_S8591881_QCD.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -73,24 +73,24 @@
 
       const FinalState& fsj = applyProjection<FinalState>(e, "FSJ");
       if (fsj.particles().size() < 1) {
-        getLog() << Log::DEBUG << "Failed multiplicity cut" << endl;
+        MSG_DEBUG("Failed multiplicity cut");
         vetoEvent;
       }
 
       const Jets& jets = applyProjection<FastJets>(e, "MidpointJets").jetsByPt();
-      getLog() << Log::DEBUG << "Jet multiplicity = " << jets.size() << endl;
+      MSG_DEBUG("Jet multiplicity = " << jets.size());
 
       // We require the leading jet to be within |eta|<2
       if (jets.size() < 1 || fabs(jets[0].momentum().eta()) >= 2) {
-        getLog() << Log::DEBUG << "Failed leading jet cut" << endl;
+        MSG_DEBUG("Failed leading jet cut");
         vetoEvent;
       }
 
       const double jetphi = jets[0].momentum().phi();
       const double jeteta = jets[0].momentum().eta();
       const double jetpT  = jets[0].momentum().pT();
-      getLog() << Log::DEBUG << "Leading jet: pT = " << jetpT
-               << ", eta = " << jeteta << ", phi = " << jetphi << endl;
+      MSG_DEBUG("Leading jet: pT = " << jetpT
+                << ", eta = " << jeteta << ", phi = " << jetphi);
 
       // Get the event weight
       const double weight = e.weight();

Modified: trunk/src/Analyses/D0_1996_S3214044.cc
==============================================================================
--- trunk/src/Analyses/D0_1996_S3214044.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/D0_1996_S3214044.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -227,7 +227,7 @@
       double mass2=p.mass2();
       if (mass2>0.0) return sqrt(mass2);
       else if (mass2<-1.0e-5) {
-        getLog() << Log::WARNING << "m2 = " << m2 << ". Assuming m2=0." << endl;
+        MSG_WARNING("m2 = " << m2 << ". Assuming m2=0.");
         return 0.0;
       }
       else return 0.0;

Modified: trunk/src/Analyses/D0_2001_S4674421.cc
==============================================================================
--- trunk/src/Analyses/D0_2001_S4674421.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/D0_2001_S4674421.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -77,7 +77,7 @@
         if (inRange(mass/GeV, 75.0, 105.0)) {
           ++Zcount;
           _eventsFilledZ += weight;
-          //getLog() << Log::DEBUG << "Z #" << Zcount << " pmom.pT() = " << pmom.pT()/GeV << " GeV" << endl;
+          //MSG_DEBUG("Z #" << Zcount << " pmom.pT() = " << pmom.pT()/GeV << " GeV");
           _h_dsigdpt_z->fill(pmom.pT()/GeV, weight);
         }
       } else {
@@ -121,7 +121,7 @@
 
       // Divide and scale ratio histos
       if (xSecW == 0 || wpt_integral == 0 || xSecZ == 0 || zpt_integral == 0) {
-        getLog() << Log::WARN << "Not filling ratio plot because input histos are empty" << endl;
+        MSG_WARNING("Not filling ratio plot because input histos are empty");
       } else {
         std::vector<double> xval;
         std::vector<double> xerr;

Modified: trunk/src/Analyses/D0_2007_S7075677.cc
==============================================================================
--- trunk/src/Analyses/D0_2007_S7075677.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/D0_2007_S7075677.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -48,7 +48,7 @@
         }
       }
       else {
-        getLog() << Log::DEBUG << "No unique lepton pair found." << endl;
+        MSG_DEBUG("No unique lepton pair found.");
       }
     }
 

Modified: trunk/src/Analyses/D0_2008_S7554427.cc
==============================================================================
--- trunk/src/Analyses/D0_2008_S7554427.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/D0_2008_S7554427.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -52,7 +52,7 @@
         }
       }
       else {
-        getLog() << Log::DEBUG << "no unique lepton pair found." << endl;
+        MSG_DEBUG("No unique lepton pair found.");
       }
 
     }

Modified: trunk/src/Analyses/D0_2008_S7662670.cc
==============================================================================
--- trunk/src/Analyses/D0_2008_S7662670.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/D0_2008_S7662670.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -62,7 +62,7 @@
       // Skip if the event is empty
       const FinalState& fs = applyProjection<FinalState>(event, "FS");
       if (fs.empty()) {
-        getLog() << Log::DEBUG << "Empty event!" << endl;
+        MSG_DEBUG("Empty event!");
         vetoEvent;
       }
 
@@ -72,8 +72,8 @@
       foreach (const Jet& j, jetpro.jets(50.0*GeV)) {
         const double pt = j.momentum().pT();
         const double y = fabs(j.momentum().rapidity());
-        getLog() << Log::TRACE << "Filling histos: pT = " << pt/GeV
-            << ", |y| = " << y << endl;
+        MSG_TRACE("Filling histos: pT = " << pt/GeV
+            << ", |y| = " << y);
         if (y < 0.4) {
           _h_dsigdptdy_y00_04->fill(pt/GeV, weight);
         } else if (y < 0.8) {

Modified: trunk/src/Analyses/D0_2008_S7719523.cc
==============================================================================
--- trunk/src/Analyses/D0_2008_S7719523.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/D0_2008_S7719523.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -88,7 +88,7 @@
           econe += p.momentum().E();
           // Veto as soon as E_cone gets larger
           if (econe/egamma > 0.07) {
-            getLog() << Log::DEBUG << "Vetoing event because photon is insufficiently isolated" << endl;
+            MSG_DEBUG("Vetoing event because photon is insufficiently isolated");
             vetoEvent;
           }
         }
@@ -108,8 +108,8 @@
       // Veto if leading jet is outside plotted rapidity regions
       const double abs_y1 = fabs(leadingJet.rapidity());
       if (inRange(abs_y1, 0.8, 1.5) || abs_y1 > 2.5) {
-        getLog() << Log::DEBUG << "Leading jet falls outside acceptance range; |y1| = "
-                 << abs_y1 << endl;
+        MSG_DEBUG("Leading jet falls outside acceptance range; |y1| = "
+                  << abs_y1);
         vetoEvent;
       }
 

Modified: trunk/src/Analyses/D0_2008_S7837160.cc
==============================================================================
--- trunk/src/Analyses/D0_2008_S7837160.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/D0_2008_S7837160.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -54,7 +54,7 @@
     void analyze(const Event & event) {
       const WFinder& wf = applyProjection<WFinder>(event, "WFe");
       if (wf.bosons().size() == 0) {
-        getLog() << Log::DEBUG << "No W candidates found: vetoing" << endl;
+        MSG_DEBUG("No W candidates found: vetoing");
         vetoEvent;
       }
 

Modified: trunk/src/Analyses/D0_2008_S7863608.cc
==============================================================================
--- trunk/src/Analyses/D0_2008_S7863608.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/D0_2008_S7863608.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -68,8 +68,8 @@
 
         // Return if there are no jets:
         if(jets_cut.size()<1) {
-          getLog() << Log::DEBUG << "Skipping event " << e.genEvent().event_number()
-                   << " because no jets pass cuts " << endl;
+          MSG_DEBUG("Skipping event " << e.genEvent().event_number()
+                    << " because no jets pass cuts ");
           vetoEvent;
         }
 

Modified: trunk/src/Analyses/D0_2009_S8202443.cc
==============================================================================
--- trunk/src/Analyses/D0_2009_S8202443.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/D0_2009_S8202443.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -86,7 +86,7 @@
         }
       }
       else {
-        getLog() << Log::DEBUG << "no unique lepton pair found." << endl;
+        MSG_DEBUG("no unique lepton pair found.");
       }
 
 
@@ -114,7 +114,7 @@
         }
       }
       else {
-        getLog() << Log::DEBUG << "no unique lepton pair found." << endl;
+        MSG_DEBUG("no unique lepton pair found.");
         vetoEvent;
       }
     }

Modified: trunk/src/Analyses/D0_2009_S8349509.cc
==============================================================================
--- trunk/src/Analyses/D0_2009_S8349509.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/D0_2009_S8349509.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -82,8 +82,8 @@
 
         // Return if there are no jets:
         if (jets.size() < 1) {
-          getLog() << Log::DEBUG << "Skipping event " << event.genEvent().event_number()
-                   << " because no jets pass cuts " << endl;
+          MSG_DEBUG("Skipping event " << event.genEvent().event_number()
+                    << " because no jets pass cuts ");
           vetoEvent;
         }
 

Modified: trunk/src/Analyses/DELPHI_1995_S3137023.cc
==============================================================================
--- trunk/src/Analyses/DELPHI_1995_S3137023.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/DELPHI_1995_S3137023.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -44,10 +44,10 @@
 
       // Even if we only generate hadronic events, we still need a cut on numCharged >= 2.
       if (numParticles < 2) {
-        getLog() << Log::DEBUG << "Failed leptonic event cut" << endl;
+        MSG_DEBUG("Failed leptonic event cut");
         vetoEvent;
       }
-      getLog() << Log::DEBUG << "Passed leptonic event cut" << endl;
+      MSG_DEBUG("Passed leptonic event cut");
 
       // Get event weight for histo filling
       const double weight = e.weight();
@@ -56,7 +56,7 @@
       const ParticlePair& beams = applyProjection<Beam>(e, "Beams").beams();
       const double meanBeamMom = ( beams.first.momentum().vector3().mod() +
                                    beams.second.momentum().vector3().mod() ) / 2.0;
-      getLog() << Log::DEBUG << "Avg beam momentum = " << meanBeamMom << endl;
+      MSG_DEBUG("Avg beam momentum = " << meanBeamMom);
 
       // Final state of unstable particles to get particle spectra
       const UnstableFinalState& ufs = applyProjection<UnstableFinalState>(e, "UFS");

Modified: trunk/src/Analyses/DELPHI_1996_S3430090.cc
==============================================================================
--- trunk/src/Analyses/DELPHI_1996_S3430090.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/DELPHI_1996_S3430090.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -151,10 +151,10 @@
       const size_t numParticles = fs.particles().size();
       // Even if we only generate hadronic events, we still need a cut on numCharged >= 2.
       if (numParticles < 2) {
-        getLog() << Log::DEBUG << "Failed leptonic event cut" << endl;
+        MSG_DEBUG("Failed leptonic event cut");
         vetoEvent;
       }
-      getLog() << Log::DEBUG << "Passed leptonic event cut" << endl;
+      MSG_DEBUG("Passed leptonic event cut");
       const double weight = e.weight();
       _passedCutWeightSum += weight;
       _weightedTotalPartNum += numParticles * weight;
@@ -163,10 +163,10 @@
       const ParticlePair& beams = applyProjection<Beam>(e, "Beams").beams();
       const double meanBeamMom = ( beams.first.momentum().vector3().mod() +
                                    beams.second.momentum().vector3().mod() ) / 2.0;
-      getLog() << Log::DEBUG << "Avg beam momentum = " << meanBeamMom << endl;
+      MSG_DEBUG("Avg beam momentum = " << meanBeamMom);
 
       // Thrusts
-      getLog() << Log::DEBUG << "Calculating thrust" << endl;
+      MSG_DEBUG("Calculating thrust");
       const Thrust& thrust = applyProjection<Thrust>(e, "Thrust");
       _hist1MinusT->fill(1 - thrust.thrust(), weight);
       _histTMajor->fill(thrust.thrustMajor(), weight);
@@ -193,20 +193,20 @@
       }
 
       // Sphericities
-      getLog() << Log::DEBUG << "Calculating sphericity" << endl;
+      MSG_DEBUG("Calculating sphericity");
       const Sphericity& sphericity = applyProjection<Sphericity>(e, "Sphericity");
       _histSphericity->fill(sphericity.sphericity(), weight);
       _histAplanarity->fill(sphericity.aplanarity(), weight);
       _histPlanarity->fill(sphericity.planarity(), weight);
 
       // C & D params
-      getLog() << Log::DEBUG << "Calculating Parisi params" << endl;
+      MSG_DEBUG("Calculating Parisi params");
       const ParisiTensor& parisi = applyProjection<ParisiTensor>(e, "Parisi");
       _histCParam->fill(parisi.C(), weight);
       _histDParam->fill(parisi.D(), weight);
 
       // Hemispheres
-      getLog() << Log::DEBUG << "Calculating hemisphere variables" << endl;
+      MSG_DEBUG("Calculating hemisphere variables");
       const Hemispheres& hemi = applyProjection<Hemispheres>(e, "Hemispheres");
       _histHemiMassH->fill(hemi.scaledM2high(), weight);
       _histHemiMassL->fill(hemi.scaledM2low(), weight);
@@ -219,7 +219,7 @@
       // Iterate over all the charged final state particles.
       double Evis = 0.0;
       double Evis2 = 0.0;
-      getLog() << Log::DEBUG << "About to iterate over charged FS particles" << endl;
+      MSG_DEBUG("About to iterate over charged FS particles");
       foreach (const Particle& p, fs.particles()) {
         // Get momentum and energy of each particle.
         const Vector3 mom3 = p.momentum().vector3();
@@ -253,7 +253,7 @@
         const double rapidityS = 0.5 * std::log((energy + momS) / (energy - momS));
         _histRapidityT->fill(rapidityT, weight);
         _histRapidityS->fill(rapidityS, weight);
-        //cerr << fabs(rapidityT) << " " << scaledMom/GeV << endl;
+        MSG_TRACE(fabs(rapidityT) << " " << scaledMom/GeV);
       }
       Evis2 = Evis*Evis;
 

Modified: trunk/src/Analyses/DELPHI_2002_069_CONF_603.cc
==============================================================================
--- trunk/src/Analyses/DELPHI_2002_069_CONF_603.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/DELPHI_2002_069_CONF_603.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -47,10 +47,10 @@
 
       // Even if we only generate hadronic events, we still need a cut on numCharged >= 2.
       if (numParticles < 2) {
-        getLog() << Log::DEBUG << "Failed ncharged cut" << endl;
+        MSG_DEBUG("Failed ncharged cut");
         vetoEvent;
       }
-      getLog() << Log::DEBUG << "Passed ncharged cut" << endl;
+      MSG_DEBUG("Passed ncharged cut");
 
       // Get event weight for histo filling
       const double weight = e.weight();
@@ -59,7 +59,7 @@
       const ParticlePair& beams = applyProjection<Beam>(e, "Beams").beams();
       const double meanBeamMom = ( beams.first.momentum().vector3().mod() +
                                    beams.second.momentum().vector3().mod() ) / 2.0;
-      getLog() << Log::DEBUG << "Avg beam momentum = " << meanBeamMom << endl;
+      MSG_DEBUG("Avg beam momentum = " << meanBeamMom);
 
 
       foreach (const GenParticle* p, particles(e.genEvent())) {

Modified: trunk/src/Analyses/DELPHI_2003_WUD_03_11.cc
==============================================================================
--- trunk/src/Analyses/DELPHI_2003_WUD_03_11.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/DELPHI_2003_WUD_03_11.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -113,10 +113,10 @@
 
       // Even if we only generate hadronic events, we still need a cut on numCharged >= 2.
       if (numParticles < 2) {
-        getLog() << Log::DEBUG << "Failed multiplicity cut" << endl;
+        MSG_DEBUG("Failed multiplicity cut");
         vetoEvent;
       }
-      getLog() << Log::DEBUG << "Passed multiplicity cut" << endl;
+      MSG_DEBUG("Passed multiplicity cut");
 
       // Get event weight for histo filling
       const double weight = e.weight();
@@ -162,8 +162,8 @@
       // Normalize inclusive single particle distributions to the average number
       // of charged particles per event.
 
-      getLog() << Log::INFO << "Number of Durham jets = " << _numdurjets << endl;
-      getLog() << Log::INFO << "Number of Jade jets   = " << _numjadejets << endl;
+      MSG_INFO("Number of Durham jets = " << _numdurjets);
+      MSG_INFO("Number of Jade jets   = " << _numjadejets);
 
       /// @todo Scale rather than normalize?
       normalize(_histDurhamBZ      , 0.0785);

Modified: trunk/src/Analyses/H1_1994_S2919893.cc
==============================================================================
--- trunk/src/Analyses/H1_1994_S2919893.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/H1_1994_S2919893.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -70,7 +70,8 @@
 
       // Apply the cuts
       // Lepton energy and angle, w2 and forward energy
-      getLog()<<Log::DEBUG<<"enel/GeV = "<<enel/GeV<<", thel = "<<thel<<", w2 = "<<w2<<", efwd/GeV = "<<efwd/GeV<<std::endl;
+      MSG_DEBUG("enel/GeV = " << enel/GeV << ", thel = " << thel
+                << ", w2 = " << w2 << ", efwd/GeV = " << efwd/GeV);
       bool cut = enel/GeV > 14. && thel > 157. && thel < 172.5 && w2 >= 3000. && efwd/GeV > 0.5;
       if (!cut) vetoEvent;
 

Modified: trunk/src/Analyses/JADE_1998_S3612880.cc
==============================================================================
--- trunk/src/Analyses/JADE_1998_S3612880.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/JADE_1998_S3612880.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -77,7 +77,7 @@
       const Vector3 & thrustAxis = thrust.thrustAxis ();
       double theta = thrustAxis.theta();
       if ( fabs(cos(theta)) >= 0.8 ) {
-        getLog() << Log::DEBUG << "Failed thrust angle cut: " << fabs(cos(theta)) << endl;
+        MSG_DEBUG("Failed thrust angle cut: " << fabs(cos(theta)));
         vetoEvent;
       }
       // TODO Evis, pmiss, pbal

Modified: trunk/src/Analyses/MC_JetAnalysis.cc
==============================================================================
--- trunk/src/Analyses/MC_JetAnalysis.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/MC_JetAnalysis.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -130,8 +130,8 @@
       double m2_i = jets[i].momentum().mass2();
       if (m2_i < 0) {
         if (m2_i < -1e-4) {
-          getLog() << Log::WARNING << "Jet mass2 is negative: " << m2_i << " GeV^2. "
-                   << "Truncating to 0.0, assuming numerical precision is to blame." << endl;
+          MSG_WARNING("Jet mass2 is negative: " << m2_i << " GeV^2. "
+                      << "Truncating to 0.0, assuming numerical precision is to blame.");
         }
         m2_i = 0.0;
       }

Modified: trunk/src/Analyses/MC_LEADINGJETS.cc
==============================================================================
--- trunk/src/Analyses/MC_LEADINGJETS.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/MC_LEADINGJETS.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -50,25 +50,25 @@
 
       const FinalState& fsj = applyProjection<FinalState>(e, "FSJ");
       if (fsj.particles().empty()) {
-        getLog() << Log::DEBUG << "Failed multiplicity cut" << endl;
+        MSG_DEBUG("Failed multiplicity cut");
         vetoEvent;
       }
 
       const FastJets& jetpro = applyProjection<FastJets>(e, "Jets");
       const Jets jets = jetpro.jetsByPt();
-      getLog() << Log::DEBUG << "Jet multiplicity = " << jets.size() << endl;
+      MSG_DEBUG("Jet multiplicity = " << jets.size());
 
       // Require the leading jet to be within |eta| < 2
       if (jets.size() < 1 || fabs(jets[0].momentum().pseudorapidity()) > 2) {
-        getLog() << Log::DEBUG << "Failed jet cut" << endl;
+        MSG_DEBUG("Failed jet cut");
         vetoEvent;
       }
 
       const double jetphi = jets[0].momentum().phi();
       const double jetpT  = jets[0].momentum().pT();
-      getLog() << Log::DEBUG << "Leading jet: pT = " << jetpT/GeV << " GeV"
-               << ", eta = " << jets[0].momentum().pseudorapidity()
-               << ", phi = " << jetphi << endl;
+      MSG_DEBUG("Leading jet: pT = " << jetpT/GeV << " GeV"
+                << ", eta = " << jets[0].momentum().pseudorapidity()
+                << ", phi = " << jetphi);
 
       // Get the event weight
       const double weight = e.weight();

Modified: trunk/src/Analyses/MC_PHOTONJETUE.cc
==============================================================================
--- trunk/src/Analyses/MC_PHOTONJETUE.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/MC_PHOTONJETUE.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -68,9 +68,9 @@
 
       // Get jets
       const Jets jets = applyProjection<FastJets>(evt, "Jets").jetsByPt();
-      getLog() << Log::DEBUG << "Jet multiplicity = " << jets.size() << endl;
+      MSG_DEBUG("Jet multiplicity = " << jets.size());
       if (jets.size() < 1) {
-        getLog() << Log::DEBUG << "No jets found" << endl;
+        MSG_DEBUG("No jets found");
         vetoEvent;
       }
 
@@ -79,20 +79,20 @@
       const double jeteta = pjet.eta();
       const double jetphi = pjet.phi();
       const double jetpT  = pjet.pT();
-      getLog() << Log::DEBUG << "Leading jet: pT = " << jetpT/GeV << " GeV"
+      MSG_DEBUG("Leading jet: pT = " << jetpT/GeV << " GeV"
                << ", eta = " << jeteta
-               << ", phi = " << jetphi << endl;
+               << ", phi = " << jetphi);
 
       // Require the leading jet to be within |eta| < 2
       if (fabs(jeteta) > 2) {
-        getLog() << Log::DEBUG << "Failed leading jet eta cut" << endl;
+        MSG_DEBUG("Failed leading jet eta cut");
         vetoEvent;
       }
 
       // Get the leading photon
       const FinalState& photonfs = applyProjection<FinalState>(evt, "Photons");
       if (photonfs.size() < 1) {
-        getLog() << Log::DEBUG << "No hard photons found" << endl;
+        MSG_DEBUG("No hard photons found");
         vetoEvent;
       }
       const FourMomentum pgamma = photonfs.particlesByPt().front().momentum();
@@ -106,7 +106,7 @@
         }
       }
       if (!isolated) {
-        getLog() << Log::DEBUG << "Leading photon is not isolated from jets" << endl;
+        MSG_DEBUG("Leading photon is not isolated from jets");
         vetoEvent;
       }
 
@@ -114,9 +114,9 @@
       const double gammaeta = pgamma.eta();
       const double gammaphi = pgamma.phi();
       const double gammapT  = pgamma.pT();
-      getLog() << Log::DEBUG << "Leading photon: pT = " << gammapT/GeV << " GeV"
-               << ", eta = " << gammaeta
-               << ", phi = " << gammaphi << endl;
+      MSG_DEBUG("Leading photon: pT = " << gammapT/GeV << " GeV"
+                << ", eta = " << gammaeta
+                << ", phi = " << gammaphi);
 
       // Get the event weight
       const double weight = evt.weight();

Modified: trunk/src/Analyses/MC_SUSY.cc
==============================================================================
--- trunk/src/Analyses/MC_SUSY.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/MC_SUSY.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -110,7 +110,7 @@
     void analyze(const Event& evt) {
       const FinalState& tracks = applyProjection<FinalState>(evt, "Tracks");
       if (tracks.particles().empty()) {
-        getLog() << Log::DEBUG << "Failed multiplicity cut" << endl;
+        MSG_DEBUG("Failed multiplicity cut");
         vetoEvent;
       }
 
@@ -129,7 +129,7 @@
       // Get jets and fill jet histos
       const FastJets& jetpro = applyProjection<FastJets>(evt, "Jets");
       const Jets jets = jetpro.jetsByPt();
-      getLog() << Log::DEBUG << "Jet multiplicity = " << jets.size() << endl;
+      MSG_DEBUG("Jet multiplicity = " << jets.size());
       _hist_n_jet->fill(jets.size(), weight);
       foreach (const Jet& j, jets) {
         const FourMomentum& pj = j.momentum();

Modified: trunk/src/Analyses/OPAL_1993_S2692198.cc
==============================================================================
--- trunk/src/Analyses/OPAL_1993_S2692198.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/OPAL_1993_S2692198.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -32,10 +32,10 @@
 //       const size_t numParticles = cfs.particles().size();
 
 //       if (numParticles < 4) {
-//         getLog() << Log::DEBUG << "Failed ncharged cut" << endl;
+//         MSG_DEBUG("Failed ncharged cut");
 //         vetoEvent;
 //       }
-//       getLog() << Log::DEBUG << "Passed ncharged cut" << endl;
+//       MSG_DEBUG("Passed ncharged cut");
 
       // Get event weight for histo filling
       const double weight = e.weight();

Modified: trunk/src/Analyses/OPAL_1998_S3780481.cc
==============================================================================
--- trunk/src/Analyses/OPAL_1998_S3780481.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/OPAL_1998_S3780481.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -37,10 +37,10 @@
 
       // Even if we only generate hadronic events, we still need a cut on numCharged >= 2.
       if (numParticles < 2) {
-        getLog() << Log::DEBUG << "Failed ncharged cut" << endl;
+        MSG_DEBUG("Failed ncharged cut");
         vetoEvent;
       }
-      getLog() << Log::DEBUG << "Passed ncharged cut" << endl;
+      MSG_DEBUG("Passed ncharged cut");
 
       // Get event weight for histo filling
       const double weight = e.weight();
@@ -50,7 +50,7 @@
       const ParticlePair& beams = applyProjection<Beam>(e, "Beams").beams();
       const double meanBeamMom = ( beams.first.momentum().vector3().mod() +
                                    beams.second.momentum().vector3().mod() ) / 2.0;
-      getLog() << Log::DEBUG << "Avg beam momentum = " << meanBeamMom << endl;
+      MSG_DEBUG("Avg beam momentum = " << meanBeamMom);
 
       int flavour = 0;
       const InitialQuarks& iqf = applyProjection<InitialQuarks>(e, "IQF");

Modified: trunk/src/Analyses/PDG_Hadron_Multiplicities_Ratios.cc
==============================================================================
--- trunk/src/Analyses/PDG_Hadron_Multiplicities_Ratios.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/PDG_Hadron_Multiplicities_Ratios.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -31,15 +31,15 @@
 
       // Even if we only generate hadronic events, we still need a cut on numCharged >= 2.
       if (numParticles < 2) {
-        getLog() << Log::DEBUG << "Failed leptonic event cut" << endl;
+        MSG_DEBUG("Failed leptonic event cut");
         vetoEvent;
       }
-      getLog() << Log::DEBUG << "Passed leptonic event cut" << endl;
+      MSG_DEBUG("Passed leptonic event cut");
 
       // Get event weight for histo filling
       const double weight = e.weight();
 
-      getLog() << Log::DEBUG << "sqrt(S) = " << sqrtS()/GeV << " GeV" << endl;
+      MSG_DEBUG("sqrt(S) = " << sqrtS()/GeV << " GeV");
 
       // Final state of unstable particles to get particle spectra
       const UnstableFinalState& ufs = applyProjection<UnstableFinalState>(e, "UFS");

Modified: trunk/src/Analyses/SFM_1984_S1178091.cc
==============================================================================
--- trunk/src/Analyses/SFM_1984_S1178091.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/SFM_1984_S1178091.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -70,10 +70,9 @@
         if (eta > 0.0) n_right += 1;
         else if (eta < 0.0) n_left += 1;
       }
-      getLog() << Log::DEBUG
-               << "N_left: " << n_left << ", "
-               << "N_right: " << n_right << ", "
-               << "N_large_x: " << n_large_x << endl;
+      MSG_DEBUG("N_left: " << n_left << ", "
+                << "N_right: " << n_right << ", "
+                << "N_large_x: " << n_large_x);
 
       // Not sure about the "=="!
       // @todo Not sure about the "== 1", the paper says no charged particle

Modified: trunk/src/Analyses/STAR_2006_S6500200.cc
==============================================================================
--- trunk/src/Analyses/STAR_2006_S6500200.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/STAR_2006_S6500200.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -45,7 +45,7 @@
       const ChargedFinalState& bbc1 = applyProjection<ChargedFinalState>(event, "BBC1");
       const ChargedFinalState& bbc2 = applyProjection<ChargedFinalState>(event, "BBC2");
       if (bbc1.size()<1 || bbc2.size()<1) {
-        getLog() << Log::DEBUG << "Failed beam-beam-counter trigger" << std::endl;
+        MSG_DEBUG("Failed beam-beam-counter trigger");
         vetoEvent;
       }
 
@@ -94,10 +94,11 @@
       scale(_h_pT_piminus,    1./(2*M_PI*_sumWeightSelected));
       scale(_h_pT_proton,     1./(2*M_PI*_sumWeightSelected));
       scale(_h_pT_antiproton, 1./(2*M_PI*_sumWeightSelected));
-      getLog() << Log::DEBUG << "sumOfWeights()     = " << sumOfWeights() << std::endl;
-      getLog() << Log::DEBUG << "_sumWeightSelected = " << _sumWeightSelected << std::endl;
+      MSG_DEBUG("sumOfWeights()     = " << sumOfWeights());
+      MSG_DEBUG("_sumWeightSelected = " << _sumWeightSelected);
     }
 
+
   private:
 
     double _sumWeightSelected;

Modified: trunk/src/Analyses/STAR_2006_S6860818.cc
==============================================================================
--- trunk/src/Analyses/STAR_2006_S6860818.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/STAR_2006_S6860818.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -54,7 +54,7 @@
       const ChargedFinalState& bbc1 = applyProjection<ChargedFinalState>(event, "BBC1");
       const ChargedFinalState& bbc2 = applyProjection<ChargedFinalState>(event, "BBC2");
       if (bbc1.size()<1 || bbc2.size()<1) {
-        getLog() << Log::DEBUG << "Failed beam-beam-counter trigger" << std::endl;
+        MSG_DEBUG("Failed beam-beam-counter trigger");
         vetoEvent;
       }
 
@@ -175,8 +175,8 @@
       scale(_h_pT_ximinus,   1./(2*M_PI*_sumWeightSelected));
       scale(_h_pT_xiplus,    1./(2*M_PI*_sumWeightSelected));
       //scale(_h_pT_omega,     1./(2*M_PI*_sumWeightSelected));
-      getLog() << Log::DEBUG << "sumOfWeights()     = " << sumOfWeights() << std::endl;
-      getLog() << Log::DEBUG << "_sumWeightSelected = " << _sumWeightSelected << std::endl;
+      MSG_DEBUG("sumOfWeights()     = " << sumOfWeights());
+      MSG_DEBUG("_sumWeightSelected = " << _sumWeightSelected);
     }
 
   private:

Modified: trunk/src/Analyses/STAR_2006_S6870392.cc
==============================================================================
--- trunk/src/Analyses/STAR_2006_S6870392.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/STAR_2006_S6870392.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -42,8 +42,8 @@
       // Skip if the event is empty
       const FinalState& fs = applyProjection<FinalState>(event, "FS");
       if (fs.empty()) {
-        getLog() << Log::DEBUG << "Skipping event " << event.genEvent().event_number()
-                 << " because no final state found " << endl;
+        MSG_DEBUG("Skipping event " << event.genEvent().event_number()
+                  << " because no final state found ");
         vetoEvent;
       }
 

Modified: trunk/src/Analyses/STAR_2008_S7993412.cc
==============================================================================
--- trunk/src/Analyses/STAR_2008_S7993412.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/STAR_2008_S7993412.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -34,8 +34,8 @@
       // Skip if the event is empty
       const FinalState& fs = applyProjection<FinalState>(event, "FS");
       if (fs.empty()) {
-        getLog() << Log::DEBUG << "Skipping event " << event.genEvent().event_number()
-                 << " because no final state found " << endl;
+        MSG_DEBUG("Skipping event " << event.genEvent().event_number()
+                  << " because no final state found ");
         vetoEvent;
       }
 

Modified: trunk/src/Analyses/STAR_2009_UE_HELEN.cc
==============================================================================
--- trunk/src/Analyses/STAR_2009_UE_HELEN.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/STAR_2009_UE_HELEN.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -62,12 +62,12 @@
     void analyze(const Event& e) {
       const FinalState& cfs = applyProjection<ChargedFinalState>(e, "CFS");
       if (cfs.particles().size() < 1) {
-        getLog() << Log::DEBUG << "Failed multiplicity cut" << endl;
+        MSG_DEBUG("Failed multiplicity cut");
         vetoEvent;
       }
 
       const Jets& alljets = applyProjection<FastJets>(e, "AllJets").jetsByPt();
-      getLog() << Log::DEBUG << "Total jet multiplicity = " << alljets.size() << endl;
+      MSG_DEBUG("Total jet multiplicity = " << alljets.size());
 
       // The jet acceptance region is |eta|<(1-R)=0.3  (with R = jet radius)
       // Jets also must have a neutral energy fraction of < 0.7
@@ -82,7 +82,7 @@
       // WARNING: There is more data in preparation, some of which
       //          does _not_ have this constraint!
       if (jets.size() != 2) {
-        getLog() << Log::DEBUG << "Failed jet multiplicity cut" << endl;
+        MSG_DEBUG("Failed jet multiplicity cut");
         vetoEvent;
       }
 
@@ -93,7 +93,7 @@
       if (deltaPhi(jets[0].momentum().phi(), jets[1].momentum().phi()) <= 5*PI/6 ||
           jets[1].momentum().pT()/jets[0].momentum().pT() <= 0.7)
       {
-        getLog() << Log::DEBUG << "Failed di-jet criteria" << endl;
+        MSG_DEBUG("Failed di-jet criteria");
         vetoEvent;
       }
 

Modified: trunk/src/Analyses/TASSO_1990_S2148048.cc
==============================================================================
--- trunk/src/Analyses/TASSO_1990_S2148048.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/TASSO_1990_S2148048.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -86,7 +86,7 @@
       // Condition 1)  --- require at least 5 (4) 'good' tracks
       int nch = cfs.particles().size();
       if ( (int(sqrtS()/GeV) > 27 && nch < 5) || (int(sqrtS()/GeV) <= 27 && nch < 4 ) ) {
-        getLog() << Log::DEBUG << "Failed # good tracks cut: " << nch << endl;
+        MSG_DEBUG("Failed # good tracks cut: " << nch);
         vetoEvent;
       }
       // Condition 2) ---
@@ -97,7 +97,7 @@
         momsum += mom;
       }
       if (momsum <=0.265 * sqrtS()/GeV) {
-        getLog() << Log::DEBUG << "Failed pTsum cut: " << momsum << " < " << 0.265 * sqrtS()/GeV << endl;
+        MSG_DEBUG("Failed pTsum cut: " << momsum << " < " << 0.265 * sqrtS()/GeV);
         vetoEvent;
       }
 
@@ -108,7 +108,7 @@
       //const Vector3 & thrustAxis = thrust.thrustAxis ();
       //double theta = thrustAxis.theta();
       //if ( fabs(cos(theta)) >= 0.8 ) {
-        //getLog() << Log::DEBUG << "Failed thrust angle cut: " << fabs(cos(theta)) << endl;
+        //MSG_DEBUG("Failed thrust angle cut: " << fabs(cos(theta)));
         //vetoEvent;
       //}
 

Modified: trunk/src/Analyses/UA5_1986_S1583476.cc
==============================================================================
--- trunk/src/Analyses/UA5_1986_S1583476.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/UA5_1986_S1583476.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -60,7 +60,7 @@
       const int numP = cfs50.size();
       const int ni = (int)floor(static_cast<float>(numP-2)/10.0);
       const int num_idx = min(ni, (int)_sumWn.size()-1);
-      getLog() << Log::TRACE << "Multiplicity index: " << numP << " charged particles -> #" << num_idx << endl;
+      MSG_TRACE("Multiplicity index: " << numP << " charged particles -> #" << num_idx);
 
       // Update weights
       const double weight = event.weight();
@@ -84,11 +84,11 @@
 
     /// Scale histos
     void finalize() {
-      getLog() << Log::DEBUG << "sumW_NSD,inel = " << _sumWTrigNSD << ", " << _sumWTrig << endl;
+      MSG_DEBUG("sumW_NSD,inel = " << _sumWTrigNSD << ", " << _sumWTrig);
       scale(_hist_eta_nsd, 0.5/_sumWTrigNSD);
       scale(_hist_eta_inelastic, 0.5/_sumWTrig);
       //
-      getLog() << Log::DEBUG << "sumW[n] = " << _sumWn << endl;
+      MSG_DEBUG("sumW[n] = " << _sumWn);
       for (size_t i = 0; i < _hists_eta_nsd.size(); ++i) {
         scale(_hists_eta_nsd[i], 0.5/_sumWn[i]);
       }

Modified: trunk/src/Analyses/ZEUS_2001_S4815815.cc
==============================================================================
--- trunk/src/Analyses/ZEUS_2001_S4815815.cc	Sun Sep 11 11:53:56 2011	(r3347)
+++ trunk/src/Analyses/ZEUS_2001_S4815815.cc	Mon Sep 12 23:42:50 2011	(r3348)
@@ -31,9 +31,9 @@
       addProjection(fs, "FS");
       /// @todo This is the *wrong* jet def: correct it!
       addProjection(FastJets(fs, FastJets::KT, 0.7), "Jets");
-      getLog() << Log::WARN << "This analysis uses the wrong jet definition: the "
+      MSG_WARNING("This analysis uses the wrong jet definition: the "
                << "paper just says 'a cone algorithm was applied to the CAL cells and jets "
-               << "were reconstructed using the energies and positions of these cells'" << endl;
+               << "were reconstructed using the energies and positions of these cells'");
 
       /// @todo This doesn't seem to correspond to the plots in the paper (SPIRES 4730372)
       _histJetEt1 = bookHistogram1D("JetET1", 11, 14.0, 75.0);
@@ -44,7 +44,7 @@
     void analyze(const Event& event) {
       const double weight = event.weight();
       const JetAlg& jets = applyProjection<FastJets>(event, "Jets");
-      getLog() << Log::INFO << "Jet multiplicity = " << jets.size() << endl;
+      MSG_INFO("Jet multiplicity = " << jets.size());
       foreach (const Jet& j, jets.jets()) {
         _histJetEt1->fill(j.momentum().pT(), weight);
       }


More information about the Rivet-svn mailing list