ClosestJetShape Class Reference

Calculate the jet shape. More...

#include <ClosestJetShape.hh>

Inheritance diagram for ClosestJetShape:
Inheritance graph
[legend]
Collaboration diagram for ClosestJetShape:
Collaboration graph
[legend]

List of all members.

Public Member Functions

void clear ()
 Reset projection between events.
double numBins () const
 Number of equidistant radius bins.
double rMin () const
 $ r_\text{min} $ value.
double rMax () const
 $ r_\text{max} $ value.
double interval () const
 Radius interval size.
double diffJetShape (size_t pTbin, size_t rbin) const
double intJetShape (size_t pTbin, size_t rbin) const
double psi (size_t pTbin) const
bool before (const Projection &p) const
virtual const std::set< PdgIdPairbeamPairs () const
virtual std::string name () const
 Get the name of the projection.
ProjectionaddPdgIdPair (PdgId beam1, PdgId beam2)
 Add a colliding beam pair.
LoggetLog () const
 Get a Log object based on the getName() property of the calling projection object.
void setName (const std::string &name)
 Used by derived classes to set their name.
Constructors etc.

Todo:
Review: remove external jet axes, binning, etc.
 ClosestJetShape (const FinalState &fs, const vector< FourMomentum > &jetaxes, double rmin=0.0, double rmax=0.7, double interval=0.1, double r1minPsi=0.3, RapScheme distscheme=RAPIDITY)
 Constructor.
virtual const Projectionclone () const
 Clone on the heap.
Projection "getting" functions

std::set< ConstProjectionPtrgetProjections () const
 Get the contained projections, including recursion.
template<typename PROJ >
const PROJ & getProjection (const std::string &name) const
 Get the named projection, specifying return type via a template argument.
const ProjectiongetProjection (const std::string &name) const
Projection applying functions

template<typename PROJ >
const PROJ & applyProjection (const Event &evt, const PROJ &proj) const
 Apply the supplied projection on event.
template<typename PROJ >
const PROJ & applyProjection (const Event &evt, const Projection &proj) const
 Apply the supplied projection on event.
template<typename PROJ >
const PROJ & applyProjection (const Event &evt, const std::string &name) const
 Apply the named projection on event.

Protected Member Functions

void project (const Event &e)
 Apply the projection to the event.
int compare (const Projection &p) const
 Compare projections.
Cmp< ProjectionmkNamedPCmp (const Projection &otherparent, const std::string &pname) const
Cmp< ProjectionmkPCmp (const Projection &otherparent, const std::string &pname) const
ProjectionHandlergetProjHandler () const
 Get a reference to the ProjectionHandler for this thread.
Projection registration functions

template<typename PROJ >
const PROJ & addProjection (const PROJ &proj, const std::string &name)
const Projection_addProjection (const Projection &proj, const std::string &name)
 Untemplated function to do the work...

Protected Attributes

bool _allowProjReg
 Flag to forbid projection registration in analyses until the init phase.

Private Attributes

const vector< FourMomentum > & _jetaxes
 The jet axes of the jet algorithm projection.
The projected jet shapes

vector< vector< double > > _diffjetshapes
 Jet shape histo.
vector< vector< double > > _intjetshapes
vector< double > _PsiSlot
Jet shape parameters

double _rmin
 Min radius (typically r=0).
double _rmax
 Max radius.
double _interval
 Length of radius interval.
double _r1minPsi
 One minus Psi radius.
RapScheme _distscheme
 Rapidity scheme.
size_t _nbins
 Number of bins.

Friends

class Event
 Event is a friend.
class Cmp< Projection >
 The Cmp specialization for Projection is a friend.
class Projectionhandler

Detailed Description

Calculate the jet shape.

Calculate the differential and integral jet shapes in $P_{\perp}$ for a given set of jet axes each event.

The rapidity scheme ($ \eta $ or $ y $) has to be specified when invoking the constructor.

The differential jet shape around a given jet axis at distance interval $ r \pm \delta{r}/2 $ is defined as

\[ \rho(r) = \frac{1}{\delta r} \frac{1}{N_\mathrm{jets}} \sum_\mathrm{jets} \frac{P_\perp(r - \delta r/2, r+\delta r/2)}{p_\perp(0, R)} \]

with $ 0 \le r \le R $ and $ P_\perp(r_1, r_2) = \sum_{\in [r_1, r_2)} p_\perp $.

The integral jet shape around a given jet axes until distance $ r $ is defined as

\[ \Psi(r) = \frac{1}{N_\mathrm{jets}} \sum_\mathrm{jets} \frac{P_\perp(0, r)}{p_\perp(0, R)} \]

with $ 0 \le r \le R $ and $ P_\perp(r_1, r_2) = \sum_{\in [r_1, r_2)} p_\perp $.

The constructor expects also the equidistant binning in radius $ r $ to produce the jet shape of all bins in a vector and this separately for each jet to allow post-selection.

In this implementation, the jet axes are passed for each event.

Deprecated:
The closest-axis jet shape algorithm is incorrect and should not be used.

Definition at line 49 of file ClosestJetShape.hh.


Constructor & Destructor Documentation

ClosestJetShape ( const FinalState fs,
const vector< FourMomentum > &  jetaxes,
double  rmin = 0.0,
double  rmax = 0.7,
double  interval = 0.1,
double  r1minPsi = 0.3,
RapScheme  distscheme = RAPIDITY 
)

Constructor.

Definition at line 9 of file ClosestJetShape.cc.

References ClosestJetShape::_nbins, ProjectionApplier::addProjection(), and Projection::setName().

Referenced by ClosestJetShape::clone().

00013     : _jetaxes(jetaxes),
00014       _rmin(rmin), _rmax(rmax), _interval(interval),
00015       _r1minPsi(r1minPsi), _distscheme(distscheme)
00016   {
00017     setName("ClosestJetShape");
00018     _nbins = int(round((rmax-rmin)/interval));
00019     addProjection(fs, "FS");
00020   }


Member Function Documentation

const Projection & _addProjection ( const Projection proj,
const std::string &  name 
) [protected, inherited]

Untemplated function to do the work...

Definition at line 33 of file ProjectionApplier.cc.

References ProjectionApplier::_allowProjReg, Log::ERROR, ProjectionApplier::getLog(), ProjectionApplier::getProjHandler(), ProjectionApplier::name(), Projection::name(), and ProjectionHandler::registerProjection().

Referenced by ProjectionApplier::addProjection().

00034                                                                              {
00035     if (!_allowProjReg) {
00036       getLog() << Log::ERROR << "Trying to register projection '"
00037                << proj.name() << "' before init phase in '" << this->name() << "'." << endl;
00038       exit(2);
00039     }
00040     const Projection& reg = getProjHandler().registerProjection(*this, proj, name);
00041     return reg;
00042   }

Projection& addPdgIdPair ( PdgId  beam1,
PdgId  beam2 
) [inline, inherited]

Add a colliding beam pair.

Definition at line 107 of file Projection.hh.

References Projection::_beamPairs.

Referenced by Projection::Projection().

00107                                                        {
00108       _beamPairs.insert(PdgIdPair(beam1, beam2));
00109       return *this;
00110     }

const PROJ& addProjection ( const PROJ &  proj,
const std::string &  name 
) [inline, protected, inherited]

Register a contained projection. The type of the argument is used to instantiate a new projection internally: this new object is applied to events rather than the argument object. Hence you are advised to only use locally-scoped Projection objects in your Projection and Analysis constructors, and to avoid polymorphism (e.g. handling ConcreteProjection via a pointer or reference to type Projection) since this will screw up the internal type management.

Definition at line 130 of file ProjectionApplier.hh.

References ProjectionApplier::_addProjection().

Referenced by ZFinder::_init(), WFinder::_init(), VetoedFinalState::addVetoOnThisFinalState(), CDF_2009_S8057893::CDF_2009_S8057893::init(), CentralEtHCM::CentralEtHCM(), ChargedFinalState::ChargedFinalState(), ChargedLeptons::ChargedLeptons(), ClosestJetShape::ClosestJetShape(), ClusteredPhotons::ClusteredPhotons(), DISKinematics::DISKinematics(), DISLepton::DISLepton(), FinalState::FinalState(), FinalStateHCM::FinalStateHCM(), FoxWolframMoments::FoxWolframMoments(), HadronicFinalState::HadronicFinalState(), Hemispheres::Hemispheres(), IdentifiedFinalState::IdentifiedFinalState(), ZEUS_2001_S4815815::init(), UA5_1989_S1926373::init(), UA5_1988_S1867512::init(), UA5_1987_S1640666::init(), UA5_1986_S1583476::init(), UA5_1982_S875503::init(), UA1_1990_S2044935::init(), STAR_2009_UE_HELEN::init(), STAR_2008_S7993412::init(), STAR_2008_S7869363::init(), STAR_2006_S6870392::init(), STAR_2006_S6860818::init(), STAR_2006_S6500200::init(), SFM_1984_S1178091::init(), PDG_HADRON_MULTIPLICITIES_RATIOS::init(), PDG_HADRON_MULTIPLICITIES::init(), OPAL_2004_S6132243::init(), OPAL_2001_S4553896::init(), OPAL_1998_S3780481::init(), OPAL_1993_S2692198::init(), MC_ZZJETS::init(), MC_ZJETS::init(), MC_WWJETS::init(), MC_WJETS::init(), MC_TTBAR::init(), MC_SUSY::init(), MC_PHOTONJETUE::init(), MC_PHOTONJETS::init(), MC_LEADINGJETS::init(), MC_JETS::init(), MC_HJETS::init(), MC_GENERIC::init(), MC_DIPHOTON::init(), MC_DIJET::init(), LHCB_2010_S8758301::init(), JADE_OPAL_2000_S4300807::init(), H1_2000_S4129130::init(), H1_1995_S3167097::init(), H1_1994_S2919893::init(), ExampleAnalysis::init(), E735_1998_S3905616::init(), DELPHI_2002_069_CONF_603::init(), DELPHI_1995_S3137023::init(), D0_2010_S8671338::init(), D0_2010_S8570965::init(), D0_2010_S8566488::init(), D0_2009_S8349509::init(), D0_2009_S8320160::init(), D0_2009_S8202443::init(), D0_2008_S7863608::init(), D0_2008_S7837160::init(), D0_2008_S7719523::init(), D0_2008_S7662670::init(), D0_2008_S7554427::init(), D0_2008_S6879055::init(), D0_2007_S7075677::init(), D0_2006_S6438750::init(), D0_2004_S5992206::init(), D0_2001_S4674421::init(), D0_2000_S4480767::init(), D0_1998_S3711838::init(), D0_1996_S3324664::init(), D0_1996_S3214044::init(), CDF_2009_S8436959::init(), CDF_2009_S8383952::init(), CDF_2009_S8233977::init(), CDF_2009_NOTE_9936::init(), CDF_2008_S8095620::init(), CDF_2008_S8093652::init(), CDF_2008_S7828950::init(), CDF_2008_S7782535::init(), CDF_2008_S7541902::init(), CDF_2008_S7540469::init(), CDF_2008_NOTE_9351::init(), CDF_2008_LEADINGJETS::init(), CDF_2007_S7057202::init(), CDF_2006_S6653332::init(), CDF_2006_S6450792::init(), CDF_2005_S6217184::init(), CDF_2005_S6080774::init(), CDF_2004_S5839831::init(), CDF_2002_S4796047::init(), CDF_2001_S4751469::init(), CDF_2001_S4563131::init(), CDF_2001_S4517016::init(), CDF_2000_S4266730::init(), CDF_2000_S4155203::init(), CDF_1998_S3618439::init(), CDF_1997_S3541940::init(), CDF_1996_S3418421::init(), CDF_1996_S3349578::init(), CDF_1996_S3108457::init(), CDF_1994_S2952106::init(), CDF_1993_S2742446::init(), CDF_1991_S2313472::init(), CDF_1990_S2089246::init(), CDF_1988_S1865951::init(), BELLE_2006_S6265367::init(), ATLAS_2010_S8817804::init(), ATLAS_2010_S8591806::init(), ATLAS_2010_CONF_2010_083::init(), ATLAS_2010_CONF_2010_081::init(), ATLAS_2010_CONF_2010_049::init(), ATLAS_2010_CONF_2010_031::init(), ALICE_2010_S8706239::init(), ALICE_2010_S8625980::init(), ALICE_2010_S8624100::init(), ALEPH_2004_S5765862::init(), ALEPH_1996_S3486095::init(), ALEPH_1996_S3196992::init(), ALEPH_1991_S2435284::init(), IsolationProjection< PROJ1, PROJ2, EST >::IsolationProjection(), JetAlg::JetAlg(), JetShape::JetShape(), LeadingParticlesFinalState::LeadingParticlesFinalState(), LossyFinalState< ConstRandomFilter >::LossyFinalState(), MergedFinalState::MergedFinalState(), Multiplicity::Multiplicity(), NeutralFinalState::NeutralFinalState(), ParisiTensor::ParisiTensor(), Sphericity::Sphericity(), SVertex::SVertex(), Thrust::Thrust(), TotalVisibleMomentum::TotalVisibleMomentum(), TriggerCDFRun0Run1::TriggerCDFRun0Run1(), TriggerCDFRun2::TriggerCDFRun2(), TriggerUA5::TriggerUA5(), and VetoedFinalState::VetoedFinalState().

00130                                                                        {
00131       const Projection& reg = _addProjection(proj, name);
00132       const PROJ& rtn = dynamic_cast<const PROJ&>(reg);
00133       return rtn;
00134     }

const PROJ& applyProjection ( const Event evt,
const std::string &  name 
) const [inline, inherited]

Apply the named projection on event.

Definition at line 97 of file ProjectionApplier.hh.

References ProjectionApplier::_applyProjection().

00097                                                                                {
00098       return pcast<PROJ>(_applyProjection(evt, name));
00099     }

const PROJ& applyProjection ( const Event evt,
const Projection proj 
) const [inline, inherited]

Apply the supplied projection on event.

Definition at line 90 of file ProjectionApplier.hh.

References ProjectionApplier::_applyProjection().

00090                                                                                 {
00091       return pcast<PROJ>(_applyProjection(evt, proj));
00092     }

const PROJ& applyProjection ( const Event evt,
const PROJ &  proj 
) const [inline, inherited]

Apply the supplied projection on event.

Definition at line 83 of file ProjectionApplier.hh.

References ProjectionApplier::_applyProjection().

Referenced by HadronicFinalState::project(), and FinalStateHCM::project().

00083                                                                           {
00084       return pcast<PROJ>(_applyProjection(evt, proj));
00085     }

const set< PdgIdPair > beamPairs (  )  const [virtual, inherited]

Return the BeamConstraints for this projection, not including recursion. Derived classes should ensure that all contained projections are registered in the _projections set for the beam constraint chaining to work.

Definition at line 39 of file Projection.cc.

References Projection::_beamPairs, Projection::beamPairs(), Projection::getLog(), ProjectionApplier::getProjections(), Rivet::intersection(), and Log::TRACE.

Referenced by Projection::beamPairs().

00039                                                    {
00040     set<PdgIdPair> ret = _beamPairs;
00041     set<ConstProjectionPtr> projs = getProjections();
00042     for (set<ConstProjectionPtr>::const_iterator ip = projs.begin(); ip != projs.end(); ++ip) {
00043       ConstProjectionPtr p = *ip;
00044       getLog() << Log::TRACE << "Proj addr = " << p << endl;
00045       if (p) ret = intersection(ret, p->beamPairs());
00046     }
00047     return ret;
00048   }

bool before ( const Projection p  )  const [inherited]

Determine whether this object should be ordered before the object p given as argument. If p is of a different class than this, the before() function of the corresponding type_info objects is used. Otherwise, if the objects are of the same class, the virtual compare(const Projection &) will be returned.

Definition at line 28 of file Projection.cc.

References Projection::compare().

Referenced by less< const Rivet::Projection * >::operator()().

00028                                                    {
00029     const std::type_info& thisid = typeid(*this);
00030     const std::type_info& otherid = typeid(p);
00031     if (thisid == otherid) {
00032       return compare(p) < 0;
00033     } else {
00034       return thisid.before(otherid);
00035     }
00036   }

void clear (  ) 

Reset projection between events.

Definition at line 31 of file ClosestJetShape.cc.

References ClosestJetShape::_diffjetshapes, ClosestJetShape::_intjetshapes, ClosestJetShape::_jetaxes, ClosestJetShape::_nbins, and ClosestJetShape::_PsiSlot.

Referenced by ClosestJetShape::project().

00031                               {
00032     // Reset vectors for each event
00033     _diffjetshapes.clear();
00034     _intjetshapes.clear();
00035     for (size_t i = 0; i < _jetaxes.size(); ++i) {
00036       const vector<double> tmp(_nbins, 0.0);
00037       _diffjetshapes.push_back(tmp);
00038       _intjetshapes.push_back(tmp);
00039     }
00040     _PsiSlot.clear();
00041     _PsiSlot.resize(_jetaxes.size(), 0.0);
00042   }

virtual const Projection* clone (  )  const [inline, virtual]

Clone on the heap.

Implements Projection.

Definition at line 64 of file ClosestJetShape.hh.

References ClosestJetShape::ClosestJetShape().

00064                                             {
00065       return new ClosestJetShape(*this);
00066     }

int compare ( const Projection p  )  const [protected, virtual]

Compare projections.

Implements Projection.

Definition at line 23 of file ClosestJetShape.cc.

References ClosestJetShape::_jetaxes, Rivet::cmp(), Rivet::EQUIVALENT, and Projection::mkNamedPCmp().

00023                                                         {
00024     PCmp fscmp = mkNamedPCmp(p, "FS");
00025     if (fscmp == EQUIVALENT) return EQUIVALENT;
00026     const ClosestJetShape& other = dynamic_cast<const ClosestJetShape&>(p);
00027     return cmp(&_jetaxes, &other._jetaxes);
00028   }

double diffJetShape ( size_t  pTbin,
size_t  rbin 
) const [inline]

Return value of differential jet shape profile histo bin.

Todo:
Remove this external indexing thing

Definition at line 100 of file ClosestJetShape.hh.

References ClosestJetShape::_diffjetshapes.

00100                                                          {
00101       return _diffjetshapes[pTbin][rbin];
00102     }

Log& getLog (  )  const [inline, inherited]
const Projection& getProjection ( const std::string &  name  )  const [inline, inherited]

Get the named projection (non-templated, so returns as a reference to a Projection base class).

Definition at line 73 of file ProjectionApplier.hh.

References ProjectionHandler::getProjection(), and ProjectionApplier::getProjHandler().

00073                                                                  {
00074       return getProjHandler().getProjection(*this, name);
00075     }

const PROJ& getProjection ( const std::string &  name  )  const [inline, inherited]

Get the named projection, specifying return type via a template argument.

Definition at line 65 of file ProjectionApplier.hh.

References ProjectionHandler::getProjection(), and ProjectionApplier::getProjHandler().

Referenced by ProjectionApplier::_applyProjection(), Rivet::pcmp(), and Hemispheres::project().

00065                                                            {
00066       const Projection& p = getProjHandler().getProjection(*this, name);
00067       return pcast<PROJ>(p);
00068     }

std::set<ConstProjectionPtr> getProjections (  )  const [inline, inherited]

Get the contained projections, including recursion.

Definition at line 58 of file ProjectionApplier.hh.

References ProjectionHandler::DEEP, ProjectionHandler::getChildProjections(), and ProjectionApplier::getProjHandler().

Referenced by Projection::beamPairs().

00058                                                       {
00059       return getProjHandler().getChildProjections(*this, ProjectionHandler::DEEP);
00060     }

ProjectionHandler& getProjHandler (  )  const [inline, protected, inherited]

Get a reference to the ProjectionHandler for this thread.

Definition at line 110 of file ProjectionApplier.hh.

References ProjectionApplier::_projhandler.

Referenced by ProjectionApplier::_addProjection(), ProjectionApplier::getProjection(), ProjectionApplier::getProjections(), and ProjectionApplier::~ProjectionApplier().

00110                                               {
00111       assert(_projhandler);
00112       return *_projhandler;
00113     }

double interval (  )  const [inline]

Radius interval size.

Definition at line 94 of file ClosestJetShape.hh.

References ClosestJetShape::_interval.

00094                             {
00095       return _interval;
00096     }

double intJetShape ( size_t  pTbin,
size_t  rbin 
) const [inline]

Return value of integrated jet shape profile histo bin.

Todo:
Remove this external indexing thing

Definition at line 106 of file ClosestJetShape.hh.

References ClosestJetShape::_intjetshapes.

00106                                                         {
00107       return _intjetshapes[pTbin][rbin];
00108     }

Cmp< Projection > mkNamedPCmp ( const Projection otherparent,
const std::string &  pname 
) const [protected, inherited]
Cmp< Projection > mkPCmp ( const Projection otherparent,
const std::string &  pname 
) const [protected, inherited]

Shortcut to make a named Cmp<Projection> comparison with the *this object automatically passed as one of the parent projections.

Definition at line 57 of file Projection.cc.

References Rivet::pcmp().

00058                                                                 {
00059     return pcmp(*this, otherparent, pname);
00060   }

virtual std::string name (  )  const [inline, virtual, inherited]
double numBins (  )  const [inline]

Number of equidistant radius bins.

Definition at line 79 of file ClosestJetShape.hh.

References ClosestJetShape::_nbins.

00079                            {
00080       return _nbins;
00081     }

void project ( const Event e  )  [protected, virtual]

Apply the projection to the event.

Todo:
Actually use histograms here, rather than doing the binning by hand
Todo:
Calculate int jet shape from diff jet shape histo (YODA)
Todo:
Calculate int [0.0, 0.3] jet shape from diff jet shape histo (YODA)

Implements Projection.

Definition at line 45 of file ClosestJetShape.cc.

References ClosestJetShape::_diffjetshapes, ClosestJetShape::_distscheme, ClosestJetShape::_interval, ClosestJetShape::_intjetshapes, ClosestJetShape::_jetaxes, ClosestJetShape::_nbins, ClosestJetShape::_PsiSlot, ClosestJetShape::_r1minPsi, ClosestJetShape::_rmin, ClosestJetShape::clear(), Rivet::deltaR(), Particle::momentum(), FinalState::particles(), FourMomentum::pT(), and Rivet::TWOPI.

00045                                               {
00046     // Reset for new event
00047     clear();
00048 
00049     if (!_jetaxes.empty()) {
00050       const FinalState& fs = applyProjection<FinalState>(e, "FS");
00051       foreach (const Particle& p, fs.particles()) {
00052         double drad_min = TWOPI;
00053         size_t i_drad_min = 0;
00054 
00055         // Identify "best match" jet axis for this particle
00056         for (size_t j = 0; j < _jetaxes.size(); ++j) {
00057           const double drad = deltaR(_jetaxes[j], p.momentum(), _distscheme);
00058           if (drad < drad_min) {
00059             i_drad_min = j;
00060             drad_min = drad;
00061           }
00062         }
00063 
00064         // Fill diff & int jet shape histos for closest jet axis
00065         /// @todo Actually use histograms here, rather than doing the binning by hand
00066         /// @todo Calculate int jet shape from diff jet shape histo (YODA)
00067         for (size_t i = 0; i < _nbins; ++i) {
00068           if (drad_min < _rmin + (i+1)*_interval) {
00069             _intjetshapes[i_drad_min][i] += p.momentum().pT();
00070             if (drad_min > _rmin + i*_interval) {
00071               _diffjetshapes[i_drad_min][i] += p.momentum().pT()/_interval;
00072             }
00073           }
00074         }
00075 
00076         // Sum pT of closest match jet axes for dr < _r1minPsi
00077         /// @todo Calculate int [0.0, 0.3] jet shape from diff jet shape histo (YODA)
00078         if (drad_min < _r1minPsi) {
00079           _PsiSlot[i_drad_min] += p.momentum().pT();
00080         }
00081 
00082       }
00083 
00084 
00085       // Normalize to total pT
00086       for (size_t j = 0; j < _jetaxes.size(); j++) {
00087         const double psimax = _intjetshapes[j][_nbins-1];
00088         if (psimax > 0.0) {
00089           _PsiSlot[j] /= psimax;
00090           for (size_t i = 0; i < _nbins; ++i) {
00091             _diffjetshapes[j][i] /= psimax;
00092             _intjetshapes[j][i] /= psimax;
00093           }
00094         }
00095       }
00096 
00097 
00098     }
00099   }

double psi ( size_t  pTbin  )  const [inline]

Return value of $ \Psi $ (integrated jet shape) at given radius for a $ p_T $ bin.

Todo:
Remove this external indexing thing

Definition at line 112 of file ClosestJetShape.hh.

References ClosestJetShape::_PsiSlot.

00112                                    {
00113       return _PsiSlot[pTbin];
00114     }

double rMax (  )  const [inline]

$ r_\text{max} $ value.

Definition at line 89 of file ClosestJetShape.hh.

References ClosestJetShape::_rmax.

00089                         {
00090       return _rmax;
00091     }

double rMin (  )  const [inline]

$ r_\text{min} $ value.

Definition at line 84 of file ClosestJetShape.hh.

References ClosestJetShape::_rmin.

00084                         {
00085       return _rmin;
00086     }

void setName ( const std::string &  name  )  [inline, inherited]

Friends And Related Function Documentation

friend class Cmp< Projection > [friend, inherited]

The Cmp specialization for Projection is a friend.

Definition at line 36 of file Projection.hh.

friend class Event [friend, inherited]

Event is a friend.

Definition at line 33 of file Projection.hh.

friend class Projectionhandler [friend, inherited]

Definition at line 38 of file ProjectionApplier.hh.


Member Data Documentation

bool _allowProjReg [protected, inherited]

Flag to forbid projection registration in analyses until the init phase.

Definition at line 157 of file ProjectionApplier.hh.

Referenced by ProjectionApplier::_addProjection(), and Analysis::Analysis().

vector<vector<double> > _diffjetshapes [private]

Jet shape histo.

Definition at line 136 of file ClosestJetShape.hh.

Referenced by ClosestJetShape::clear(), ClosestJetShape::diffJetShape(), and ClosestJetShape::project().

Rapidity scheme.

Definition at line 159 of file ClosestJetShape.hh.

Referenced by ClosestJetShape::project().

double _interval [private]

Length of radius interval.

Definition at line 153 of file ClosestJetShape.hh.

Referenced by ClosestJetShape::interval(), and ClosestJetShape::project().

vector<vector<double> > _intjetshapes [private]
const vector<FourMomentum>& _jetaxes [private]

The jet axes of the jet algorithm projection.

Definition at line 129 of file ClosestJetShape.hh.

Referenced by ClosestJetShape::clear(), ClosestJetShape::compare(), and ClosestJetShape::project().

size_t _nbins [private]
vector<double> _PsiSlot [private]
double _r1minPsi [private]

One minus Psi radius.

Definition at line 156 of file ClosestJetShape.hh.

Referenced by ClosestJetShape::project().

double _rmax [private]

Max radius.

Definition at line 150 of file ClosestJetShape.hh.

Referenced by ClosestJetShape::rMax().

double _rmin [private]

Min radius (typically r=0).

Definition at line 147 of file ClosestJetShape.hh.

Referenced by ClosestJetShape::project(), and ClosestJetShape::rMin().


The documentation for this class was generated from the following files: