Rivet Namespace Reference
Detailed Description
Typedef Documentation
Definition at line 11 of file IsolationTools.hh. Definition at line 13 of file IsolationTools.hh. Typedef for Analysis (smart) pointer. Definition at line 16 of file AnalysisHandler.hh.
Definition at line 23 of file RivetYODA.fhh.
Smart (shared) pointer for handling projections. Definition at line 10 of file Analysis.fhh.
Definition at line 35 of file RivetYODA.fhh.
Definition at line 11 of file Projection.fhh. Rivet::Exception is a synonym for Rivet::Error. Definition at line 19 of file Exceptions.hh.
Definition at line 25 of file RivetYODA.hh.
Definition at line 24 of file RivetYODA.fhh.
Typedef for a collection of histogram format name enums. Definition at line 44 of file HistoFormat.hh.
Typedef for a map of histogram format enums to strings. Definition at line 14 of file HistoFormat.hh.
Typedef for a map of histogram format name strings to enums. Definition at line 18 of file HistoFormat.hh. Definition at line 14 of file MatrixN.hh. Definition at line 15 of file IsolationTools.hh.
Typedef for a pair of Particle objects. Definition at line 20 of file Particle.fhh.
Typedef for a vector of Particle objects. Definition at line 14 of file Particle.fhh.
Typedef for Cmp<Projection>
Typedef for a PDG ID code. Definition at line 29 of file Particle.fhh. Typedef for a pair of particle names. Definition at line 32 of file Particle.fhh.
Definition at line 28 of file RivetYODA.hh.
Definition at line 26 of file RivetYODA.hh.
Definition at line 25 of file RivetYODA.fhh.
Definition at line 9 of file Projection.fhh.
Typedef for Projection (smart) pointer. Definition at line 14 of file ProjectionHandler.hh.
Typedef for a collection of PseudoJets. Definition at line 42 of file FastJets.hh.
Typedef for a collection of bin edges. Definition at line 34 of file RivetYODA.fhh.
Definition at line 27 of file RivetYODA.hh.
Definition at line 26 of file RivetYODA.fhh.
Definition at line 11 of file Vector3.hh.
Definition at line 14 of file Vector4.hh. Enumeration Type Documentation
Enumerate the possible states of a Cmp object. Definition at line 14 of file Cmp.fhh. { UNDEFINED = -2, //< Undefined state. ASC = -1, //< The two corresponding objects are in ascending order. ORDERED = -1, //< The two corresponding objects are ordered. EQUIVALENT = 0, //< The two corresponding objects are equivalent. DESC = 1, //< The two corresponding objects are in descending order. UNORDERED = 1, //< The two corresponding objects are anti-ordered. ANTIORDERED = 1 //< The two corresponding objects are anti-ordered. };
Enumeration of available histogram output formats. Definition at line 11 of file HistoFormat.hh.
Enum for range of Definition at line 62 of file MathHeader.hh. { MINUSPI_PLUSPI, ZERO_2PI };
Represents whether an interval is open (non-inclusive) or closed (inclusive). For example, the interval Definition at line 101 of file MathUtils.hh.
Enum for rapidity variable to be used in calculating Definition at line 59 of file MathHeader.hh. { PSEUDORAPIDITY = 0, ETA = 0, RAPIDITY = 1, YRAP = 1 };
Enum for signs of numbers. Definition at line 56 of file MathHeader.hh. Function Documentation
Definition at line 45 of file Spherocity.cc. References cross(), mod(), s, Vector< N >::size(), Vector3::unit(), Vector3::x(), and Vector3::y(). Referenced by Spherocity::_calcSpherocity(). { // According to the Salam paper, p5, footnote 4, the // axis n that minimises the Spherocity value ALWAYS coincides with the // direction of one of the transverse momentum vectors of the events particles. // Thus we carry out the calculation of Sphero for all particles and pick the // one that yields the smallerst values vector<Vector3> p = perpmomenta; vector<double> sval; // Prepare vector to store unit vector representation of all particle momenta vector<Vector3> units; foreach (const Vector3& p, perpmomenta) { units.push_back(Vector3(p.x(), p.y(), 0.0).unit()); } // Spherocity calculation // // Pick the solution with the smallest spherocity sphero = 99999.; // The outer loop is for iteration over all unit vectors foreach (const Vector3& u, units){ double s =0.0; for (unsigned int k=0 ; k<p.size() ; k++) { s += fabs( p[k].cross(u).mod() ); } if (s < sphero) { sphero = s; saxis = u; } } }
Definition at line 48 of file Thrust.cc. References Vector3::dot(), intpow(), mod(), mod2Cmp(), Rivet::PID::n, sign(), and Vector3::unit(). Referenced by Thrust::_calcThrust(). { // This function implements the iterative algorithm as described in the // Pythia manual. We take eight (four) different starting vectors // constructed from the four (three) leading particles to make sure that // we don't find a local maximum. vector<Vector3> p = momenta; assert(p.size() >= 3); unsigned int n = 3; if (p.size() == 3) n = 3; vector<Vector3> tvec; vector<double> tval; std::sort(p.begin(), p.end(), mod2Cmp); for (int i = 0 ; i < intpow(2, n-1); ++i) { // Create an initial vector from the leading four jets Vector3 foo(0,0,0); int sign = i; for (unsigned int k = 0 ; k < n ; ++k) { (sign % 2) == 1 ? foo += p[k] : foo -= p[k]; sign /= 2; } foo=foo.unit(); // Iterate double diff=999.; while (diff>1e-5) { Vector3 foobar(0,0,0); for (unsigned int k=0 ; k<p.size() ; k++) foo.dot(p[k])>0 ? foobar+=p[k] : foobar-=p[k]; diff=(foo-foobar.unit()).mod(); foo=foobar.unit(); } // Calculate the thrust value for the vector we found t=0.; for (unsigned int k=0 ; k<p.size() ; k++) t+=fabs(foo.dot(p[k])); // Store everything tval.push_back(t); tvec.push_back(foo); } // Pick the solution with the largest thrust t=0.; for (unsigned int i=0 ; i<tvec.size() ; i++) if (tval[i]>t){ t=tval[i]; taxis=tvec[i]; } }
Definition at line 11 of file RivetPaths.cc. Referenced by findAnalysisInfoFile(), findAnalysisLibFile(), findAnalysisPlotFile(), and findAnalysisRefFile(). { //struct stat stFileInfo; foreach (const string& dir, paths) { const string path = dir + "/" + filename; //if (stat(path.c_str(), &stFileInfo) == 0) { if (access(path.c_str(), R_OK) == 0) { return path; } } return ""; }
Definition at line 10 of file Event.cc. Referenced by Event::_geNormAlignment(). { for (HepMC::GenEvent::particle_iterator ip = ge.particles_begin(); ip != ge.particles_end(); ++ip) { const HepMC::FourVector& mom = (*ip)->momentum(); (*ip)->set_momentum(HepMC::FourVector(mom.px(), -mom.py(), -mom.pz(), mom.e())); } for (HepMC::GenEvent::vertex_iterator iv = ge.vertices_begin(); iv != ge.vertices_end(); ++iv) { const HepMC::FourVector& pos = (*iv)->position(); (*iv)->set_position(HepMC::FourVector(pos.x(), -pos.y(), -pos.z(), pos.t())); } }
Reduce any number to the range [-2PI, 2PI]. Achieved by repeated addition or subtraction of 2PI as required. Used to normalise angular measures. Definition at line 367 of file MathUtils.hh. References isZero(), and TWOPI. Referenced by mapAngle0To2Pi(), and mapAngleMPiToPi().
Definition at line 28 of file Logging.cc. Referenced by Log::setLevel(), and Log::setLevels(). { /// @todo Check ordering - "Foo" should come before "Foo.Bar" for (Log::LevelMap::const_iterator lev = defaultLevels.begin(); lev != defaultLevels.end(); ++lev) { for (Log::LogMap::iterator log = existingLogs.begin(); log != existingLogs.end(); ++log) { if (log->first.find(lev->first) == 0) { log->second->setLevel(lev->second); } } } } Definition at line 247 of file Vector3.hh. References Vector< N >::_vec. {
Vector3 result;
result._vec = a._vec + b._vec;
return result;
}
Definition at line 225 of file Vector4.hh. References Vector< N >::_vec. {
FourVector result;
result._vec = a._vec + b._vec;
return result;
}
Definition at line 262 of file MatrixN.hh. References Matrix< N >::_matrix. Referenced by operator+(), operator-(), and subtract(). {
Matrix<N> result;
result._matrix = a._matrix + b._matrix;
return result;
}
Definition at line 516 of file Vector4.hh. References Vector< N >::_vec. {
FourMomentum result;
result._vec = a._vec + b._vec;
return result;
}
Named number-type addition in quadrature operation. Definition at line 167 of file MathUtils.hh. {
return sqrt(a*a + b*b);
}
Named number-type addition in quadrature operation. Definition at line 173 of file MathUtils.hh. {
return sqrt(a*a + b*b + c*c);
}
Set the Rivet analysis plugin library search paths. Definition at line 53 of file RivetPaths.cc. References getAnalysisLibPaths(), and setAnalysisLibPaths(). { vector<string> paths = getAnalysisLibPaths(); paths.push_back(extrapath); setAnalysisLibPaths(paths); }
Angle (in radians) between spatial parts of two Lorentz vectors. Definition at line 246 of file Vector4.hh. References FourVector::angle(). {
return a.angle(b);
}
Angle (in radians) between spatial parts of two Lorentz vectors. Definition at line 251 of file Vector4.hh. References angle(), and FourVector::vector3(). { return angle( a, b.vector3() ); }
Angle (in radians) between spatial parts of two Lorentz vectors. Definition at line 256 of file Vector4.hh. References FourVector::angle(). {
return a.angle(b);
}
Angle (in radians) between two 3-vectors. Definition at line 270 of file Vector3.hh. References Vector3::angle(). Referenced by MC_DIJET::analyze(), angle(), DISKinematics::project(), and Matrix3::setAsRotation(). {
return a.angle(b);
}
Calculate azimuthal angle of a Lorentz vector. Definition at line 287 of file Vector4.hh. References FourVector::azimuthalAngle(). {
return v.azimuthalAngle(mapping);
}
Calculate azimuthal angle of a 3-vector. Returns a number in (-pi, pi] or in [0, 2pi) according to the mapping scheme selected. Definition at line 303 of file Vector3.hh. References Vector3::azimuthalAngle(). Referenced by MC_DIJET::analyze(), CDF_2010_S8591881_DY::analyze(), and CDF_2008_NOTE_9351::analyze(). {
return v.azimuthalAngle(mapping);
}
Function to get beam particle IDs from an event. Definition at line 15 of file Beam.cc. References Beam::beamIds(), and Beam::project(). {
Beam beamproj;
beamproj.project(e);
return beamproj.beamIds();
}
Function to get beam particles from an event. Definition at line 9 of file Beam.cc. References Beam::beams(), and Beam::project(). Referenced by AnalysisHandler::init(), DISLepton::project(), and DISKinematics::project(). {
Beam beamproj;
beamproj.project(e);
return beamproj.beams();
}
Calculate the velocity boost vector of a momentum 4-vector. Definition at line 567 of file Vector4.hh. References FourMomentum::boostVector(). {
return v.boostVector();
}
Definition at line 35 of file ChargedFinalState.cc. References Particle::pdgId(), and Rivet::PID::threeCharge(). Referenced by ChargedFinalState::project(). { return PID::threeCharge(p.pdgId()) == 0; }
Global helper function for easy creation of Cmp objects. Definition at line 285 of file Cmp.hh. Referenced by ConstRandomFilter::compare(), DISFinalState::compare(), IsolationProjection< PROJ1, PROJ2, EST >::compare(), ClusteredPhotons::compare(), NeutralFinalState::compare(), LeptonClusters::compare(), LeadingParticlesFinalState::compare(), InvMassFinalState::compare(), Sphericity::compare(), ZFinder::compare(), IdentifiedFinalState::compare(), FinalState::compare(), WFinder::compare(), JetShape::compare(), VetoedFinalState::compare(), and FastJets::compare(). {
return Cmp<T>(t1, t2);
}
Compare jets by Definition at line 243 of file Jet.hh. References Jet::momentum(), and FourVector::pseudorapidity(). {
return fabs(a.momentum().pseudorapidity()) < fabs(b.momentum().pseudorapidity());
}
Compare jets by Definition at line 265 of file Jet.hh. References Jet::momentum(), and FourMomentum::rapidity(). {
return fabs(a.momentum().rapidity()) < fabs(b.momentum().rapidity());
}
Compare jets by Definition at line 221 of file Jet.hh. References FourMomentum::E(), and Jet::momentum(). {
return a.momentum().E() < b.momentum().E();
}
Compare jets by ascending momentum, Definition at line 199 of file Jet.hh. References Vector< N >::mod(), Jet::momentum(), and FourVector::vector3(). {
return a.momentum().vector3().mod() < b.momentum().vector3().mod();
}
Compare jets by Definition at line 232 of file Jet.hh. References Jet::momentum(), and FourVector::pseudorapidity(). {
return a.momentum().pseudorapidity() < b.momentum().pseudorapidity();
}
Compare jets by Definition at line 190 of file Jet.hh. References Jet::ptSum(). {
return a.ptSum() < b.ptSum();
}
Compare jets by Definition at line 254 of file Jet.hh. References Jet::momentum(), and FourMomentum::rapidity(). {
return a.momentum().rapidity() < b.momentum().rapidity();
}
Compare jets by Definition at line 238 of file Jet.hh. References Jet::momentum(), and FourVector::pseudorapidity(). {
return fabs(a.momentum().pseudorapidity()) > fabs(b.momentum().pseudorapidity());
}
Compare jets by Definition at line 260 of file Jet.hh. References Jet::momentum(), and FourMomentum::rapidity(). {
return fabs(a.momentum().rapidity()) > fabs(b.momentum().rapidity());
}
Compare jets by Definition at line 227 of file Jet.hh. References Jet::momentum(), and FourVector::pseudorapidity(). {
return a.momentum().pseudorapidity() > b.momentum().pseudorapidity();
}
Compare jets by Definition at line 249 of file Jet.hh. References Jet::momentum(), and FourMomentum::rapidity(). {
return a.momentum().rapidity() > b.momentum().rapidity();
}
Compare jets by Definition at line 216 of file Jet.hh. References FourMomentum::E(), and Jet::momentum(). Referenced by JetAlg::jetsByE(). {
return a.momentum().E() > b.momentum().E();
}
Use this so that highest Definition at line 205 of file Jet.hh. References Jet::EtSum(). Referenced by JetAlg::jetsByEt(). {
return a.EtSum() > b.EtSum();
}
Use this so that lowest Definition at line 210 of file Jet.hh. References Jet::EtSum(). {
return a.EtSum() < b.EtSum();
}
Compare jets by descending momentum, Definition at line 195 of file Jet.hh. References Vector< N >::mod(), Jet::momentum(), and FourVector::vector3(). Referenced by JetAlg::jetsByP(). {
return a.momentum().vector3().mod() > b.momentum().vector3().mod();
}
Compare jets by Definition at line 185 of file Jet.hh. References Jet::ptSum(). Referenced by CDF_2008_S7540469::analyze(), and JetAlg::jetsByPt(). {
return a.ptSum() > b.ptSum();
}
Definition at line 47 of file JetAlg.hh. References FourVector::pseudorapidity(). {
return fabs(a.pseudorapidity()) < fabs(b.pseudorapidity());
}
Definition at line 59 of file JetAlg.hh. References FourMomentum::rapidity(). {
return fabs(a.rapidity()) < fabs(b.rapidity());
}
Definition at line 23 of file JetAlg.hh. References Vector< N >::mod(), and FourVector::vector3(). {
return a.vector3().mod() < b.vector3().mod();
}
Definition at line 41 of file JetAlg.hh. References FourVector::pseudorapidity(). {
return a.pseudorapidity() < b.pseudorapidity();
}
Definition at line 53 of file JetAlg.hh. References FourMomentum::rapidity(). {
return a.rapidity() < b.rapidity();
}
Definition at line 44 of file JetAlg.hh. References FourVector::pseudorapidity(). {
return fabs(a.pseudorapidity()) > fabs(b.pseudorapidity());
}
Definition at line 56 of file JetAlg.hh. References FourMomentum::rapidity(). {
return fabs(a.rapidity()) > fabs(b.rapidity());
}
Definition at line 38 of file JetAlg.hh. References FourVector::pseudorapidity(). {
return a.pseudorapidity() > b.pseudorapidity();
}
Definition at line 50 of file JetAlg.hh. References FourMomentum::rapidity(). {
return a.rapidity() > b.rapidity();
}
Definition at line 20 of file JetAlg.hh. References Vector< N >::mod(), and FourVector::vector3(). {
return a.vector3().mod() > b.vector3().mod();
}
Sort by ascending absolute pseudorapidity, Definition at line 180 of file Particle.hh. References Particle::momentum(), and FourVector::pseudorapidity(). Referenced by FinalState::particlesByModEta(). {
return fabs(a.momentum().pseudorapidity()) < fabs(b.momentum().pseudorapidity());
}
Sort by ascending absolute rapidity, Definition at line 196 of file Particle.hh. References Particle::momentum(), and FourMomentum::rapidity(). {
return fabs(a.momentum().rapidity()) < fabs(b.momentum().rapidity());
}
Sort by ascending energy, Definition at line 164 of file Particle.hh. References FourMomentum::E(), and Particle::momentum(). {
return a.momentum().E() < b.momentum().E();
}
Sort by ascending transverse energy, Definition at line 156 of file Particle.hh. References FourMomentum::Et(), and Particle::momentum(). {
return a.momentum().Et() < b.momentum().Et();
}
Sort by ascending momentum, Definition at line 148 of file Particle.hh. References Vector< N >::mod(), Particle::momentum(), and FourVector::vector3(). {
return a.momentum().vector3().mod() < b.momentum().vector3().mod();
}
Sort by ascending pseudorapidity, Definition at line 172 of file Particle.hh. References Particle::momentum(), and FourVector::pseudorapidity(). Referenced by FinalState::particlesByEta(). {
return a.momentum().pseudorapidity() < b.momentum().pseudorapidity();
}
Sort by ascending transverse momentum, Definition at line 140 of file Particle.hh. References Particle::momentum(), and FourMomentum::pT(). {
return a.momentum().pT() < b.momentum().pT();
}
Sort by ascending rapidity, Definition at line 188 of file Particle.hh. References Particle::momentum(), and FourMomentum::rapidity(). {
return a.momentum().rapidity() < b.momentum().rapidity();
}
Sort by descending absolute pseudorapidity, Definition at line 176 of file Particle.hh. References Particle::momentum(), and FourVector::pseudorapidity(). {
return fabs(a.momentum().pseudorapidity()) > fabs(b.momentum().pseudorapidity());
}
Sort by descending absolute rapidity, Definition at line 192 of file Particle.hh. References Particle::momentum(), and FourMomentum::rapidity(). {
return fabs(a.momentum().rapidity()) > fabs(b.momentum().rapidity());
}
Sort by descending pseudorapidity, Definition at line 168 of file Particle.hh. References Particle::momentum(), and FourVector::pseudorapidity(). {
return a.momentum().pseudorapidity() > b.momentum().pseudorapidity();
}
Sort by descending rapidity, Definition at line 184 of file Particle.hh. References Particle::momentum(), and FourMomentum::rapidity(). {
return a.momentum().rapidity() > b.momentum().rapidity();
}
Sort by descending energy, Definition at line 160 of file Particle.hh. References FourMomentum::E(), and Particle::momentum(). Referenced by FinalState::particlesByE(). {
return a.momentum().E() > b.momentum().E();
}
Sort by descending transverse energy, Definition at line 152 of file Particle.hh. References FourMomentum::Et(), and Particle::momentum(). Referenced by FinalState::particlesByEt(). {
return a.momentum().Et() > b.momentum().Et();
}
Sort by descending momentum, Definition at line 144 of file Particle.hh. References Vector< N >::mod(), Particle::momentum(), and FourVector::vector3(). Referenced by FinalState::particlesByP(). {
return a.momentum().vector3().mod() > b.momentum().vector3().mod();
}
Sort by descending transverse momentum, Definition at line 136 of file Particle.hh. References Particle::momentum(), and FourMomentum::pT(). Referenced by D0_2010_S8570965::analyze(), D0_2010_S8821313::analyze(), ATLAS_2012_I1186556::analyze(), ATLAS_2011_S9120807::analyze(), ATLAS_2012_I1180197::analyze(), ATLAS_2011_CONF_2011_090::analyze(), ATLAS_2012_CONF_2012_153::analyze(), ATLAS_2011_S9212353::analyze(), FinalState::particlesByPt(), and ChargedLeptons::project(). {
return a.momentum().pT() > b.momentum().pT();
}
Definition at line 153 of file LorentzTrans.hh. References LorentzTransform::combine(). {
return a.combine(b);
}
Find whether ParticleName p is compatible with the template ParticleName allowed. Effectively this is asking whether p is a subset of allowed. Definition at line 16 of file BeamConstraint.hh. References ANY. Referenced by AnalysisHandler::analyze(), compatible(), and intersection(). { //assert(p != ANY); return (allowed == ANY || p == allowed); }
Find whether PdgIdPair pair is compatible with the template PdgIdPair allowedpair. This assesses whether either of the two possible pairings of pair's constituents is compatible. Definition at line 24 of file BeamConstraint.hh. References compatible(). { bool oneToOne = compatible(pair.first, allowedpair.first); bool twoToTwo = compatible(pair.second, allowedpair.second); bool oneToTwo = compatible(pair.first, allowedpair.second); bool twoToOne = compatible(pair.second, allowedpair.first); return (oneToOne && twoToTwo) || (oneToTwo && twoToOne); }
Check particle compatibility of Particle pairs. Definition at line 34 of file BeamConstraint.hh. References compatible(), and make_pdgid_pair(). { return compatible(make_pdgid_pair(ppair.first.pdgId(), ppair.second.pdgId()), allowedpair); }
Check particle compatibility of Particle pairs (for symmetric completeness) Definition at line 40 of file BeamConstraint.hh. References compatible(). { return compatible(ppair, allowedpair); }
Find whether a PdgIdPair pair is compatible with at least one template beam pair in a set allowedpairs. Definition at line 48 of file BeamConstraint.hh. References compatible(). { for (set<PdgIdPair>::const_iterator bp = allowedpairs.begin(); bp != allowedpairs.end(); ++bp) { if (compatible(pair, *bp)) return true; } return false; }
Contract two 4-vectors, with metric signature (+ - - -). Definition at line 194 of file Vector4.hh. References FourVector::contract(). Referenced by dot(). {
return a.contract(b);
}
Calculate the correlation strength between two samples. Definition at line 326 of file MathUtils.hh. References covariance(). Referenced by correlation_err(), and correlation_helper(). { const double cov = covariance(sample1, sample2); const double var1 = covariance(sample1, sample1); const double var2 = covariance(sample2, sample2); const double correlation = cov/sqrt(var1*var2); const double corr_strength = correlation*sqrt(var2/var1); return corr_strength; }
Calculate the error of the correlation strength between two samples assuming Poissonian errors. Definition at line 336 of file MathUtils.hh. References correlation(), covariance(), and covariance_err(). Referenced by correlation_helper(). { const double cov = covariance(sample1, sample2); const double var1 = covariance(sample1, sample1); const double var2 = covariance(sample2, sample2); const double cov_e = covariance_err(sample1, sample2); const double var1_e = covariance_err(sample1, sample1); const double var2_e = covariance_err(sample2, sample2); // Calculate the correlation const double correlation = cov/sqrt(var1*var2); // Calculate the error on the correlation const double correlation_err = cov_e/sqrt(var1*var2) - cov/(2*pow(3./2., var1*var2)) * (var1_e * var2 + var1 * var2_e); // Calculate the error on the correlation strength const double corr_strength_err = correlation_err*sqrt(var2/var1) + correlation/(2*sqrt(var2/var1)) * (var2_e/var1 - var2*var1_e/pow(2, var2)); return corr_strength_err; }
helper function to fill correlation points into scatter plot Definition at line 13 of file UA5_1988_S1867512.cc. References correlation(), and correlation_err(). Referenced by UA5_1988_S1867512::finalize(). { return Point2D( x, correlation(nf, nb), xerr, correlation_err(nf, nb)/sqrt(sumWPassed) ); }
Calculate the covariance (variance) between two samples. Definition at line 294 of file MathUtils.hh. References mean(). Referenced by correlation(), and correlation_err().
Calculate the error on the covariance (variance) of two samples, assuming poissonian errors. Definition at line 308 of file MathUtils.hh. References mean(), and mean_err(). Referenced by correlation_err(). { const double mean1 = mean(sample1); const double mean2 = mean(sample2); const double mean1_e = mean_err(sample1); const double mean2_e = mean_err(sample2); const size_t N = sample1.size(); double cov_e = 0.0; for (size_t i = 0; i < N; i++) { const double cov_i = (sqrt(sample1[i]) - mean1_e)*(sample2[i] - mean2) + (sample1[i] - mean1)*(sqrt(sample2[i]) - mean2_e); cov_e += cov_i; } if (N > 1) return cov_e/(N-1); else return 0.0; }
Definition at line 221 of file Vector3.hh. References Vector3::cross(). Referenced by _calcS(), Thrust::_calcThrust(), and Matrix3::setAsRotation(). {
return a.cross(b);
}
Definition at line 280 of file Particle.hh. References deltaEta(), and Particle::momentum(). { return deltaEta(p1.momentum(), p2.momentum()); }
Definition at line 284 of file Particle.hh. References deltaEta(), and Particle::momentum(). { return deltaEta(p.momentum(), v); }
Definition at line 288 of file Particle.hh. References deltaEta(), and Particle::momentum(). { return deltaEta(p.momentum(), v); }
Definition at line 292 of file Particle.hh. References deltaEta(), and Particle::momentum(). { return deltaEta(p.momentum(), v); }
Definition at line 296 of file Particle.hh. References deltaEta(), eta(), and Particle::momentum().
Definition at line 300 of file Particle.hh. References deltaEta(), and Particle::momentum(). { return deltaEta(v, p.momentum()); }
Definition at line 304 of file Particle.hh. References deltaEta(), and Particle::momentum(). { return deltaEta(v, p.momentum()); }
Definition at line 308 of file Particle.hh. References deltaEta(), and Particle::momentum(). { return deltaEta(v, p.momentum()); }
Definition at line 312 of file Particle.hh. References deltaEta(), and Particle::momentum().
Calculate the difference in pseudorapidity between two spatial vectors. Definition at line 336 of file Vector3.hh. References deltaEta(), and Vector3::pseudorapidity(). { return deltaEta(a.pseudorapidity(), b.pseudorapidity()); }
Calculate the difference in pseudorapidity between two spatial vectors. Definition at line 341 of file Vector3.hh. References deltaEta(), and Vector3::pseudorapidity(). { return deltaEta(v.pseudorapidity(), eta2); }
Calculate the difference in pseudorapidity between two spatial vectors. Definition at line 346 of file Vector3.hh. References deltaEta(), and Vector3::pseudorapidity(). { return deltaEta(eta1, v.pseudorapidity()); }
Definition at line 368 of file Jet.hh. References Jet::momentum(). Referenced by deltaEta(). { return deltaEta(j1.momentum(), j2.momentum()); }
Definition at line 372 of file Jet.hh. References deltaEta(), Particle::momentum(), and Jet::momentum(). { return deltaEta(j.momentum(), p.momentum()); }
Definition at line 376 of file Jet.hh. References deltaEta(), Particle::momentum(), and Jet::momentum(). { return deltaEta(p.momentum(), j.momentum()); }
Definition at line 380 of file Jet.hh. References deltaEta(), and Jet::momentum(). { return deltaEta(j.momentum(), v); }
Definition at line 384 of file Jet.hh. References deltaEta(), and Jet::momentum(). { return deltaEta(j.momentum(), v); }
Definition at line 388 of file Jet.hh. References deltaEta(), and Jet::momentum(). { return deltaEta(j.momentum(), v); }
Definition at line 392 of file Jet.hh. References deltaEta(), eta(), and Jet::momentum().
Definition at line 396 of file Jet.hh. References deltaEta(), and Jet::momentum(). { return deltaEta(v, j.momentum()); }
Definition at line 400 of file Jet.hh. References deltaEta(), and Jet::momentum(). { return deltaEta(v, j.momentum()); }
Definition at line 404 of file Jet.hh. References deltaEta(), and Jet::momentum(). { return deltaEta(v, j.momentum()); }
Definition at line 408 of file Jet.hh. References deltaEta(), and Jet::momentum().
Calculate the difference between two pseudorapidities, returning the unsigned value. Definition at line 417 of file MathUtils.hh. {
return fabs(eta1 - eta2);
}
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 841 of file Vector4.hh. References deltaEta(), and FourVector::vector3(). { return deltaEta(a.vector3(), b.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 846 of file Vector4.hh. References deltaEta(), and FourVector::vector3(). { return deltaEta(v.vector3(), eta2); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 851 of file Vector4.hh. References deltaEta(), and FourVector::vector3(). { return deltaEta(eta1, v.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 856 of file Vector4.hh. References deltaEta(), and FourVector::vector3(). { return deltaEta(a.vector3(), b.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 861 of file Vector4.hh. References deltaEta(), and FourVector::vector3(). { return deltaEta(v.vector3(), eta2); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 866 of file Vector4.hh. References deltaEta(), and FourVector::vector3(). { return deltaEta(eta1, v.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 871 of file Vector4.hh. References deltaEta(), and FourVector::vector3(). { return deltaEta(a.vector3(), b.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 876 of file Vector4.hh. References deltaEta(), and FourVector::vector3(). { return deltaEta(a.vector3(), b.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 881 of file Vector4.hh. References deltaEta(), and FourVector::vector3(). { return deltaEta(a.vector3(), b); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 886 of file Vector4.hh. References deltaEta(), and FourVector::vector3(). { return deltaEta(a, b.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 891 of file Vector4.hh. References deltaEta(), and FourVector::vector3(). { return deltaEta(a.vector3(), b); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 896 of file Vector4.hh. References deltaEta(), and FourVector::vector3(). { return deltaEta(a, b.vector3()); }
Definition at line 243 of file Particle.hh. References deltaPhi(), and Particle::momentum(). { return deltaPhi(p1.momentum(), p2.momentum()); }
Definition at line 247 of file Particle.hh. References deltaPhi(), and Particle::momentum(). { return deltaPhi(p.momentum(), v); }
Definition at line 251 of file Particle.hh. References deltaPhi(), and Particle::momentum(). { return deltaPhi(p.momentum(), v); }
Definition at line 255 of file Particle.hh. References deltaPhi(), and Particle::momentum(). { return deltaPhi(p.momentum(), v); }
Definition at line 259 of file Particle.hh. References deltaPhi(), Particle::momentum(), and phi().
Definition at line 263 of file Particle.hh. References deltaPhi(), and Particle::momentum(). { return deltaPhi(v, p.momentum()); }
Definition at line 267 of file Particle.hh. References deltaPhi(), and Particle::momentum(). { return deltaPhi(v, p.momentum()); }
Definition at line 271 of file Particle.hh. References deltaPhi(), and Particle::momentum(). { return deltaPhi(v, p.momentum()); }
Definition at line 275 of file Particle.hh. References deltaPhi(), and Particle::momentum().
Definition at line 323 of file Jet.hh. References Jet::momentum(). Referenced by MC_JetAnalysis::analyze(), CMS_2011_S8950903::analyze(), STAR_2008_S7993412::analyze(), MC_DIPHOTON::analyze(), ATLAS_2011_S9002537::analyze(), ATLAS_2011_S8994773::analyze(), CDF_2012_NOTE10874::analyze(), CMS_2011_S8973270::analyze(), CMS_2011_S9215166::analyze(), MC_LEADJETUE::analyze(), CDF_1994_S2952106::analyze(), CMS_2012_I1107658::analyze(), CMS_2011_S9120041::analyze(), D0_2009_S8349509::analyze(), STAR_2009_UE_HELEN::analyze(), D0_2004_S5992206::analyze(), MC_PHOTONJETUE::analyze(), ATLAS_2012_I1183818::analyze(), CDF_2010_S8591881_DY::analyze(), CDF_2010_S8591881_QCD::analyze(), CDF_2008_LEADINGJETS::analyze(), ATLAS_2012_I1126136::analyze(), CDF_2008_NOTE_9351::analyze(), ATLAS_2011_S9120807::analyze(), MC_TTBAR::analyze(), ATLAS_2011_S9212183::analyze(), ATLAS_2011_CONF_2011_098::analyze(), CDF_2001_S4751469::analyze(), ATLAS_2012_I1125961::analyze(), ATLAS_2012_I1095236::analyze(), ATLAS_2012_CONF_2012_109::analyze(), ATLAS_2011_S8983313::analyze(), ATLAS_2012_I1083318::analyze(), ATLAS_2011_CONF_2011_090::analyze(), ATLAS_2010_S8894728::analyze(), ATLAS_2011_I945498::analyze(), ATLAS_2011_S9212353::analyze(), MC_VH2BB::analyze(), ATLAS_2011_S9041966::analyze(), deltaPhi(), and deltaR(). { return deltaPhi(j1.momentum(), j2.momentum()); }
Definition at line 327 of file Jet.hh. References deltaPhi(), Particle::momentum(), and Jet::momentum(). { return deltaPhi(j.momentum(), p.momentum()); }
Definition at line 331 of file Jet.hh. References deltaPhi(), Particle::momentum(), and Jet::momentum(). { return deltaPhi(p.momentum(), j.momentum()); }
Definition at line 335 of file Jet.hh. References deltaPhi(), and Jet::momentum(). { return deltaPhi(j.momentum(), v); }
Definition at line 339 of file Jet.hh. References deltaPhi(), and Jet::momentum(). { return deltaPhi(j.momentum(), v); }
Definition at line 343 of file Jet.hh. References deltaPhi(), and Jet::momentum(). { return deltaPhi(j.momentum(), v); }
Definition at line 347 of file Jet.hh. References deltaPhi(), Jet::momentum(), and phi().
Definition at line 351 of file Jet.hh. References deltaPhi(), and Jet::momentum(). { return deltaPhi(v, j.momentum()); }
Definition at line 355 of file Jet.hh. References deltaPhi(), and Jet::momentum(). { return deltaPhi(v, j.momentum()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 357 of file Vector3.hh. References Vector3::azimuthalAngle(), and deltaPhi(). { return deltaPhi(a.azimuthalAngle(), b.azimuthalAngle()); }
Definition at line 359 of file Jet.hh. References deltaPhi(), and Jet::momentum(). { return deltaPhi(v, j.momentum()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 362 of file Vector3.hh. References Vector3::azimuthalAngle(), and deltaPhi(). { return deltaPhi(v.azimuthalAngle(), phi2); }
Definition at line 363 of file Jet.hh. References deltaPhi(), and Jet::momentum().
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 367 of file Vector3.hh. References Vector3::azimuthalAngle(), and deltaPhi(). { return deltaPhi(phi1, v.azimuthalAngle()); }
Calculate the difference between two angles in radians. Returns in the range [0, PI]. Definition at line 411 of file MathUtils.hh. References mapAngle0ToPi(). { return mapAngle0ToPi(phi1 - phi2); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 776 of file Vector4.hh. References deltaPhi(), and FourVector::vector3(). { return deltaPhi(a.vector3(), b.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 781 of file Vector4.hh. References deltaPhi(), and FourVector::vector3(). { return deltaPhi(v.vector3(), phi2); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 786 of file Vector4.hh. References deltaPhi(), and FourVector::vector3(). { return deltaPhi(phi1, v.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 791 of file Vector4.hh. References deltaPhi(), and FourVector::vector3(). { return deltaPhi(a.vector3(), b.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 796 of file Vector4.hh. References deltaPhi(), and FourVector::vector3(). { return deltaPhi(v.vector3(), phi2); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 801 of file Vector4.hh. References deltaPhi(), and FourVector::vector3(). { return deltaPhi(phi1, v.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 806 of file Vector4.hh. References deltaPhi(), and FourVector::vector3(). { return deltaPhi(a.vector3(), b.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 811 of file Vector4.hh. References deltaPhi(), and FourVector::vector3(). { return deltaPhi(a.vector3(), b.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 816 of file Vector4.hh. References deltaPhi(), and FourVector::vector3(). { return deltaPhi(a.vector3(), b); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 821 of file Vector4.hh. References deltaPhi(), and FourVector::vector3(). { return deltaPhi(a, b.vector3()); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 826 of file Vector4.hh. References deltaPhi(), and FourVector::vector3(). { return deltaPhi(a.vector3(), b); }
Calculate the difference in azimuthal angle between two spatial vectors. Definition at line 831 of file Vector4.hh. References deltaPhi(), and FourVector::vector3(). { return deltaPhi(a, b.vector3()); }
Definition at line 201 of file Particle.hh. References deltaR(), and Particle::momentum(). { return deltaR(p1.momentum(), p2.momentum(), scheme); }
Definition at line 206 of file Particle.hh. References deltaR(), and Particle::momentum(). { return deltaR(p.momentum(), v, scheme); }
Definition at line 211 of file Particle.hh. References deltaR(), and Particle::momentum(). { return deltaR(p.momentum(), v, scheme); }
Definition at line 216 of file Particle.hh. References deltaR(), and Particle::momentum(). { return deltaR(p.momentum(), v); }
Definition at line 220 of file Particle.hh. References deltaR(), eta(), Particle::momentum(), and phi().
Definition at line 224 of file Particle.hh. References deltaR(), and Particle::momentum(). { return deltaR(v, p.momentum(), scheme); }
Definition at line 229 of file Particle.hh. References deltaR(), and Particle::momentum(). { return deltaR(v, p.momentum(), scheme); }
Definition at line 234 of file Particle.hh. References deltaR(), and Particle::momentum(). { return deltaR(v, p.momentum()); }
Definition at line 238 of file Particle.hh. References deltaR(), and Particle::momentum().
Definition at line 271 of file Jet.hh. References Jet::momentum(). Referenced by CDF_2004_S5839831::_calcTransCones(), MC_JetAnalysis::analyze(), D0_2011_I895662::analyze(), ATLAS_2011_S9002537::analyze(), CDF_2005_S6080774::analyze(), MC_DIPHOTON::analyze(), D0_2008_S6879055::analyze(), CDF_1993_S2742446::analyze(), CDF_2008_S7540469::analyze(), CDF_2009_S8436959::analyze(), CMS_2011_S8973270::analyze(), MC_ZJETS::analyze(), MC_HJETS::analyze(), D0_2006_S6438750::analyze(), CDF_1997_S3541940::analyze(), CDF_1994_S2952106::analyze(), D0_2010_S8570965::analyze(), MC_PHOTONJETS::analyze(), MC_PHOTONS::analyze(), MC_WJETS::analyze(), ATLAS_2012_I1082009::analyze(), CDF_2008_S8095620::analyze(), ATLAS_2012_I946427::analyze(), CDF_2006_S6653332::analyze(), MC_PHOTONJETUE::analyze(), D0_1996_S3214044::analyze(), ATLAS_2012_CONF_2012_104::analyze(), ATLAS_2012_I1190891::analyze(), D0_2008_S7719523::analyze(), ATLAS_2012_I1126136::analyze(), ATLAS_2012_I1186556::analyze(), MC_TTBAR::analyze(), ATLAS_2011_S9120807::analyze(), ATLAS_2011_S9212183::analyze(), ATLAS_2012_CONF_2012_105::analyze(), CDF_1996_S3349578::analyze(), ATLAS_2011_CONF_2011_098::analyze(), ATLAS_2010_S8914702::analyze(), ATLAS_2012_I1112263::analyze(), ATLAS_2012_CONF_2012_103::analyze(), ATLAS_2012_I1125961::analyze(), MC_ZZJETS::analyze(), ATLAS_2012_I1095236::analyze(), ATLAS_2012_I1117704::analyze(), MC_WWJETS::analyze(), ATLAS_2012_CONF_2012_001::analyze(), ATLAS_2012_CONF_2012_109::analyze(), ATLAS_2012_I1180197::analyze(), ATLAS_2011_S8983313::analyze(), ATLAS_2012_I1083318::analyze(), ATLAS_2011_S9019561::analyze(), ATLAS_2011_CONF_2011_090::analyze(), ATLAS_2010_S8919674::analyze(), ATLAS_2012_CONF_2012_153::analyze(), ATLAS_2011_I945498::analyze(), MC_SUSY::analyze(), ATLAS_2011_S9212353::analyze(), ATLAS_2012_I943401::analyze(), ATLAS_2011_S9225137::analyze(), MC_VH2BB::analyze(), ATLAS_2011_S9041966::analyze(), ATLAS_2012_I1093738::analyze(), ATLAS_2012_I1094568::analyze(), CDF_2004_S5839831::analyze(), JetShape::calc(), deltaR(), ClusteredPhotons::project(), LeptonClusters::project(), and ATLAS_2011_I945498::selectJets(). { return deltaR(j1.momentum(), j2.momentum(), scheme); }
Definition at line 276 of file Jet.hh. References deltaR(), Particle::momentum(), and Jet::momentum(). { return deltaR(j.momentum(), p.momentum(), scheme); }
Definition at line 281 of file Jet.hh. References deltaR(), Particle::momentum(), and Jet::momentum(). { return deltaR(p.momentum(), j.momentum(), scheme); }
Definition at line 286 of file Jet.hh. References deltaR(), and Jet::momentum(). { return deltaR(j.momentum(), v, scheme); }
Definition at line 291 of file Jet.hh. References deltaR(), and Jet::momentum(). { return deltaR(j.momentum(), v, scheme); }
Definition at line 296 of file Jet.hh. References deltaR(), and Jet::momentum(). { return deltaR(j.momentum(), v); }
Definition at line 304 of file Jet.hh. References deltaR(), and Jet::momentum(). { return deltaR(v, j.momentum(), scheme); }
Definition at line 309 of file Jet.hh. References deltaR(), and Jet::momentum(). { return deltaR(v, j.momentum(), scheme); }
Definition at line 314 of file Jet.hh. References deltaR(), and Jet::momentum(). { return deltaR(v, j.momentum()); }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between two spatial vectors. Definition at line 378 of file Vector3.hh. References Vector3::azimuthalAngle(), deltaR(), and Vector3::pseudorapidity(). { return deltaR(a.pseudorapidity(), a.azimuthalAngle(), b.pseudorapidity(), b.azimuthalAngle()); }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between two spatial vectors. Definition at line 384 of file Vector3.hh. References Vector3::azimuthalAngle(), deltaR(), and Vector3::pseudorapidity(). { return deltaR(v.pseudorapidity(), v.azimuthalAngle(), eta2, phi2); }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between two spatial vectors. Definition at line 389 of file Vector3.hh. References Vector3::azimuthalAngle(), deltaR(), and Vector3::pseudorapidity(). { return deltaR(eta1, phi1, v.pseudorapidity(), v.azimuthalAngle()); }
Calculate the distance between two points in 2D rapidity-azimuthal ("\f$ \eta-\phi \f$") space. The phi values are given in radians. Definition at line 423 of file MathUtils.hh. References deltaPhi(), and sqr().
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between two four-vectors. There is a scheme ambiguity for momentum-type four vectors as to whether the pseudorapidity (a purely geometric concept) or the rapidity (a relativistic energy-momentum quantity) is to be used: this can be chosen via the optional scheme parameter. Use of this scheme option is discouraged in this case since Definition at line 585 of file Vector4.hh. References deltaR(), PSEUDORAPIDITY, RAPIDITY, and FourVector::vector3(). { switch (scheme) { case PSEUDORAPIDITY : return deltaR(a.vector3(), b.vector3()); case RAPIDITY: { const FourMomentum* ma = dynamic_cast<const FourMomentum*>(&a); const FourMomentum* mb = dynamic_cast<const FourMomentum*>(&b); if (!ma || !mb) { string err = "deltaR with scheme RAPIDITY can only be called with FourMomentum objects, not FourVectors"; throw std::runtime_error(err); } return deltaR(*ma, *mb, scheme); } default: throw std::runtime_error("The specified deltaR scheme is not yet implemented"); } }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between two four-vectors. There is a scheme ambiguity for momentum-type four vectors as to whether the pseudorapidity (a purely geometric concept) or the rapidity (a relativistic energy-momentum quantity) is to be used: this can be chosen via the optional scheme parameter. Definition at line 611 of file Vector4.hh. References deltaR(), PSEUDORAPIDITY, RAPIDITY, and FourVector::vector3(). { switch (scheme) { case PSEUDORAPIDITY : return deltaR(v.vector3(), eta2, phi2); case RAPIDITY: { const FourMomentum* mv = dynamic_cast<const FourMomentum*>(&v); if (!mv) { string err = "deltaR with scheme RAPIDITY can only be called with FourMomentum objects, not FourVectors"; throw std::runtime_error(err); } return deltaR(*mv, eta2, phi2, scheme); } default: throw std::runtime_error("The specified deltaR scheme is not yet implemented"); } }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between two four-vectors. There is a scheme ambiguity for momentum-type four vectors as to whether the pseudorapidity (a purely geometric concept) or the rapidity (a relativistic energy-momentum quantity) is to be used: this can be chosen via the optional scheme parameter. Definition at line 637 of file Vector4.hh. References deltaR(), PSEUDORAPIDITY, RAPIDITY, and FourVector::vector3(). { switch (scheme) { case PSEUDORAPIDITY : return deltaR(eta1, phi1, v.vector3()); case RAPIDITY: { const FourMomentum* mv = dynamic_cast<const FourMomentum*>(&v); if (!mv) { string err = "deltaR with scheme RAPIDITY can only be called with FourMomentum objects, not FourVectors"; throw std::runtime_error(err); } return deltaR(eta1, phi1, *mv, scheme); } default: throw std::runtime_error("The specified deltaR scheme is not yet implemented"); } }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between two four-vectors. There is a scheme ambiguity for momentum-type four vectors as to whether the pseudorapidity (a purely geometric concept) or the rapidity (a relativistic energy-momentum quantity) is to be used: this can be chosen via the optional scheme parameter. Definition at line 663 of file Vector4.hh. References FourVector::azimuthalAngle(), deltaR(), PSEUDORAPIDITY, RAPIDITY, FourMomentum::rapidity(), and FourVector::vector3(). { switch (scheme) { case PSEUDORAPIDITY: return deltaR(a.vector3(), b.vector3()); case RAPIDITY: return deltaR(a.rapidity(), a.azimuthalAngle(), b.rapidity(), b.azimuthalAngle()); default: throw std::runtime_error("The specified deltaR scheme is not yet implemented"); } }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between two four-vectors. There is a scheme ambiguity for momentum-type four vectors as to whether the pseudorapidity (a purely geometric concept) or the rapidity (a relativistic energy-momentum quantity) is to be used: this can be chosen via the optional scheme parameter. Definition at line 680 of file Vector4.hh. References FourVector::azimuthalAngle(), deltaR(), PSEUDORAPIDITY, RAPIDITY, FourMomentum::rapidity(), and FourVector::vector3(). { switch (scheme) { case PSEUDORAPIDITY: return deltaR(v.vector3(), eta2, phi2); case RAPIDITY: return deltaR(v.rapidity(), v.azimuthalAngle(), eta2, phi2); default: throw std::runtime_error("The specified deltaR scheme is not yet implemented"); } }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between two four-vectors. There is a scheme ambiguity for momentum-type four vectors as to whether the pseudorapidity (a purely geometric concept) or the rapidity (a relativistic energy-momentum quantity) is to be used: this can be chosen via the optional scheme parameter. Definition at line 699 of file Vector4.hh. References FourVector::azimuthalAngle(), deltaR(), PSEUDORAPIDITY, RAPIDITY, FourMomentum::rapidity(), and FourVector::vector3(). { switch (scheme) { case PSEUDORAPIDITY: return deltaR(eta1, phi1, v.vector3()); case RAPIDITY: return deltaR(eta1, phi1, v.rapidity(), v.azimuthalAngle()); default: throw std::runtime_error("The specified deltaR scheme is not yet implemented"); } }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between two four-vectors. There is a scheme ambiguity for momentum-type four vectors as to whether the pseudorapidity (a purely geometric concept) or the rapidity (a relativistic energy-momentum quantity) is to be used: this can be chosen via the optional scheme parameter. Definition at line 717 of file Vector4.hh. References FourVector::azimuthalAngle(), deltaR(), PSEUDORAPIDITY, RAPIDITY, FourMomentum::rapidity(), and FourVector::vector3(). { switch (scheme) { case PSEUDORAPIDITY: return deltaR(a.vector3(), b.vector3()); case RAPIDITY: return deltaR(a.rapidity(), a.azimuthalAngle(), FourMomentum(b).rapidity(), b.azimuthalAngle()); default: throw std::runtime_error("The specified deltaR scheme is not yet implemented"); } }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between two four-vectors. There is a scheme ambiguity for momentum-type four vectors as to whether the pseudorapidity (a purely geometric concept) or the rapidity (a relativistic energy-momentum quantity) is to be used: this can be chosen via the optional scheme parameter. Definition at line 734 of file Vector4.hh. References FourVector::azimuthalAngle(), deltaR(), PSEUDORAPIDITY, RAPIDITY, FourMomentum::rapidity(), rapidity(), and FourVector::vector3(). { switch (scheme) { case PSEUDORAPIDITY: return deltaR(a.vector3(), b.vector3()); case RAPIDITY: return deltaR(FourMomentum(a).rapidity(), a.azimuthalAngle(), b.rapidity(), b.azimuthalAngle()); default: throw std::runtime_error("The specified deltaR scheme is not yet implemented"); } }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between a three-vector and a four-vector. Definition at line 748 of file Vector4.hh. References deltaR(), and FourVector::vector3(). { return deltaR(a.vector3(), b); }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between a three-vector and a four-vector. Definition at line 754 of file Vector4.hh. References deltaR(), and FourVector::vector3(). { return deltaR(a, b.vector3()); }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between a three-vector and a four-vector. Definition at line 760 of file Vector4.hh. References deltaR(), and FourVector::vector3(). { return deltaR(a.vector3(), b); }
Calculate the 2D rapidity-azimuthal ("eta-phi") distance between a three-vector and a four-vector. Definition at line 766 of file Vector4.hh. References deltaR(), and FourVector::vector3(). { return deltaR(a, b.vector3()); }
Definition at line 353 of file MatrixN.hh. { return m.determinant(); }
Diagonalize an NxN matrix, returning a collection of pairs of eigenvalues and eigenvectors, ordered decreasing in eigenvalue. Definition at line 112 of file MatrixDiag.hh. References EigenSystem< N >::_eigenPairs, Rivet::PID::A(), Matrix< N >::get(), and Vector< N >::set(). Referenced by FParameter::_calcFParameter(), and Sphericity::_calcSphericity(). { EigenSystem<N> esys; // Make a GSL matrix. gsl_matrix* A = gsl_matrix_alloc(N, N); for (size_t i = 0; i < N; ++i) { for (size_t j = 0; j < N; ++j) { gsl_matrix_set(A, i, j, m.get(i, j)); } } // Use GSL diagonalization. gsl_matrix* vecs = gsl_matrix_alloc(N, N); gsl_vector* vals = gsl_vector_alloc(N); gsl_eigen_symmv_workspace* workspace = gsl_eigen_symmv_alloc(N); gsl_eigen_symmv(A, vals, vecs, workspace); gsl_eigen_symmv_sort(vals, vecs, GSL_EIGEN_SORT_VAL_DESC); // Build the vector of "eigen-pairs". typename EigenSystem<N>::EigenPairs eigensolns; for (size_t i = 0; i < N; ++i) { typename EigenSystem<N>::EigenPair ep; ep.first = gsl_vector_get(vals, i); Vector<N> ev; for (size_t j = 0; j < N; ++j) { ev.set(j, gsl_matrix_get(vecs, j, i)); } ep.second = ev; eigensolns.push_back(ep); } // Free GSL memory. gsl_eigen_symmv_free(workspace); gsl_matrix_free(A); gsl_matrix_free(vecs); gsl_vector_free(vals); // Populate the returned object. esys._eigenPairs = eigensolns; return esys; }
Contract two 4-vectors, with metric signature (+ - - -). Definition at line 199 of file Vector4.hh. References contract(). { return contract(a, b); }
Definition at line 217 of file Vector3.hh. References Vector3::dot(). Referenced by Thrust::_calcThrust(), D0_1996_S3214044::_fourJetAnalysis(), SLD_2004_S5693039::analyze(), SLD_1999_S3743934::analyze(), ALEPH_1996_S3486095::analyze(), ALEPH_2004_S5765862::analyze(), DELPHI_1996_S3430090::analyze(), DISKinematics::project(), and Hemispheres::project(). {
return a.dot(b);
}
Calculate the transverse energy Definition at line 562 of file Vector4.hh. References FourMomentum::Et(). Referenced by H1_2000_S4129130::analyze(), H1_1994_S2919893::analyze(), CDF_1996_S3108457::analyze(), CDF_1997_S3541940::analyze(), ATLAS_2012_I946427::analyze(), and CDF_1996_S3349578::analyze(). {
return v.Et();
}
Calculate the transverse energy squared, Definition at line 558 of file Vector4.hh. References FourMomentum::Et2(). {
return v.Et2();}
Synonym for pseudorapidity. Definition at line 310 of file Vector4.hh. References FourVector::eta(). {
return v.eta();
}
Synonym for pseudorapidity. Definition at line 325 of file Vector3.hh. References Vector3::eta(). Referenced by FinalState::accept(), H1_2000_S4129130::analyze(), CMS_2011_S8950903::analyze(), CMS_2010_S8656010::analyze(), CMS_2011_S8957746::analyze(), H1_1994_S2919893::analyze(), UA5_1982_S875503::analyze(), CMS_2010_S8547297::analyze(), D0_1996_S3324664::analyze(), CDF_2001_S4563131::analyze(), CDF_1990_S2089246::analyze(), CMS_2011_S9215166::analyze(), SFM_1984_S1178091::analyze(), ALICE_2010_S8625980::analyze(), CDF_1997_S3541940::analyze(), UA5_1986_S1583476::analyze(), CMS_2011_S8884919::analyze(), UA1_1990_S2044935::analyze(), ATLAS_2012_I1183818::analyze(), CDF_2010_S8591881_QCD::analyze(), CDF_2008_LEADINGJETS::analyze(), MC_GENERIC::analyze(), ATLAS_2011_S9120807::analyze(), MC_TTBAR::analyze(), ATLAS_2010_S8914702::analyze(), ATLAS_2012_I1112263::analyze(), ATLAS_2012_I1095236::analyze(), ATLAS_2012_CONF_2012_001::analyze(), ATLAS_2012_I1180197::analyze(), ATLAS_2012_I943401::analyze(), ATLAS_2012_I1093738::analyze(), deltaEta(), deltaR(), ATLAS_2011_S9120807::getEtaBin(), ATLAS_2010_S8914702::getEtaBin(), ATLAS_2012_I1093738::getEtaBin(), ATLAS_2012_I1091481::getSeta(), TriggerCDFRun0Run1::project(), TriggerCDFRun2::project(), InitialQuarks::project(), and TriggerUA5::project(). {
return v.eta();
}
Find the first file of the given name in the analysis info file search dirs.
Definition at line 114 of file RivetPaths.cc. References _findFile(), and getAnalysisInfoPaths(). Referenced by AnalysisInfo::make(). { const vector<string> paths = pathprepend + getAnalysisInfoPaths() + pathappend; return _findFile(filename, paths); }
Find the first file of the given name in the analysis library search dirs.
Definition at line 72 of file RivetPaths.cc. References _findFile(), and getAnalysisLibPaths(). { return _findFile(filename, getAnalysisLibPaths()); }
Find the first file of the given name in the analysis plot file search dirs.
Definition at line 136 of file RivetPaths.cc. References _findFile(), and getAnalysisPlotPaths(). { const vector<string> paths = pathprepend + getAnalysisPlotPaths() + pathappend; return _findFile(filename, paths); }
Find the first file of the given name in the ref data file search dirs.
Definition at line 92 of file RivetPaths.cc. References _findFile(), and getAnalysisRefPaths(). Referenced by getDatafilePath(). { const vector<string> paths = pathprepend + getAnalysisRefPaths() + pathappend; return _findFile(filename, paths); }
Compare two floating point numbers for equality with a degree of fuzziness. The tolerance parameter is fractional, based on absolute values of the args. Definition at line 34 of file MathUtils.hh. References isZero(). Referenced by Sphericity::_calcSphericity(), Cmp< double >::_compare(), BABAR_2007_S6895344::analyze(), BELLE_2006_S6265367::analyze(), BABAR_2005_S6181155::analyze(), CMS_2011_S9215166::analyze(), ALICE_2010_S8625980::analyze(), CMS_2011_S9120041::analyze(), UA1_1990_S2044935::analyze(), ATLAS_2012_I1084540::analyze(), ATLAS_2010_S8894728::analyze(), ATLAS_2010_S8918562::analyze(), ALEPH_2004_S5765862::analyze(), CDF_2004_S5839831::analyze(), AnalysisHandler::analyze(), Vector3::angle(), Sphericity::compare(), ALICE_2010_S8625980::finalize(), CMS_2011_S9120041::finalize(), UA1_1990_S2044935::finalize(), ATLAS_2010_S8918562::finalize(), ALEPH_2004_S5765862::finalize(), CDF_2004_S5839831::finalize(), fuzzyEquals(), fuzzyGtrEquals(), fuzzyLessEquals(), OPAL_2004_S6132243::getHistIndex(), ATLAS_2010_S8894728::init(), CMS_2010_S8547297::init(), ATLAS_2011_S8994773::init(), CMS_2011_S8884919::init(), CMS_2011_S9215166::init(), CDF_2012_NOTE10874::init(), CMS_2011_S9120041::init(), CMS_QCD_10_024::init(), SFM_1984_S1178091::init(), UA5_1989_S1926373::init(), CDF_1988_S1865951::init(), ATLAS_2012_I1091481::init(), UA5_1986_S1583476::init(), CDF_1990_S2089246::init(), UA1_1990_S2044935::init(), ALICE_2010_S8624100::init(), ALICE_2010_S8625980::init(), ATLAS_2011_I944826::init(), UA5_1988_S1867512::init(), ATLAS_2010_S8918562::init(), LHCB_2011_I917009::init(), CDF_2004_S5839831::init(), ALEPH_1996_S3196992::particleInJet(), and Run::readEvent().
Compare two integral-type numbers for equality with a degree of fuzziness. Since there is no risk of floating point error with integral types, this function just exists in case Definition at line 49 of file MathUtils.hh. {
return a == b;
}
Compare two vectors by index, allowing for numerical precision. Definition at line 189 of file VectorN.hh. References fuzzyEquals(), and Vector< N >::get(). { for (size_t i = 0; i < N; ++i) { const double a = va.get(i); const double b = vb.get(i); if (!Rivet::fuzzyEquals(a, b, tolerance)) return false; } return true; }
Compare two matrices by index, allowing for numerical precision. Definition at line 397 of file MatrixN.hh. References fuzzyEquals(), and Matrix< N >::get(). { for (size_t i = 0; i < N; ++i) { for (size_t j = 0; j < N; ++j) { const double a = ma.get(i, j); const double b = mb.get(i, j); if (!Rivet::fuzzyEquals(a, b, tolerance)) return false; } } return true; }
Compare two floating point numbers for >= with a degree of fuzziness. The tolerance parameter on the equality test is as for Definition at line 57 of file MathUtils.hh. References fuzzyEquals(). Referenced by inRange(). { return a > b || fuzzyEquals(a, b, tolerance); }
Compare two integral-type numbers for >= with a degree of fuzziness. Since there is no risk of floating point error with integral types, this function just exists in case Definition at line 68 of file MathUtils.hh. {
return a >= b;
}
Compare two floating point numbers for <= with a degree of fuzziness. The tolerance parameter on the equality test is as for Definition at line 76 of file MathUtils.hh. References fuzzyEquals(). Referenced by ATLAS_2010_S8894728::_moments_to_stddev(), and inRange(). { return a < b || fuzzyEquals(a, b, tolerance); }
Compare two integral-type numbers for <= with a degree of fuzziness. Since there is no risk of floating point error with integral types, this function just exists in case Definition at line 87 of file MathUtils.hh. {
return a <= b;
}
Get Rivet analysis info metadata search paths. Definition at line 99 of file RivetPaths.cc. References getAnalysisLibPaths(), getRivetDataPath(), and pathsplit(). Referenced by findAnalysisInfoFile(). { vector<string> dirs; char* env = 0; env = getenv("RIVET_INFO_PATH"); if (env) { // Use the Rivet analysis path variable if set... dirs += pathsplit(env); } // Then fall back to the Rivet data install path... dirs += getRivetDataPath(); // ... and also add any analysis plugin search dirs for convenience dirs += getAnalysisLibPaths(); return dirs; }
Get Rivet analysis plugin library search paths. Definition at line 59 of file RivetPaths.cc. References getLibPath(), and pathsplit(). Referenced by AnalysisLoader::_loadAnalysisPlugins(), addAnalysisLibPath(), findAnalysisLibFile(), getAnalysisInfoPaths(), getAnalysisPlotPaths(), and getAnalysisRefPaths(). { vector<string> dirs; char* env = 0; env = getenv("RIVET_ANALYSIS_PATH"); if (env) { // Use the Rivet analysis path variable if set... dirs += pathsplit(env); } // ... otherwise fall back to the Rivet library install path dirs += getLibPath(); return dirs; }
Get Rivet analysis plot style search paths. Definition at line 121 of file RivetPaths.cc. References getAnalysisLibPaths(), getRivetDataPath(), and pathsplit(). Referenced by findAnalysisPlotFile(). { vector<string> dirs; char* env = 0; env = getenv("RIVET_PLOT_PATH"); if (env) { // Use the Rivet analysis path variable if set... dirs += pathsplit(env); } // Then fall back to the Rivet data install path... dirs += getRivetDataPath(); // ... and also add any analysis plugin search dirs for convenience dirs += getAnalysisLibPaths(); return dirs; }
Get Rivet analysis reference data search paths. Definition at line 77 of file RivetPaths.cc. References getAnalysisLibPaths(), getRivetDataPath(), and pathsplit(). Referenced by findAnalysisRefFile(). { vector<string> dirs; char* env = 0; env = getenv("RIVET_REF_PATH"); if (env) { // Use the Rivet analysis path variable if set... dirs += pathsplit(env); } // Then fall back to the Rivet data install path... dirs += getRivetDataPath(); // ... and also add any analysis plugin search dirs for convenience dirs += getAnalysisLibPaths(); return dirs; }
Get the file system path to the AIDA reference file for this paper. Definition at line 11 of file RivetYODA.cc. References findAnalysisRefFile(), and getRivetDataPath(). Referenced by getRefData(). { const string path = findAnalysisRefFile(papername + ".aida"); if (!path.empty()) return path; throw Rivet::Error("Couldn't find ref data file '" + papername + ".aida" + " in $RIVET_REF_PATH, " + getRivetDataPath() + ", or ."); return ""; }
Get data install path. Definition at line 33 of file RivetPaths.cc. Referenced by getRivetDataPath(). { BrInitError error; br_init_lib(&error); char* temp = br_find_data_dir(DEFAULTDATADIR); const string sharedir(temp); free (temp); return sharedir; }
Function which returns a vector of all the histogram format values in the HistoFormat enum. Definition at line 49 of file HistoFormat.hh. References getKnownHistoFormats(). { HistoFormatList names; HistoFormatMap hfmap = getKnownHistoFormats(); for (HistoFormatMap::const_iterator hf = hfmap.begin(); hf != hfmap.end(); ++hf) { names.push_back(hf->first); } return names; }
Function which returns a vector of all the histogram format name strings. Definition at line 60 of file HistoFormat.hh. References getKnownHistoFormats(). { vector<string> names; HistoFormatMap hfmap = getKnownHistoFormats(); for (HistoFormatMap::const_iterator hf = hfmap.begin(); hf != hfmap.end(); ++hf) { names.push_back(hf->second); } return names; }
Function which returns a map from histogram format enums to the corresponding name strings. Definition at line 22 of file HistoFormat.hh. References FLAT, ROOT, and YODA. Referenced by getKnownHistoFormatEnums(), getKnownHistoFormatNames(), and getKnownHistoFormatsR(). { HistoFormatMap hfmap; hfmap[YODA] = "YODA"; hfmap[FLAT] = "FLAT"; #ifdef HAVE_ROOT hfmap[ROOT] = "ROOT"; #endif return hfmap; }
Function which returns a map from histogram format name strings to the corresponding enums. Definition at line 33 of file HistoFormat.hh. References getKnownHistoFormats(). { HistoFormatMap hfmap = getKnownHistoFormats(); HistoFormatMapR hfmapr; for (HistoFormatMap::const_iterator hf = hfmap.begin(); hf != hfmap.end(); ++hf) { hfmapr[hf->second] = hf->first; } return hfmapr; }
Get library install path. Definition at line 24 of file RivetPaths.cc. Referenced by getAnalysisLibPaths(). { BrInitError error; br_init_lib(&error); char* temp = br_find_lib_dir(DEFAULTLIBDIR); const string libdir(temp); free (temp); return libdir; }
Function to get a map of all the refdata in a paper with the given papername. Definition at line 20 of file RivetYODA.cc. References getDatafilePath(). Referenced by Analysis::_cacheRefData(). { // Get filename const string xmlfile = getDatafilePath(papername); YODA::Reader & reader = ReaderAIDA::create(); vector<YODA::AnalysisObject *> aovec; reader.read(xmlfile, aovec); // Return value, to be populated RefDataMap rtn; foreach ( YODA::AnalysisObject * ao, aovec ) { Scatter2DPtr refdata( dynamic_cast<Scatter2D *>(ao) ); if (!refdata) continue; string plotpath = refdata->path(); // split path at "/" and only return the last field, i.e. the histogram ID std::vector<string> pathvec; split( pathvec, plotpath, is_any_of("/"), token_compress_on ); plotpath = pathvec.back(); rtn[plotpath] = refdata; } return rtn; }
Get Rivet data install path. Definition at line 42 of file RivetPaths.cc. References getDataPath(). Referenced by getAnalysisInfoPaths(), getAnalysisPlotPaths(), getAnalysisRefPaths(), and getDatafilePath(). { return getDataPath() + "/Rivet"; }
Definition at line 16 of file HadronicFinalState.cc. References Rivet::PID::isHadron(), and Particle::pdgId(). Referenced by HadronicFinalState::project(). { return ! PID::isHadron(p.pdgId()); }
Return the bin index of the given value, val, given a vector of bin edges. NB. The binedges vector must be sorted Definition at line 256 of file MathUtils.hh. References inRange(). Referenced by CDF_2008_S7782535::analyze(), and JetShape::calc().
Determine if value is in the range low to high, for floating point numbers. Interval boundary types are defined by lowbound and highbound.
Definition at line 109 of file MathUtils.hh. References CLOSED, fuzzyGtrEquals(), fuzzyLessEquals(), and OPEN. Referenced by H1_2000_S4129130::analyze(), CDF_2006_S6450792::analyze(), STAR_2008_S7993412::analyze(), STAR_2006_S6870392::analyze(), UA1_1990_S2044935::analyze(), D0_2004_S5992206::analyze(), D0_2001_S4674421::analyze(), CDF_2010_S8591881_DY::analyze(), D0_2008_S7719523::analyze(), CDF_2008_NOTE_9351::analyze(), MC_TTBAR::analyze(), ATLAS_2011_I944826::analyze(), CDF_2004_S5839831::analyze(), ATLAS_2011_I919017::analyze(), InvMassFinalState::calc(), JetShape::calc(), JetShape::diffJetShape(), ATLAS_2011_S9120807::getEtaBin(), OPAL_2004_S6132243::getHistIndex(), index_between(), inRange(), JetShape::intJetShape(), JetAlg::jets(), linspace(), TriggerCDFRun2::project(), TriggerCDFRun0Run1::project(), InitialQuarks::project(), UnstableFinalState::project(), TriggerUA5::project(), JetShape::rBinMax(), JetShape::rBinMid(), JetShape::rBinMin(), CDF_2012_NOTE10874::region_index(), ATLAS_2010_S8894728::region_index(), and ATLAS_2011_S8994773::region_index(). { if (lowbound == OPEN && highbound == OPEN) { return (value > low && value < high); } else if (lowbound == OPEN && highbound == CLOSED) { return (value > low && fuzzyLessEquals(value, high)); } else if (lowbound == CLOSED && highbound == OPEN) { return (fuzzyGtrEquals(value, low) && value < high); } else { // if (lowbound == CLOSED && highbound == CLOSED) { return (fuzzyGtrEquals(value, low) && fuzzyLessEquals(value, high)); } }
Alternative version of inRange for doubles, which accepts a pair for the range arguments. Definition at line 124 of file MathUtils.hh. References inRange(). { return inRange(value, lowhigh.first, lowhigh.second, lowbound, highbound); }
Determine if value is in the range low to high, for integer types. Interval boundary types are defined by lowbound and highbound.
Definition at line 134 of file MathUtils.hh. { if (lowbound == OPEN && highbound == OPEN) { return (value > low && value < high); } else if (lowbound == OPEN && highbound == CLOSED) { return (value > low && value <= high); } else if (lowbound == CLOSED && highbound == OPEN) { return (value >= low && value < high); } else { // if (lowbound == CLOSED && highbound == CLOSED) { return (value >= low && value <= high); } }
Alternative version of Definition at line 148 of file MathUtils.hh. References inRange(). { return inRange(value, lowhigh.first, lowhigh.second, lowbound, highbound); }
Return the integral over the histogram bins. Definition at line 38 of file RivetYODA.hh. Referenced by JetShape::calc(), CMS_2012_I1107658::finalize(), and D0_2001_S4674421::finalize(). {
return histo->integral();
}
Return the intersection of two sets of {PdgIdPair}s. Definition at line 56 of file BeamConstraint.hh. References compatible(). Referenced by Projection::beamPairs(). { set<PdgIdPair> ret; for (set<PdgIdPair>::const_iterator bp = a.begin(); bp != a.end(); ++bp) { if (compatible(*bp, b)) ret.insert(*bp); } return ret; }
A more efficient version of pow for raising numbers to integer powers. Definition at line 179 of file MathUtils.hh. Referenced by _calcT(), ATLAS_2010_S8894728::_moments_to_stddev(), and ATLAS_2010_S8894728::analyze(). { assert(exp >= 0); if (exp == 0) return (Num) 1; else if (exp == 1) return val; return val * intpow(val, exp-1); }
Calculate the Lorentz self-invariant of a 4-vector. Definition at line 241 of file Vector4.hh. References FourVector::invariant(). Referenced by DISKinematics::project(). {
return lv.invariant();
}
Definition at line 149 of file LorentzTrans.hh. References LorentzTransform::inverse(). {
return lt.inverse();
}
Definition at line 348 of file MatrixN.hh. References Matrix< N >::inverse(). { return m.inverse(); }
Definition at line 18 of file VisibleFinalState.cc. References GLUON, Rivet::PID::isHadron(), Particle::pdgId(), PHOTON, and Rivet::PID::threeCharge(). Referenced by VisibleFinalState::project(). { // charged particles are visible if ( PID::threeCharge( p.pdgId() ) != 0 ) return false; // neutral hadrons are visible if ( PID::isHadron( p.pdgId() ) ) return false; // photons are visible if ( p.pdgId() == PHOTON ) return false; // gluons are visible (for parton level analyses) if ( p.pdgId() == GLUON ) return false; // everything else is invisible return true; }
Compare a floating point number to zero with a degree of fuzziness expressed by the absolute tolerance parameter. Definition at line 17 of file MathUtils.hh. Referenced by _mapAngleM2PITo2Pi(), CDF_2004_S5839831::analyze(), Vector3::azimuthalAngle(), FinalState::FinalState(), fuzzyEquals(), Matrix< 4 >::isDiag(), Matrix< 4 >::isEqual(), Vector< 4 >::isZero(), Matrix< 4 >::isZero(), mapAngle0To2Pi(), mapAngle0ToPi(), mapAngleMPiToPi(), DISKinematics::project(), UnstableFinalState::project(), rapidity(), Hemispheres::scaledM2high(), Hemispheres::scaledM2low(), Matrix3::setAsRotation(), sign(), and toString(). {
return (fabs(val) < tolerance);
}
Compare an integral-type number to zero. Since there is no risk of floating point error, this function just exists in case Definition at line 26 of file MathUtils.hh. {
return val == 0;
}
External form of numerically safe nullness check. Definition at line 201 of file VectorN.hh. References Vector< N >::isZero(). {
return v.isZero(tolerance);
}
External form of numerically safe nullness check. Definition at line 411 of file MatrixN.hh. References Matrix< N >::isZero(). { return m.isZero(tolerance); }
Make a list of nbins + 1 values equally spaced between start and end inclusive. NB. The arg ordering and the meaning of the nbins variable is "histogram-like", as opposed to the Numpy/Matlab version. Definition at line 215 of file MathUtils.hh. References CLOSED, and inRange(). Referenced by JetShape::JetShape(), and logspace().
Make a list of nbins + 1 values exponentially spaced between start and end inclusive. NB. The arg ordering and the meaning of the nbins variable is "histogram-like", as opposed to the Numpy/Matlab version, and the start and end arguments are expressed in "normal" space, rather than as the logarithms of the start/end values as in Numpy/Matlab. Definition at line 235 of file MathUtils.hh. References linspace(). Referenced by MC_DIPHOTON::init(), MC_JetAnalysis::init(), MC_HJETS::init(), MC_ZJETS::init(), MC_PDFS::init(), MC_PHOTONJETS::init(), MC_TTBAR::init(), MC_ZZJETS::init(), MC_WJETS::init(), MC_WWJETS::init(), MC_PHOTONS::init(), and MC_WPOL::init(). { assert(end >= start); assert(start > 0); assert(nbins > 0); const double logstart = std::log(start); const double logend = std::log(end); const vector<double> logvals = linspace(nbins, logstart, logend); assert(logvals.size() == nbins+1); vector<double> rtn; foreach (double logval, logvals) { rtn.push_back(std::exp(logval)); } assert(rtn.size() == nbins+1); return rtn; }
Definition at line 15 of file LorentzTrans.hh. Referenced by LorentzTransform::gamma(), and LorentzTransform::setBoost(). {
return 1.0 / sqrt(1 - beta*beta);
}
Convenience maker of particle ID pairs from PdgIds. Definition at line 154 of file ParticleName.hh. Referenced by compatible(), and AnalysisInfo::make(). {
return make_pair(a, b);
}
Convenience maker of particle ID pairs from particle names. Definition at line 160 of file ParticleName.hh. References toParticleId(). { const PdgId pa = toParticleId(a); const PdgId pb = toParticleId(b); return make_pair(pa, pb); }
Map an angle into the range [0, 2PI). Definition at line 385 of file MathUtils.hh. References _mapAngleM2PITo2Pi(), isZero(), and TWOPI. Referenced by CDF_2004_S5839831::_calcTransCones(), and D0_1996_S3324664::analyze().
Map an angle into the range [0, PI]. Definition at line 395 of file MathUtils.hh. References isZero(), mapAngleMPiToPi(), and PI. Referenced by CDF_1997_S3541940::_psi(), CDF_1996_S3349578::_psi(), CDF_2005_S6080774::analyze(), ATLAS_2011_S8971293::analyze(), D0_2010_S8570965::analyze(), MC_PHOTONJETS::analyze(), D0_2010_S8821313::analyze(), MC_ZZJETS::analyze(), MC_WWJETS::analyze(), and deltaPhi(). { double rtn = fabs(mapAngleMPiToPi(angle)); if (isZero(rtn)) return 0; assert(rtn > 0 && rtn <= PI); return rtn; }
Map an angle into the range (-PI, PI]. Definition at line 375 of file MathUtils.hh. References _mapAngleM2PITo2Pi(), isZero(), PI, and TWOPI. Referenced by MC_SUSY::analyze(), and mapAngle0ToPi().
Get the mass Definition at line 533 of file Vector4.hh. References FourMomentum::mass(). Referenced by BABAR_2007_S7266081::analyze(), ARGUS_1993_S2789213::analyze(), ARGUS_1993_S2669951::analyze(), D0_2011_I895662::analyze(), CDF_1996_S3108457::analyze(), ATLAS_2010_S8817804::analyze(), ATLAS_2012_I1082936::analyze(), CDF_2010_S8591881_DY::analyze(), ATLAS_2011_S9108483::analyze(), ATLAS_2012_I1190891::analyze(), CDF_2008_NOTE_9351::analyze(), ATLAS_2012_I1186556::analyze(), MC_TTBAR::analyze(), ATLAS_2012_I1112263::analyze(), MC_WWJETS::analyze(), ATLAS_2012_CONF_2012_001::analyze(), ATLAS_2012_CONF_2012_153::analyze(), ATLAS_2011_I945498::analyze(), ATLAS_2012_I943401::analyze(), ATLAS_2012_I1094568::analyze(), mt2::mt2_massless(), VetoedFinalState::project(), and mt2::scan_high(). {
return v.mass();
}
Get the squared mass Definition at line 538 of file Vector4.hh. References FourMomentum::mass2(). Referenced by CDF_1997_S3541940::_reduce(), CDF_1996_S3349578::_reduce(), D0_1996_S3214044::_safeMass(), CDF_1997_S3541940::_safeMass(), CDF_1996_S3349578::_safeMass(), D0_2001_S4674421::analyze(), and VetoedFinalState::project(). {
return v.mass2();
}
Calculate the mean of a sample. Definition at line 276 of file MathUtils.hh. Referenced by ATLAS_2010_S8894728::_moments_to_stddev(), ATLAS_2011_S8994773::analyze(), ATLAS_2010_S8894728::analyze(), covariance(), and covariance_err(). { double mean = 0.0; for (size_t i=0; i<sample.size(); ++i) { mean += sample[i]; } return mean/sample.size(); }
Definition at line 285 of file MathUtils.hh. Referenced by covariance_err(). { double mean_e = 0.0; for (size_t i=0; i<sample.size(); ++i) { mean_e += sqrt(sample[i]); } return mean_e/sample.size(); }
Calculate the modulus of a vector. Definition at line 150 of file VectorN.hh. References Vector< N >::mod(). Referenced by FParameter::_calcFParameter(), _calcS(), Spherocity::_calcSpherocity(), _calcT(), Thrust::_calcThrust(), D0_1996_S3214044::_fourJetAnalysis(), and Hemispheres::project(). {
return v.mod();
}
Calculate the modulus-squared of a vector. Definition at line 143 of file VectorN.hh. References Vector< N >::mod2(). {
return v.mod2();
}
Definition at line 42 of file Thrust.cc. References Vector< N >::mod2(). Referenced by _calcT(). {
return a.mod2() > b.mod2();
}
Make a 4-momentum vector from a FastJet pseudo-jet. Definition at line 36 of file FastJets.hh. Referenced by D0_1996_S3214044::_fourJetAnalysis(), D0_1996_S3214044::_threeJetAnalysis(), BELLE_2001_S4598261::analyze(), ARGUS_1993_S2653028::analyze(), BABAR_2007_S7266081::analyze(), MC_JetAnalysis::analyze(), OPAL_1993_S2692198::analyze(), SLD_2004_S5693039::analyze(), CMS_2011_S8950903::analyze(), CMS_2011_S8968497::analyze(), SLD_1999_S3743934::analyze(), D0_2011_I895662::analyze(), CDF_2008_S8093652::analyze(), CMS_2011_S8957746::analyze(), D0_2007_S7075677::analyze(), MC_DIPHOTON::analyze(), CDF_2005_S6080774::analyze(), CMS_2012_I1102908::analyze(), CDF_2008_S7540469::analyze(), CMS_2011_S9215166::analyze(), MC_DIJET::analyze(), MC_HJETS::analyze(), MC_ZJETS::analyze(), D0_2010_S8566488::analyze(), MC_LEADJETUE::analyze(), ATLAS_2011_S8971293::analyze(), D0_2009_S8320160::analyze(), CDF_1994_S2952106::analyze(), D0_2008_S7863608::analyze(), MC_PHOTONJETS::analyze(), MC_PHOTONS::analyze(), MC_WJETS::analyze(), CDF_2008_S8095620::analyze(), ATLAS_2012_I946427::analyze(), STAR_2009_UE_HELEN::analyze(), D0_2009_S8202443::analyze(), CDF_2006_S6653332::analyze(), D0_2004_S5992206::analyze(), ATLAS_2012_I1183818::analyze(), D0_1996_S3214044::analyze(), CDF_2010_S8591881_DY::analyze(), CDF_2010_S8591881_QCD::analyze(), ATLAS_2012_CONF_2012_104::analyze(), CDF_2008_LEADINGJETS::analyze(), ATLAS_2012_I1126136::analyze(), CDF_2008_NOTE_9351::analyze(), ATLAS_2012_I1186556::analyze(), MC_TTBAR::analyze(), ATLAS_2012_CONF_2012_105::analyze(), ATLAS_2011_CONF_2011_098::analyze(), ATLAS_2012_I1112263::analyze(), ATLAS_2012_CONF_2012_103::analyze(), ATLAS_2012_I1117704::analyze(), MC_ZZJETS::analyze(), ATLAS_2012_I1095236::analyze(), MC_WWJETS::analyze(), ATLAS_2012_CONF_2012_001::analyze(), ATLAS_2012_CONF_2012_109::analyze(), ATLAS_2012_I1180197::analyze(), ATLAS_2011_CONF_2011_090::analyze(), ATLAS_2010_S8919674::analyze(), ATLAS_2012_CONF_2012_153::analyze(), ATLAS_2011_I945498::analyze(), ATLAS_2011_S9212353::analyze(), ATLAS_2012_I943401::analyze(), ATLAS_2011_S9225137::analyze(), and CDF_2004_S5839831::analyze(). {
return FourMomentum(pj.E(), pj.px(), pj.py(), pj.pz());
}
Make a 3-momentum vector from a FastJet pseudo-jet. Definition at line 31 of file FastJets.hh. {
return Vector3(pj.px(), pj.py(), pj.pz());
}
Definition at line 225 of file Vector3.hh. References Vector< N >::_vec. {
Vector3 result;
result._vec = a * v._vec;
return result;
}
Definition at line 311 of file MatrixN.hh. References Matrix< N >::_matrix. Referenced by divide(), multiply(), operator*(), operator/(), LorentzTransform::preMult(), and LorentzTransform::transform(). {
Matrix<N> tmp;
tmp._matrix = a._matrix * b._matrix;
return tmp;
}
Definition at line 203 of file Vector4.hh. References Vector< N >::_vec. {
FourVector result;
result._vec = a * v._vec;
return result;
}
Definition at line 284 of file MatrixN.hh. References Matrix< N >::_matrix. { Matrix<N> rtn; rtn._matrix = a * m._matrix; return rtn; }
Definition at line 324 of file MatrixN.hh. References Matrix< N >::_matrix, and Vector< N >::_vec. {
Vector<N> tmp;
tmp._vec = a._matrix * b._vec;
return tmp;
}
Definition at line 494 of file Vector4.hh. References Vector< N >::_vec. {
FourMomentum result;
result._vec = a * v._vec;
return result;
}
Definition at line 14 of file Utils.hh. { string::const_iterator it1 = s1.begin(); string::const_iterator it2 = s2.begin(); while ( (it1 != s1.end()) && (it2 != s2.end()) ) { if(::toupper(*it1) != ::toupper(*it2)) { // < Letters differ? // Return -1 to indicate smaller than, 1 otherwise return (::toupper(*it1) < ::toupper(*it2)) ? -1 : 1; } // Proceed to the next character in each string ++it1; ++it2; } size_t size1 = s1.size(), size2 = s2.size(); // Cache lengths // Return -1,0 or 1 according to strings' lengths if (size1 == size2) return 0; return (size1 < size2) ? -1 : 1; }
Definition at line 16 of file NonHadronicFinalState.cc. References Rivet::PID::isHadron(), and Particle::pdgId(). Referenced by NonHadronicFinalState::project(). { return PID::isHadron(p.pdgId()); }
Allow ParticlePair to be passed to an ostream. Definition at line 125 of file Particle.hh. References toString(). { os << toString(pp); return os; }
Definition at line 166 of file MatrixDiag.hh. References toString(). { out << toString(e); return out; }
Streaming output to a logger must have a Log::Level/int as its first argument. The streaming operator can use Log's internals. Definition at line 189 of file Logging.cc. References Log::_nostream, Log::formatMessage(), and Log::isActive(). { if (log.isActive(level)) { cout << log.formatMessage(level, ""); return cout; } else { return *(log._nostream); } }
Definition at line 169 of file LorentzTrans.hh. References toString(). { out << toString(lt); return out; }
Stream out string representation. Definition at line 176 of file VectorN.hh. References toString(). { out << toString(v); return out; }
Stream an AnalysisInfo as a text description. Definition at line 239 of file AnalysisInfo.hh. References toString(). { os << toString(ai); return os; }
Stream out string representation. Definition at line 386 of file MatrixN.hh. References m, and toString().
Write a 4-vector to an ostream. Definition at line 920 of file Vector4.hh. References toString(). { out << toString(lv); return out; }
Definition at line 19 of file RivetHepMC.hh. References pi. Referenced by BELLE_2001_S4598261::analyze(), ARGUS_1993_S2653028::analyze(), ARGUS_1993_S2789213::analyze(), ARGUS_1993_S2669951::analyze(), H1_2000_S4129130::analyze(), CMS_2011_S8941262::analyze(), H1_1994_S2919893::analyze(), CDF_2005_S6080774::analyze(), MC_DIPHOTON::analyze(), SLD_2002_S4869273::analyze(), ALEPH_2001_S4656318::analyze(), DELPHI_2002_069_CONF_603::analyze(), CDF_1993_S2742446::analyze(), CDF_2009_S8436959::analyze(), CDF_2012_NOTE10874::analyze(), D0_2006_S6438750::analyze(), MC_IDENTIFIED::analyze(), ALEPH_1996_S3196992::analyze(), D0_2010_S8570965::analyze(), MC_PHOTONS::analyze(), MC_PHOTONJETS::analyze(), CMS_2012_I1107658::analyze(), CDF_2008_S8095620::analyze(), CMS_2011_S9120041::analyze(), ATLAS_2012_I946427::analyze(), JADE_OPAL_2000_S4300807::analyze(), ATLAS_2012_I1183818::analyze(), ATLAS_2012_CONF_2012_104::analyze(), ATLAS_2011_S9108483::analyze(), ATLAS_2012_I1190891::analyze(), D0_2008_S7719523::analyze(), ATLAS_2012_I1126136::analyze(), ATLAS_2012_I1186556::analyze(), ATLAS_2011_S9212183::analyze(), ATLAS_2011_S9120807::analyze(), ATLAS_2012_CONF_2012_105::analyze(), ATLAS_2011_CONF_2011_098::analyze(), ATLAS_2010_S8914702::analyze(), ATLAS_2012_CONF_2012_103::analyze(), ATLAS_2012_I1112263::analyze(), ATLAS_2012_I1125961::analyze(), ATLAS_2012_I1095236::analyze(), ATLAS_2012_I1117704::analyze(), ATLAS_2012_CONF_2012_001::analyze(), ATLAS_2012_CONF_2012_109::analyze(), ATLAS_2012_I1180197::analyze(), ATLAS_2011_S8983313::analyze(), ATLAS_2011_CONF_2011_090::analyze(), ATLAS_2011_S9019561::analyze(), ATLAS_2010_S8919674::analyze(), OPAL_2001_S4553896::analyze(), ATLAS_2012_CONF_2012_153::analyze(), ATLAS_2011_S9212353::analyze(), ATLAS_2012_I943401::analyze(), ATLAS_2011_S9225137::analyze(), ATLAS_2011_S9041966::analyze(), ATLAS_2012_I1093738::analyze(), ATLAS_2012_I1094568::analyze(), CDF_2004_S5839831::analyze(), Jet::containsBottom(), Jet::containsCharm(), Particle::hasAncestor(), particles(), BeamThrust::project(), FParameter::project(), InitialQuarks::project(), UnstableFinalState::project(), Spherocity::project(), Thrust::project(), Sphericity::project(), Hemispheres::project(), FinalState::project(), and FastJets::project().
Definition at line 26 of file RivetHepMC.hh. References particles(). { assert(ge); return particles(*ge); }
Definition at line 59 of file RivetHepMC.hh. Referenced by InitialQuarks::project(). {
return make_pair(gv->particles_in_const_begin(), gv->particles_in_const_end());
}
Definition at line 64 of file RivetHepMC.hh. Referenced by InitialQuarks::project(). {
return make_pair(gv->particles_out_const_begin(), gv->particles_out_const_end());
}
Join several filesystem paths together with a delimiter character. Note that this does NOT join path elements together with a platform-portable directory delimiter, cf. the Python Definition at line 81 of file Utils.hh. Referenced by setAnalysisLibPaths(). { const string delim = ":"; string rtn; for (vector<string>::const_iterator is = paths.begin(); is != paths.end(); ++is) { if (rtn.size() > 0) rtn += delim; rtn += *is; } return rtn; }
Split a path string with colon delimiters. Ignores zero-length substrings. Designed for getting elements of filesystem paths, naturally. Definition at line 62 of file Utils.hh. Referenced by getAnalysisInfoPaths(), getAnalysisLibPaths(), getAnalysisPlotPaths(), and getAnalysisRefPaths(). { const string delim = ":"; vector<string> dirs; string tmppath = path; while (true) { const size_t delim_pos = tmppath.find(delim); if (delim_pos == string::npos) break; const string dir = tmppath.substr(0, delim_pos); if (dir.length()) dirs.push_back(dir); // Don't insert "empties" tmppath.replace(0, delim_pos+1, ""); } if (tmppath.length()) dirs.push_back(tmppath); // Don't forget the trailing component! return dirs; }
Convenience method for casting to a const Projection reference. Definition at line 31 of file Projection.fhh. { return dynamic_cast<const PROJ&>(p); }
Convenience method for casting to a const Projection pointer. Definition at line 38 of file Projection.fhh. { return dynamic_cast<const PROJ*>(p); }
Global helper function for easy creation of Cmp<Projection> objects. Definition at line 295 of file Cmp.hh. Referenced by ProjectionHandler::_getEquiv(), Projection::mkNamedPCmp(), and Projection::mkPCmp(). {
return Cmp<Projection>(p1, p2);
}
Global helper function for easy creation of Cmp<Projection> objects from two parent projections and their common name for the projection to be compared. Definition at line 301 of file Cmp.hh. References ProjectionApplier::getProjection(). {
return Cmp<Projection>(parent1.getProjection(pname), parent2.getProjection(pname));
}
Global helper function for easy creation of Cmp<Projection> objects from two parent projections and their common name for the projection to be compared. This version takes one parent as a pointer. Definition at line 308 of file Cmp.hh. References ProjectionApplier::getProjection(). {
assert(parent1);
return Cmp<Projection>(parent1->getProjection(pname), parent2.getProjection(pname));
}
Global helper function for easy creation of Cmp<Projection> objects from two parent projections and their common name for the projection to be compared. This version takes one parent as a pointer. Definition at line 316 of file Cmp.hh. References ProjectionApplier::getProjection(). {
assert(parent2);
return Cmp<Projection>(parent1.getProjection(pname), parent2->getProjection(pname));
}
Global helper function for easy creation of Cmp<Projection> objects from two parent projections and their common name for the projection to be compared. Definition at line 323 of file Cmp.hh. References ProjectionApplier::getProjection(). {
assert(parent1);
assert(parent2);
return Cmp<Projection>(parent1->getProjection(pname), parent2->getProjection(pname));
}
Synonym for polarRadius. Definition at line 278 of file Vector4.hh. References FourVector::perp(). {
return v.perp();
}
Synonym for polarRadius. Definition at line 292 of file Vector3.hh. References Vector3::perp(). Referenced by ATLAS_2012_I1082009::analyze(), ATLAS_2012_I1186556::analyze(), ATLAS_2012_I1112263::analyze(), ATLAS_2012_I1125961::analyze(), ATLAS_2012_I1095236::analyze(), ATLAS_2012_CONF_2012_001::analyze(), ATLAS_2012_I1180197::analyze(), ATLAS_2012_CONF_2012_109::analyze(), ATLAS_2012_I943401::analyze(), and InvMassFinalState::massT(). {
return v.perp();
}
Synonym for polarRadius2. Definition at line 265 of file Vector4.hh. References FourVector::perp2(). {
return v.perp2();
}
Synonym for polarRadius2. Definition at line 279 of file Vector3.hh. References Vector3::perp2(). {
return v.perp2();
}
Synonym for azimuthalAngle. Definition at line 291 of file Vector4.hh. References FourVector::phi(). {
return v.phi(mapping);
}
Synonym for azimuthalAngle. Definition at line 307 of file Vector3.hh. References Vector3::phi(). Referenced by CMS_2011_S8950903::analyze(), CDF_2005_S6080774::analyze(), MC_DIPHOTON::analyze(), CMS_2011_S9215166::analyze(), MC_LEADJETUE::analyze(), ATLAS_2011_S8971293::analyze(), CDF_1994_S2952106::analyze(), STAR_2009_UE_HELEN::analyze(), D0_2004_S5992206::analyze(), CDF_2010_S8591881_QCD::analyze(), CDF_2008_LEADINGJETS::analyze(), ATLAS_2012_I1112263::analyze(), ATLAS_2012_I1095236::analyze(), ATLAS_2012_CONF_2012_001::analyze(), ATLAS_2011_CONF_2011_090::analyze(), ATLAS_2011_S9212353::analyze(), ATLAS_2012_I943401::analyze(), ATLAS_2011_S9041966::analyze(), deltaPhi(), deltaR(), ATLAS_2012_I1091481::getSE(), ATLAS_2012_I1091481::getSeta(), and ATLAS_2011_S9108483::rndGauss(). {
return v.phi(mapping);
}
Calculate polar angle of a Lorentz vector. Definition at line 297 of file Vector4.hh. References FourVector::polarAngle(). {
return v.polarAngle();
}
Calculate polar angle of a 3-vector. Definition at line 312 of file Vector3.hh. References Vector3::polarAngle(). {
return v.polarAngle();
}
Calculate transverse length Definition at line 274 of file Vector4.hh. References FourVector::polarRadius(). {
return v.polarRadius();
}
Calculate transverse length Definition at line 288 of file Vector3.hh. References Vector3::polarRadius(). {
return v.polarRadius();
}
Calculate transverse length sq. Definition at line 261 of file Vector4.hh. References FourVector::polarRadius2(). {
return v.polarRadius2();
}
Calculate transverse length sq. Definition at line 275 of file Vector3.hh. References Vector3::polarRadius2(). {
return v.polarRadius2();
}
Calculate pseudorapidity of a Lorentz vector. Definition at line 306 of file Vector4.hh. References FourVector::pseudorapidity(). {
return v.pseudorapidity();
}
Calculate pseudorapidity of a 3-vector. Definition at line 321 of file Vector3.hh. References Vector3::pseudorapidity(). Referenced by CDF_2008_S7540469::analyze(), MC_DIJET::analyze(), MC_LEADJETUE::analyze(), and CDF_2004_S5839831::analyze(). {
return v.pseudorapidity();
}
Calculate the transverse momentum Definition at line 553 of file Vector4.hh. References FourMomentum::pT(). Referenced by FinalState::accept(), MC_JetAnalysis::analyze(), CMS_2012_I1087342::analyze(), CMS_2011_S8950903::analyze(), CMS_2010_S8656010::analyze(), ATLAS_2010_S8591806::analyze(), LHCF_2012_I1115479::analyze(), ALICE_2011_S8909580::analyze(), D0_2011_I895662::analyze(), CMS_2011_S8957746::analyze(), H1_1994_S2919893::analyze(), CMS_2010_S8547297::analyze(), CMS_2011_S8978280::analyze(), MC_DIPHOTON::analyze(), ATLAS_2011_S8994773::analyze(), D0_2008_S6879055::analyze(), ALICE_2010_S8706239::analyze(), CDF_2012_NOTE10874::analyze(), LHCB_2011_I919315::analyze(), MC_DIJET::analyze(), MC_LEADJETUE::analyze(), STAR_2006_S6500200::analyze(), ATLAS_2011_S8971293::analyze(), CDF_2009_S8233977::analyze(), D0_2008_S7863608::analyze(), CMS_2012_I1107658::analyze(), MC_PHOTONS::analyze(), STAR_2006_S6860818::analyze(), CMS_2011_S8884919::analyze(), ATLAS_2010_S8817804::analyze(), LHCB_2010_S8758301::analyze(), CMS_2011_S9120041::analyze(), STAR_2009_UE_HELEN::analyze(), D0_2009_S8202443::analyze(), ATLAS_2012_I1082936::analyze(), D0_2001_S4674421::analyze(), MC_PHOTONJETUE::analyze(), CDF_2010_S8591881_QCD::analyze(), CDF_2010_S8591881_DY::analyze(), ATLAS_2012_CONF_2012_104::analyze(), CDF_2008_LEADINGJETS::analyze(), ATLAS_2011_S9108483::analyze(), ATLAS_2012_I1190891::analyze(), LHCB_2011_I917009::analyze(), CDF_2008_NOTE_9351::analyze(), MC_TTBAR::analyze(), STAR_2008_S7869363::analyze(), ATLAS_2011_CONF_2011_098::analyze(), CDF_2001_S4751469::analyze(), ATLAS_2011_S9128077::analyze(), ATLAS_2012_CONF_2012_001::analyze(), ATLAS_2012_I1180197::analyze(), ATLAS_2012_I1083318::analyze(), ATLAS_2011_CONF_2011_090::analyze(), ATLAS_2010_S8894728::analyze(), ATLAS_2010_S8919674::analyze(), ATLAS_2012_CONF_2012_153::analyze(), ATLAS_2011_I945498::analyze(), ATLAS_2011_S9212353::analyze(), ATLAS_2011_S9041966::analyze(), ATLAS_2011_I944826::analyze(), DELPHI_1996_S3430090::analyze(), ATLAS_2011_S9126244::analyze(), and InitialQuarks::project(). {
return v.pT();
}
Calculate the squared transverse momentum Definition at line 548 of file Vector4.hh. References FourMomentum::pT2(). Referenced by H1_1994_S2919893::analyze(), and ATLAS_2011_S9128077::analyze(). {
return v.pT2();
}
Calculate a rapidity value from the supplied energy E and longitudinal momentum pz. Definition at line 429 of file MathUtils.hh. References isZero(), and MAXDOUBLE. Referenced by D0_2011_I895662::analyze(), CMS_2012_I1102908::analyze(), ATLAS_2011_S8971293::analyze(), D0_2008_S7863608::analyze(), CDF_2008_S8095620::analyze(), CDF_2006_S6653332::analyze(), MC_GENERIC::analyze(), ATLAS_2012_I1083318::analyze(), ATLAS_2011_I945498::analyze(), ATLAS_2012_I1094568::analyze(), ATLAS_2011_S9126244::analyze(), ATLAS_2011_S9126244::analyzeJets(), and deltaR().
Calculate the rapidity of a momentum 4-vector. Definition at line 543 of file Vector4.hh. References FourMomentum::rapidity(). {
return v.rapidity();
}
Synonym for polarRadius. Definition at line 282 of file Vector4.hh. References FourVector::rho(). {
return v.rho();
}
Synonym for polarRadius. Definition at line 296 of file Vector3.hh. References Vector3::rho(). {
return v.rho();
}
Synonym for polarRadius2. Definition at line 269 of file Vector4.hh. References FourVector::rho2(). {
return v.rho2();
}
Synonym for polarRadius2. Definition at line 283 of file Vector3.hh. References Vector3::rho2(). {
return v.rho2();
}
Set the Rivet analysis plugin library search paths. Definition at line 48 of file RivetPaths.cc. References pathjoin(). Referenced by addAnalysisLibPath(). { const string pathstr = pathjoin(paths); setenv("RIVET_ANALYSIS_PATH", pathstr.c_str(), 1); }
Find the sign of a number. Definition at line 187 of file MathUtils.hh. References isZero(), MINUS, PLUS, and ZERO. Referenced by _calcT(), CDF_1994_S2952106::analyze(), MC_PHOTONJETUE::analyze(), D0_2008_S7719523::analyze(), ATLAS_2012_I943401::analyze(), ATLAS_2012_I1093738::analyze(), and FourMomentum::mass().
Named number-type squaring operation. Definition at line 161 of file MathUtils.hh. Referenced by BABAR_2005_S6181155::analyze(), BELLE_2006_S6265367::analyze(), CLEO_2004_S5809304::analyze(), BABAR_2007_S6895344::analyze(), ARGUS_1993_S2789213::analyze(), ARGUS_1993_S2669951::analyze(), OPAL_1993_S2692198::analyze(), H1_1994_S2919893::analyze(), CDF_1994_S2952106::analyze(), D0_2010_S8821313::analyze(), D0_2001_S4674421::analyze(), MC_WPOL::analyze(), ATLAS_2011_S9108483::analyze(), ATLAS_2012_I1126136::analyze(), ATLAS_2012_I943401::analyze(), deltaR(), and sqrtS(). {
return a*a;
}
Function to get beam centre of mass energy from an event. Definition at line 25 of file Beam.cc. References Beam::project(), and Beam::sqrtS(). Referenced by CMS_2011_S9120041::analyze(), CMS_2011_S9120041::finalize(), CMS_2011_S8884919::init(), CMS_2011_S9120041::init(), and sqrtS(). {
Beam beamproj;
beamproj.project(e);
return beamproj.sqrtS();
}
Function to get beam centre of mass energy from a pair of beam momenta. Definition at line 35 of file Beam.cc. References FourMomentum::E(), FourMomentum::pz(), and sqr().
Definition at line 253 of file Vector3.hh. References Vector< N >::_vec. {
Vector3 result;
result._vec = a._vec - b._vec;
return result;
}
Definition at line 269 of file MatrixN.hh. References add(). Referenced by operator-(). { return add(a, -b); }
Synonym for polarAngle. Definition at line 301 of file Vector4.hh. References FourVector::theta(). {
return v.theta();
}
Synonym for polarAngle. Definition at line 316 of file Vector3.hh. References Vector3::theta(). Referenced by JADE_1998_S3612880::analyze(), mt2::mt2_massless(), and Matrix3::setAsRotation(). {
return v.theta();
}
Print a PdgIdPair as a string. Definition at line 168 of file ParticleName.hh. References toParticleName(). Referenced by AnalysisHandler::analyze(). { string out = "[" + toParticleName(pair.first) + ", " + toParticleName(pair.second) + "]"; return out; }
Print a PdgId as a named string. Definition at line 148 of file ParticleName.hh. References ParticleNames::particleId(). Referenced by make_pdgid_pair(). {
return ParticleNames::particleId(pname);
}
Print a PdgId as a named string. Definition at line 142 of file ParticleName.hh. References ParticleNames::particleName(). Referenced by toBeamsString(), and toString(). {
return ParticleNames::particleName(p);
}
Print a ParticlePair as a string. Definition at line 114 of file Particle.hh. References GeV, and toParticleName(). { stringstream out; out << "[" << toParticleName(pair.first.pdgId()) << " @ " << pair.first.momentum().E()/GeV << " GeV, " << toParticleName(pair.second.pdgId()) << " @ " << pair.second.momentum().E()/GeV << " GeV]"; return out.str(); }
Definition at line 156 of file MatrixDiag.hh. { ostringstream ss; //for (typename EigenSystem<N>::EigenPairs::const_iterator i = e.begin(); i != e.end(); ++i) { ss << e->first << " -> " << e->second; // if (i+1 != e.end()) ss << endl; //} return ss.str(); }
Make string representation. Definition at line 163 of file VectorN.hh. References Vector< N >::size(). { ostringstream out; out << "("; for (size_t i = 0; i < v.size(); ++i) { out << (fabs(v[i]) < 1E-30 ? 0.0 : v[i]); if (i < v.size()-1) out << ", "; } out << ")"; return out.str(); }
Definition at line 165 of file LorentzTrans.hh. References LorentzTransform::_boostMatrix, and toString(). { return toString(lt._boostMatrix); }
String representation. Definition at line 171 of file AnalysisInfo.cc. References AnalysisInfo::name(), AnalysisInfo::status(), and AnalysisInfo::summary(). Referenced by operator<<(), and toString(). { stringstream ss; ss << ai.name(); ss << " - " << ai.summary(); // ss << " - " << ai.beams(); // ss << " - " << ai.energies(); ss << " (" << ai.status() << ")"; return ss.str(); }
Make string representation. Definition at line 368 of file MatrixN.hh. References Matrix< N >::get(), isZero(), and Matrix< N >::size(). { ostringstream ss; ss << "[ "; for (size_t i = 0; i < m.size(); ++i) { ss << "( "; for (size_t j = 0; j < m.size(); ++j) { const double e = m.get(i, j); ss << (Rivet::isZero(e) ? 0.0 : e) << " "; } ss << ") "; } ss << "]"; return ss.str(); }
Render a 4-vector as a string. Definition at line 909 of file Vector4.hh. References FourVector::t(), FourVector::x(), FourVector::y(), and FourVector::z(). { ostringstream out; out << "(" << (fabs(lv.t()) < 1E-30 ? 0.0 : lv.t()) << "; " << (fabs(lv.x()) < 1E-30 ? 0.0 : lv.x()) << ", " << (fabs(lv.y()) < 1E-30 ? 0.0 : lv.y()) << ", " << (fabs(lv.z()) < 1E-30 ? 0.0 : lv.z()) << ")"; return out.str(); }
Definition at line 40 of file Utils.hh. References s, and transform(). Referenced by ParticleNames::_particleId(), and AnalysisHandler::init(). { string out = s; std::transform(out.begin(), out.end(), out.begin(), (int(*)(int)) toupper); return out; }
Definition at line 157 of file LorentzTrans.hh. References LorentzTransform::transform(). Referenced by toLower(), and toUpper(). {
return lt.transform(v4);
}
Definition at line 336 of file MatrixN.hh. References Matrix< N >::transpose(). { // Matrix<N> tmp; // for (size_t i = 0; i < N; ++i) { // for (size_t j = 0; j < N; ++j) { // tmp.set(i, j, m.get(j, i)); // } // } // return tmp; return m.transpose(); }
Definition at line 39 of file RivetHepMC.hh. Referenced by vertices(). { vector<GenVertex*> rtn; for (GenEvent::vertex_const_iterator vi = ge.vertices_begin(); vi != ge.vertices_end(); ++vi) { rtn.push_back(*vi); } return rtn; }
Definition at line 46 of file RivetHepMC.hh. References vertices(). { assert(ge); return vertices(*ge); } Variable Documentation
Initial value:
Definition at line 71 of file Constants.hh. Definition at line 53 of file Constants.hh. Definition at line 52 of file Constants.hh. Definition at line 21 of file ParticleName.hh. Referenced by MC_SUSY::analyze(), CDF_2008_S8095620::init(), ATLAS_2011_I926145::init(), CDF_2006_S6653332::init(), and ParticleNames::ParticleNames().
Definition at line 19 of file ParticleName.hh. Referenced by ParticleNames::ParticleNames().
Definition at line 16 of file ParticleName.hh. Referenced by ParticleNames::_particleId(), and ParticleNames::ParticleNames(). Definition at line 42 of file ParticleName.hh. Referenced by ParticleNames::ParticleNames(). Definition at line 59 of file ParticleName.hh. Referenced by compatible(), AnalysisInfo::make(), ParticleNames::ParticleNames(), Beam::project(), and Projection::Projection().
Definition at line 20 of file Constants.hh.
Definition at line 69 of file Constants.hh. Definition at line 57 of file ParticleName.hh. Referenced by SLD_2004_S5693039::analyze(), CMS_2011_S8941262::analyze(), OPAL_1998_S3780481::analyze(), SLD_1999_S3743934::analyze(), CDF_2008_S8095620::analyze(), CDF_2006_S6653332::analyze(), and Jet::containsBottom().
Definition at line 26 of file Constants.hh. Referenced by ATLAS_2011_S9108483::analyze(), LHCB_2010_S8758301::getLongestLivedAncestor(), and LHCB_2011_I917009::getMotherLifeTimeSum(). Definition at line 27 of file Constants.hh.
Definition at line 67 of file Constants.hh.
Definition at line 42 of file Units.hh. Referenced by EXAMPLE::analyze().
Definition at line 56 of file ParticleName.hh. Referenced by SLD_2004_S5693039::analyze(), OPAL_1998_S3780481::analyze(), SLD_1999_S3743934::analyze(), and Jet::containsCharm(). Definition at line 72 of file Units.hh. Referenced by D0_1996_S3214044::_fourJetAnalysis(), D0_1996_S3214044::_threeJetAnalysis(), H1_2000_S4129130::analyze(), H1_1994_S2919893::analyze(), and H1_1994_S2919893::beamAngle(). Definition at line 53 of file ParticleName.hh. Referenced by SLD_2004_S5693039::analyze(), OPAL_1998_S3780481::analyze(), and SLD_1999_S3743934::analyze(). Definition at line 43 of file Constants.hh. Definition at line 13 of file ParticleName.hh. Referenced by WFinder::_init(), ParticleNames::_particleId(), IdentifiedFinalState::acceptChLeptons(), CDF_2008_S7541902::analyze(), ATLAS_2012_CONF_2012_104::analyze(), ATLAS_2012_I1186556::analyze(), ATLAS_2012_CONF_2012_105::analyze(), ATLAS_2012_I1095236::analyze(), ATLAS_2012_I1180197::analyze(), MC_SUSY::analyze(), ATLAS_2012_I943401::analyze(), CDF_2000_S4155203::init(), D0_2008_S6879055::init(), MC_ZJETS::init(), MC_ZZJETS::init(), MC_WWJETS::init(), MC_WJETS::init(), ATLAS_2011_I954993::init(), CDF_2008_S7540469::init(), ATLAS_2011_I925932::init(), D0_2001_S4674421::init(), D0_2007_S7075677::init(), D0_2008_S7554427::init(), ATLAS_2011_S9131140::init(), CDF_2008_S8095620::init(), D0_2000_S4480767::init(), D0_2009_S8202443::init(), MC_SUSY::init(), CDF_2009_S8383952::init(), ATLAS_2011_I926145::init(), D0_2008_S7837160::init(), D0_2010_S8821313::init(), MC_WPOL::init(), ATLAS_2010_S8919674::init(), ATLAS_2012_I1083318::init(), ATLAS_2011_I944826::init(), ATLAS_2011_S9108483::init(), CDF_2006_S6653332::init(), CDF_2008_S7541902::init(), ATLAS_2011_S9212183::init(), ATLAS_2012_I1125961::init(), ATLAS_2011_S9019561::init(), ATLAS_2012_I1095236::init(), ATLAS_2012_I1117704::init(), ATLAS_2011_CONF_2011_090::init(), ATLAS_2011_S8983313::init(), ATLAS_2012_CONF_2012_103::init(), ATLAS_2012_CONF_2012_001::init(), ATLAS_2011_S9212353::init(), ATLAS_2012_CONF_2012_105::init(), ATLAS_2011_S9225137::init(), ATLAS_2012_CONF_2012_104::init(), ATLAS_2012_I943401::init(), ATLAS_2012_I1180197::init(), ATLAS_2012_CONF_2012_109::init(), ATLAS_2012_I1112263::init(), ATLAS_2012_I1190891::init(), ATLAS_2012_I1186556::init(), ATLAS_2011_CONF_2011_098::init(), ATLAS_2012_I1126136::init(), ATLAS_2012_CONF_2012_153::init(), ATLAS_2011_I945498::init(), ATLAS_2011_S9041966::init(), ATLAS_2012_I1094568::init(), MC_VH2BB::init(), ParticleNames::ParticleNames(), and InitialQuarks::project().
Definition at line 42 of file Constants.hh.
Definition at line 68 of file Constants.hh.
Definition at line 49 of file Constants.hh.
Definition at line 65 of file Constants.hh. Definition at line 43 of file ParticleName.hh. Referenced by ATLAS_2012_CONF_2012_109::analyze(). Definition at line 44 of file ParticleName.hh.
Definition at line 102 of file Units.hh. Referenced by D0_2010_S8821313::analyze(). Definition at line 60 of file Constants.hh.
Definition at line 64 of file Units.hh. Referenced by BABAR_2005_S6181155::finalize(), ATLAS_2011_I954993::finalize(), ATLAS_2012_I946427::finalize(), CDF_2008_S7540469::finalize(), ATLAS_2012_CONF_2012_105::finalize(), ATLAS_2012_CONF_2012_104::finalize(), ATLAS_2012_I1186556::finalize(), ATLAS_2012_CONF_2012_103::finalize(), ATLAS_2012_I1117704::finalize(), ATLAS_2012_I1125961::finalize(), ATLAS_2012_I1095236::finalize(), ATLAS_2012_I1190891::finalize(), ATLAS_2012_I1126136::finalize(), ATLAS_2012_I1112263::finalize(), ATLAS_2012_CONF_2012_109::finalize(), ATLAS_2012_CONF_2012_001::finalize(), ATLAS_2011_S9225137::finalize(), ATLAS_2012_I943401::finalize(), ATLAS_2012_I1180197::finalize(), and ATLAS_2012_CONF_2012_153::finalize().
Definition at line 66 of file Constants.hh. Definition at line 48 of file ParticleName.hh.
Definition at line 121 of file Units.hh. Referenced by CDF_2004_S5839831::_calcTransCones(), CDF_1996_S3349578::_fiveJetAnalysis(), CDF_1996_S3349578::_fourJetAnalysis(), D0_1996_S3214044::_fourJetAnalysis(), Event::_geNormAlignment(), CDF_1996_S3349578::_threeJetAnalysis(), D0_1996_S3214044::_threeJetAnalysis(), ATLAS_2011_I894867::analyze(), MC_JetAnalysis::analyze(), PDG_HADRON_MULTIPLICITIES::analyze(), PDG_HADRON_MULTIPLICITIES_RATIOS::analyze(), H1_2000_S4129130::analyze(), CMS_2012_I1087342::analyze(), CMS_2011_S9088458::analyze(), CMS_2010_S8656010::analyze(), ATLAS_2010_S8591806::analyze(), CDF_2006_S6450792::analyze(), CMS_2011_S8941262::analyze(), LHCF_2012_I1115479::analyze(), ALICE_2011_S8909580::analyze(), STAR_2008_S7993412::analyze(), ALICE_2011_S8945144::analyze(), D0_2011_I895662::analyze(), CMS_2011_S9086218::analyze(), CMS_2011_S8957746::analyze(), H1_1994_S2919893::analyze(), CDF_2000_S4155203::analyze(), CDF_2007_S7057202::analyze(), CDF_2005_S6080774::analyze(), CMS_2010_S8547297::analyze(), D0_2007_S7075677::analyze(), ATLAS_2011_S9002537::analyze(), MC_DIPHOTON::analyze(), ATLAS_2011_S8994773::analyze(), D0_1996_S3324664::analyze(), D0_2000_S4480767::analyze(), D0_2010_S8671338::analyze(), CDF_1998_S3618439::analyze(), CDF_2000_S4266730::analyze(), CDF_2001_S4563131::analyze(), CMS_2012_I1102908::analyze(), CDF_1988_S1865951::analyze(), ATLAS_2010_CONF_2010_049::analyze(), CDF_2008_S7828950::analyze(), D0_2008_S6879055::analyze(), CDF_2001_S4517016::analyze(), ALICE_2010_S8706239::analyze(), CDF_1993_S2742446::analyze(), CDF_2008_S7540469::analyze(), CDF_2009_S8436959::analyze(), CDF_2012_NOTE10874::analyze(), CMS_2011_S8973270::analyze(), CMS_2011_S9215166::analyze(), MC_ZJETS::analyze(), LHCB_2011_I919315::analyze(), MC_DIJET::analyze(), MC_HJETS::analyze(), MC_LEADJETUE::analyze(), STAR_2006_S6500200::analyze(), CDF_2008_S7782535::analyze(), ALICE_2010_S8625980::analyze(), D0_2010_S8566488::analyze(), ATLAS_2011_I925932::analyze(), ALEPH_1996_S3196992::analyze(), ATLAS_2011_S8971293::analyze(), CDF_1996_S3108457::analyze(), CDF_1997_S3541940::analyze(), CDF_1996_S3418421::analyze(), ATLAS_2011_S9131140::analyze(), CDF_2009_S8233977::analyze(), CDF_1994_S2952106::analyze(), ATLAS_2011_I954993::analyze(), D0_2008_S7863608::analyze(), D0_2010_S8570965::analyze(), MC_PHOTONJETS::analyze(), MC_PHOTONS::analyze(), STAR_2006_S6860818::analyze(), CMS_2012_I1107658::analyze(), D0_2008_S7837160::analyze(), CMS_2011_S8884919::analyze(), MC_WJETS::analyze(), ATLAS_2010_S8817804::analyze(), D0_2008_S7662670::analyze(), ATLAS_2012_I1082009::analyze(), CMS_2011_S9120041::analyze(), EXAMPLE::analyze(), CDF_2005_S6217184::analyze(), D0_2009_S8349509::analyze(), D0_2009_S8202443::analyze(), UA1_1990_S2044935::analyze(), ALEPH_1999_S4193598::analyze(), D0_2004_S5992206::analyze(), ATLAS_2012_I1082936::analyze(), D0_2001_S4674421::analyze(), MC_PHOTONJETUE::analyze(), ATLAS_2011_S8924791::analyze(), ATLAS_2012_I1183818::analyze(), JADE_1998_S3612880::analyze(), MC_WPOL::analyze(), D0_1996_S3214044::analyze(), CDF_2010_S8591881_DY::analyze(), CDF_2010_S8591881_QCD::analyze(), CDF_2008_LEADINGJETS::analyze(), ATLAS_2012_CONF_2012_104::analyze(), ATLAS_2011_S9108483::analyze(), TASSO_1990_S2148048::analyze(), D0_2008_S7719523::analyze(), ATLAS_2012_I1190891::analyze(), MC_GENERIC::analyze(), ATLAS_2012_I1126136::analyze(), H1_1995_S3167097::analyze(), CDF_2008_NOTE_9351::analyze(), ATLAS_2012_I1186556::analyze(), ATLAS_2011_S9120807::analyze(), MC_TTBAR::analyze(), ATLAS_2011_S9212183::analyze(), STAR_2008_S7869363::analyze(), ATLAS_2012_CONF_2012_105::analyze(), CDF_1996_S3349578::analyze(), ATLAS_2011_CONF_2011_098::analyze(), ATLAS_2010_S8914702::analyze(), CDF_2001_S4751469::analyze(), ATLAS_2012_CONF_2012_103::analyze(), ATLAS_2012_I1112263::analyze(), ATLAS_2011_S9128077::analyze(), ATLAS_2012_I1125961::analyze(), MC_ZZJETS::analyze(), ATLAS_2012_I1095236::analyze(), ATLAS_2012_I1117704::analyze(), MC_WWJETS::analyze(), ATLAS_2012_CONF_2012_001::analyze(), ATLAS_2011_I926145::analyze(), ATLAS_2012_CONF_2012_109::analyze(), ATLAS_2012_I1180197::analyze(), ATLAS_2012_I1083318::analyze(), ATLAS_2011_S8983313::analyze(), ATLAS_2011_CONF_2011_090::analyze(), ATLAS_2011_S9019561::analyze(), ATLAS_2010_S8894728::analyze(), ATLAS_2010_S8919674::analyze(), OPAL_2001_S4553896::analyze(), ATLAS_2012_CONF_2012_153::analyze(), ATLAS_2011_I945498::analyze(), ATLAS_2012_I1091481::analyze(), MC_SUSY::analyze(), ATLAS_2011_S9212353::analyze(), ATLAS_2012_I943401::analyze(), MC_VH2BB::analyze(), ATLAS_2011_S9225137::analyze(), ATLAS_2010_S8918562::analyze(), ATLAS_2011_S9041966::analyze(), ATLAS_2012_I1093738::analyze(), ALEPH_1996_S3486095::analyze(), ATLAS_2012_I1094568::analyze(), ALEPH_2004_S5765862::analyze(), ATLAS_2011_I944826::analyze(), DELPHI_1996_S3430090::analyze(), CDF_2004_S5839831::analyze(), AnalysisHandler::analyze(), ATLAS_2011_S9126244::analyze(), ATLAS_2011_I919017::analyze(), ATLAS_2011_S9126244::analyzeJets(), InvMassFinalState::calc(), CDF_2009_S8057893::CDF_2009_S8057893::init(), ATLAS_2011_I944826::daughtersSurviveCuts(), ATLAS_2012_I1084540::fillMap(), ATLAS_2010_S8918562::fillPtEtaNch(), ALICE_2010_S8625980::finalize(), JADE_1998_S3612880::finalize(), UA1_1990_S2044935::finalize(), ATLAS_2010_S8918562::finalize(), CDF_2004_S5839831::finalize(), PDG_HADRON_MULTIPLICITIES_RATIOS::finalize(), PDG_HADRON_MULTIPLICITIES::finalize(), OPAL_2004_S6132243::getHistIndex(), ATLAS_2012_I1091481::getPionEnergy(), ATLAS_2010_S8894728::init(), CMS_2010_S8547297::init(), CMS_2010_S8656010::init(), ATLAS_2011_S8994773::init(), CMS_2011_S8978280::init(), CMS_2011_S8884919::init(), CMS_2011_S8941262::init(), ATLAS_2010_CONF_2010_049::init(), CMS_2011_S9215166::init(), CMS_2012_I1107658::init(), CMS_2011_S8957746::init(), ATLAS_2010_S8591806::init(), D0_2011_I895662::init(), CDF_2012_NOTE10874::init(), STAR_2008_S7993412::init(), CMS_QCD_10_024::init(), STAR_2006_S6500200::init(), ATLAS_2011_S9002537::init(), MC_DIJET::init(), CDF_2000_S4155203::init(), CDF_2005_S6080774::init(), SFM_1984_S1178091::init(), MC_DIPHOTON::init(), MC_JetAnalysis::init(), MC_ZJETS::init(), MC_HJETS::init(), UA5_1989_S1926373::init(), D0_2008_S6879055::init(), CDF_1993_S2742446::init(), MC_PHOTONJETS::init(), ATLAS_2012_I1091481::init(), MC_TTBAR::init(), MC_ZZJETS::init(), CDF_1988_S1865951::init(), MC_WJETS::init(), UA5_1986_S1583476::init(), MC_WWJETS::init(), MC_LEADJETUE::init(), MC_PHOTONJETUE::init(), CDF_1990_S2089246::init(), ATLAS_2011_I954993::init(), D0_2010_S8570965::init(), JADE_OPAL_2000_S4300807::init(), UA1_1990_S2044935::init(), CDF_2008_S7540469::init(), ATLAS_2011_I925932::init(), D0_2007_S7075677::init(), JADE_1998_S3612880::init(), ALEPH_2004_S5765862::init(), STAR_2009_UE_HELEN::init(), ALICE_2010_S8624100::init(), STAR_2006_S6860818::init(), D0_2008_S7863608::init(), MC_PHOTONS::init(), D0_2008_S7554427::init(), ATLAS_2011_S9131140::init(), D0_2010_S8671338::init(), ALICE_2010_S8625980::init(), MC_SUSY::init(), CDF_2008_S8095620::init(), CDF_2009_NOTE_9936::init(), D0_2009_S8349509::init(), D0_2009_S8202443::init(), D0_2000_S4480767::init(), EXAMPLE::init(), CDF_2009_S8383952::init(), CDF_2009_S8436959::init(), D0_2006_S6438750::init(), ATLAS_2011_I926145::init(), D0_2008_S7837160::init(), D0_2010_S8821313::init(), MC_WPOL::init(), ATLAS_2012_I1083318::init(), ATLAS_2011_I944826::init(), ATLAS_2010_S8919674::init(), UA5_1988_S1867512::init(), ATLAS_2011_S9212183::init(), CDF_2006_S6653332::init(), ATLAS_2011_S9108483::init(), CDF_2008_S7541902::init(), ATLAS_2012_I1125961::init(), ATLAS_2012_CONF_2012_109::init(), ATLAS_2012_I1180197::init(), ATLAS_2012_I1117704::init(), ATLAS_2012_I943401::init(), ATLAS_2012_I1112263::init(), ATLAS_2012_I1095236::init(), ATLAS_2011_S9225137::init(), ATLAS_2012_CONF_2012_103::init(), TASSO_1990_S2148048::init(), ATLAS_2012_CONF_2012_001::init(), ATLAS_2011_CONF_2011_090::init(), ATLAS_2012_I1190891::init(), ATLAS_2012_I946427::init(), ATLAS_2011_S8983313::init(), ATLAS_2012_CONF_2012_105::init(), ATLAS_2011_S9019561::init(), ATLAS_2011_S9212353::init(), ATLAS_2012_CONF_2012_104::init(), ATLAS_2012_I1186556::init(), ATLAS_2011_CONF_2011_098::init(), ATLAS_2012_I1084540::init(), D0_2008_S7719523::init(), CDF_2009_S8233977::init(), ATLAS_2012_I1126136::init(), CDF_2010_S8591881_DY::init(), ATLAS_2012_CONF_2012_153::init(), CDF_2008_NOTE_9351::init(), CDF_2010_S8591881_QCD::init(), CDF_2008_LEADINGJETS::init(), D0_2004_S5992206::init(), ATLAS_2010_S8914702::init(), CDF_2001_S4751469::init(), ATLAS_2011_S9120807::init(), ATLAS_2010_S8918562::init(), ATLAS_2011_I945498::init(), ATLAS_2011_S9041966::init(), ATLAS_2012_I1094568::init(), ATLAS_2012_I1093738::init(), STAR_2008_S7869363::init(), MC_VH2BB::init(), ATLAS_2011_I919017::init(), CDF_2004_S5839831::init(), PDG_HADRON_MULTIPLICITIES::init(), PDG_HADRON_MULTIPLICITIES_RATIOS::init(), JetAlg::jets(), NeutralFinalState::NeutralFinalState(), WFinder::project(), ATLAS_2011_I945498::selectJets(), AnalysisHandler::setRunBeams(), and toString(). Definition at line 128 of file Units.hh. Referenced by H1_1995_S3167097::_getbin(), H1_2000_S4129130::analyze(), H1_1994_S2919893::analyze(), CDF_2000_S4155203::analyze(), and H1_1995_S3167097::analyze().
Definition at line 47 of file ParticleName.hh. Referenced by isInvisibleFilter().
Definition at line 34 of file Constants.hh. Definition at line 14 of file Constants.hh.
A pre-defined value of Definition at line 53 of file MathHeader.hh.
Definition at line 35 of file Constants.hh.
Definition at line 36 of file Constants.hh.
Definition at line 37 of file Constants.hh.
Definition at line 52 of file ParticleName.hh. Referenced by ParticleNames::ParticleNames().
Definition at line 31 of file ParticleName.hh. Referenced by SLD_1999_S3743934::analyze(), OPAL_2000_S4418603::analyze(), STAR_2006_S6860818::analyze(), and STAR_2009_UE_HELEN::init(). Definition at line 32 of file ParticleName.hh. Referenced by SLD_1999_S3743934::analyze(), OPAL_2000_S4418603::analyze(), CMS_2011_S8978280::analyze(), STAR_2006_S6860818::analyze(), ATLAS_2011_I944826::analyze(), BABAR_2007_S7266081::findDecayProducts(), and ARGUS_1993_S2653028::findDecayProducts().
Definition at line 81 of file Constants.hh.
Definition at line 88 of file Constants.hh.
Definition at line 34 of file ParticleName.hh. Referenced by BABAR_2007_S7266081::findDecayProducts(). Definition at line 33 of file ParticleName.hh. Referenced by OPAL_1994_S2927284::analyze(), SLD_2004_S5693039::analyze(), SLD_1999_S3743934::analyze(), STAR_2006_S6860818::analyze(), BABAR_2007_S7266081::findDecayProducts(), ARGUS_1993_S2653028::findDecayProducts(), and ATLAS_2011_I944826::init(). Definition at line 35 of file ParticleName.hh. Referenced by SLD_1999_S3743934::analyze(), CMS_2011_S8978280::analyze(), STAR_2006_S6860818::analyze(), ATLAS_2011_I944826::analyze(), and ARGUS_1993_S2653028::findDecayProducts(). Definition at line 36 of file ParticleName.hh. Definition at line 46 of file Units.hh. Referenced by ALEPH_1991_S2435284::analyze(), CDF_1996_S3418421::analyze(), ATLAS_2012_I1082936::analyze(), ATLAS_2012_I1094568::analyze(), and operator<<(). Definition at line 47 of file Units.hh. Referenced by D0_1996_S3214044::_safeMass(), CDF_1997_S3541940::_safeMass(), CDF_1996_S3349578::_safeMass(), MC_ZZJETS::analyze(), and MC_WWJETS::analyze().
Definition at line 43 of file MathHeader.hh. Referenced by CMS_2012_I1102908::analyze(), D0_2004_S5992206::init(), and rapidity().
Definition at line 44 of file MathHeader.hh.
A sensible default maximum value of rapidity for Rivet analyses to use. Definition at line 24 of file Rivet.hh. Referenced by FinalState::FinalState(), CDF_2000_S4155203::init(), D0_2008_S6879055::init(), ALEPH_1996_S3196992::init(), D0_2007_S7075677::init(), JADE_1998_S3612880::init(), D0_2008_S7554427::init(), D0_2009_S8202443::init(), CDF_2009_S8383952::init(), MC_WPOL::init(), ATLAS_2011_I944826::init(), TASSO_1990_S2148048::init(), and UnstableFinalState::project().
Definition at line 120 of file Units.hh. Referenced by CMS_2011_S8957746::analyze(), LHCB_2011_I919315::analyze(), CDF_2009_S8233977::analyze(), LHCB_2010_S8758301::finalize(), ATLAS_2010_S8894728::init(), ATLAS_2011_S8994773::init(), CMS_2012_I1107658::init(), TOTEM_2012_I1115294::init(), CMS_2011_S9120041::init(), ATLAS_2012_I1183818::init(), MC_IDENTIFIED::init(), MC_GENERIC::init(), ATLAS_2011_I944826::init(), ATLAS_2010_S8918562::init(), and STARRandomFilter::operator()().
Definition at line 62 of file Units.hh. Referenced by CMS_2011_S8941262::finalize(), LHCB_2011_I919315::finalize(), ATLAS_2010_CONF_2010_049::finalize(), LHCB_2010_S8758301::finalize(), and ATLAS_2011_I919017::finalize().
Definition at line 61 of file Units.hh. Referenced by CDF_1988_S1865951::finalize(), ATLAS_2011_I894867::finalize(), CDF_2009_S8233977::finalize(), LHCB_2010_S8758301::finalize(), UA1_1990_S2044935::finalize(), and ATLAS_2012_I1084540::finalize().
Definition at line 38 of file Units.hh. Referenced by D0_2010_S8821313::analyze(), MC_ZZJETS::analyze(), and MC_WWJETS::analyze().
Definition at line 20 of file ParticleName.hh. Referenced by WFinder::_init(), IdentifiedFinalState::acceptChLeptons(), ATLAS_2012_CONF_2012_104::analyze(), ATLAS_2012_CONF_2012_105::analyze(), ATLAS_2012_I1180197::analyze(), ATLAS_2012_CONF_2012_153::analyze(), MC_SUSY::analyze(), ATLAS_2012_I943401::analyze(), CMS_2011_S8941262::init(), CMS_2011_S9215166::init(), CMS_2012_I1107658::init(), ATLAS_2011_S9002537::init(), MC_ZZJETS::init(), MC_WWJETS::init(), ATLAS_2011_I954993::init(), ATLAS_2011_I925932::init(), D0_2008_S7863608::init(), ATLAS_2011_S9131140::init(), D0_2010_S8671338::init(), CDF_2008_S8095620::init(), MC_SUSY::init(), D0_2009_S8349509::init(), ATLAS_2011_I926145::init(), D0_2010_S8821313::init(), ATLAS_2010_S8919674::init(), ATLAS_2011_I944826::init(), ATLAS_2012_I1083318::init(), ATLAS_2012_I1125961::init(), CDF_2006_S6653332::init(), ATLAS_2011_S9212183::init(), ATLAS_2012_I1112263::init(), ATLAS_2011_CONF_2011_090::init(), ATLAS_2011_S9225137::init(), ATLAS_2012_I1180197::init(), ATLAS_2012_CONF_2012_103::init(), ATLAS_2012_I1190891::init(), ATLAS_2011_S9019561::init(), ATLAS_2011_S8983313::init(), ATLAS_2012_I1117704::init(), ATLAS_2012_I943401::init(), ATLAS_2012_CONF_2012_104::init(), ATLAS_2012_CONF_2012_001::init(), ATLAS_2012_CONF_2012_109::init(), ATLAS_2011_S9212353::init(), ATLAS_2012_CONF_2012_105::init(), ATLAS_2012_I1095236::init(), ATLAS_2012_I1082009::init(), ATLAS_2011_CONF_2011_098::init(), ATLAS_2012_I1186556::init(), ATLAS_2012_I1126136::init(), ATLAS_2012_CONF_2012_153::init(), D0_2004_S5992206::init(), ATLAS_2011_I945498::init(), ATLAS_2011_S9041966::init(), ATLAS_2012_I1094568::init(), MC_VH2BB::init(), and ParticleNames::ParticleNames().
Definition at line 63 of file Units.hh. Referenced by CDF_2006_S6450792::finalize(), CDF_2008_S7828950::finalize(), CMS_2011_S8941262::finalize(), CDF_2001_S4563131::finalize(), CDF_2007_S7057202::finalize(), CDF_2001_S4517016::finalize(), ATLAS_2011_I926145::finalize(), and BELLE_2006_S6265367::finalize().
Definition at line 18 of file ParticleName.hh. Referenced by ParticleNames::_particleId(), STAR_2009_UE_HELEN::init(), and ParticleNames::ParticleNames().
Definition at line 51 of file Constants.hh.
Definition at line 22 of file ParticleName.hh. Referenced by WFinder::_init(), IdentifiedFinalState::acceptNeutrinos(), CDF_2008_S7541902::analyze(), D0_2001_S4674421::init(), ATLAS_2012_I1083318::init(), ATLAS_2010_S8919674::init(), CDF_2008_S7541902::init(), ParticleNames::ParticleNames(), and VetoedFinalState::vetoNeutrinos(). Definition at line 23 of file ParticleName.hh. Referenced by D0_2001_S4674421::init(), CDF_2008_S7541902::init(), and ParticleNames::ParticleNames(). Definition at line 24 of file ParticleName.hh. Referenced by WFinder::_init(), IdentifiedFinalState::acceptNeutrinos(), ATLAS_2012_I1083318::init(), ATLAS_2010_S8919674::init(), ParticleNames::ParticleNames(), and VetoedFinalState::vetoNeutrinos(). Definition at line 25 of file ParticleName.hh. Referenced by ParticleNames::ParticleNames(). Definition at line 26 of file ParticleName.hh. Referenced by IdentifiedFinalState::acceptNeutrinos(), ParticleNames::ParticleNames(), and VetoedFinalState::vetoNeutrinos(). Definition at line 27 of file ParticleName.hh. Referenced by ParticleNames::ParticleNames().
Definition at line 39 of file ParticleName.hh. Referenced by STAR_2006_S6860818::analyze(). Definition at line 40 of file ParticleName.hh. Definition at line 45 of file ParticleName.hh. Referenced by ATLAS_2011_I944826::init(). Definition at line 46 of file ParticleName.hh.
Definition at line 17 of file ParticleName.hh. Referenced by ParticleNames::_particleId(), OPAL_1993_S2692198::analyze(), CDF_2008_S7540469::analyze(), ATLAS_2012_CONF_2012_109::analyze(), ClusteredPhotons::ClusteredPhotons(), CDF_2005_S6080774::init(), MC_DIPHOTON::init(), CDF_1993_S2742446::init(), MC_PHOTONJETS::init(), ALEPH_1996_S3196992::init(), MC_PHOTONJETUE::init(), D0_2010_S8570965::init(), MC_PHOTONS::init(), MC_SUSY::init(), CDF_2009_S8436959::init(), D0_2006_S6438750::init(), ATLAS_2012_I946427::init(), D0_2008_S7719523::init(), ATLAS_2010_S8914702::init(), ATLAS_2011_S9120807::init(), ATLAS_2012_I1093738::init(), isInvisibleFilter(), LeptonClusters::LeptonClusters(), and ParticleNames::ParticleNames().
Definition at line 12 of file Constants.hh. Referenced by Jet::containsBottom(), Jet::containsCharm(), particles(), FoxWolframMoments::project(), ProjectionHandler::removeProjectionApplier(), and ATLAS_2011_S9108483::rndGauss().
A pre-defined value of Definition at line 47 of file MathHeader.hh. Referenced by Spherocity::_calcSpherocity(), CDF_2004_S5839831::_calcTransCones(), H1_1994_S2919893::analyze(), ATLAS_2011_S8994773::analyze(), CDF_2012_NOTE10874::analyze(), CMS_2011_S8973270::analyze(), CMS_2011_S9215166::analyze(), MC_LEADJETUE::analyze(), CDF_1994_S2952106::analyze(), CMS_2011_S9120041::analyze(), STAR_2009_UE_HELEN::analyze(), MC_PHOTONJETUE::analyze(), CDF_2010_S8591881_DY::analyze(), CDF_2010_S8591881_QCD::analyze(), CDF_2008_LEADINGJETS::analyze(), ATLAS_2012_I1126136::analyze(), CDF_2008_NOTE_9351::analyze(), ATLAS_2010_S8914702::analyze(), CDF_2001_S4751469::analyze(), ATLAS_2010_S8894728::analyze(), ATLAS_2012_I1093738::analyze(), Vector3::azimuthalAngle(), CMS_2011_S8973270::finalize(), MC_ZZJETS::init(), MC_PHOTONJETUE::init(), MC_WWJETS::init(), MC_SUSY::init(), mapAngle0ToPi(), mapAngleMPiToPi(), Vector3::polarAngle(), DISKinematics::project(), CDF_2012_NOTE10874::region_index(), ATLAS_2010_S8894728::region_index(), and ATLAS_2011_S8994773::region_index(). Definition at line 30 of file ParticleName.hh. Referenced by ATLAS_2012_CONF_2012_109::analyze(), and BABAR_2007_S7266081::findDecayProducts(). Definition at line 15 of file Constants.hh.
Definition at line 59 of file Units.hh. Referenced by CDF_2000_S4155203::finalize(), CMS_2012_I1087342::finalize(), CDF_1998_S3618439::finalize(), STAR_2006_S6870392::finalize(), CDF_2000_S4266730::finalize(), D0_2011_I895662::finalize(), CLEO_2004_S5809304::finalize(), ATLAS_2010_S8817804::finalize(), ATLAS_2012_I1082936::finalize(), D0_2001_S4674421::finalize(), BELLE_2006_S6265367::finalize(), ATLAS_2011_I945498::finalize(), ATLAS_2011_S9019561::finalize(), ATLAS_2011_S8983313::finalize(), and ATLAS_2011_CONF_2011_090::finalize().
Definition at line 29 of file ParticleName.hh. Referenced by BABAR_2007_S7266081::findDecayProducts(), and ParticleNames::ParticleNames(). Definition at line 28 of file ParticleName.hh. Referenced by OPAL_1994_S2927284::analyze(), SLD_2004_S5693039::analyze(), SLD_1999_S3743934::analyze(), STAR_2006_S6860818::analyze(), ARGUS_1993_S2653028::findDecayProducts(), BABAR_2007_S7266081::findDecayProducts(), STAR_2006_S6500200::init(), ATLAS_2011_I944826::init(), and ParticleNames::ParticleNames(). Definition at line 14 of file ParticleName.hh. Referenced by ParticleNames::_particleId(), MC_SUSY::analyze(), D0_2001_S4674421::init(), CDF_2008_S8095620::init(), ATLAS_2011_I926145::init(), CDF_2006_S6653332::init(), CDF_2008_S7541902::init(), and ParticleNames::ParticleNames(). Definition at line 15 of file ParticleName.hh. Referenced by Event::_geNormAlignment(), ParticleNames::_particleId(), OPAL_1994_S2927284::analyze(), SLD_2004_S5693039::analyze(), SLD_1999_S3743934::analyze(), STAR_2006_S6860818::analyze(), ARGUS_1993_S2653028::findDecayProducts(), STAR_2006_S6500200::init(), and ParticleNames::ParticleNames().
Definition at line 50 of file Constants.hh. Definition at line 96 of file Units.hh. Referenced by _calcS(), BABAR_2007_S6895344::analyze(), BABAR_2005_S6181155::analyze(), BELLE_2006_S6265367::analyze(), CLEO_2004_S5809304::analyze(), ARGUS_1993_S2789213::analyze(), ARGUS_1993_S2669951::analyze(), EXAMPLE::analyze(), JADE_1998_S3612880::analyze(), JADE_1998_S3612880::finalize(), main(), AnalysisInfo::make(), mt2::mt2_massless(), toLower(), and toUpper().
Definition at line 85 of file Units.hh. Referenced by Sphericity::_calcSphericity(), UA5_1982_S875503::finalize(), EigenSystem< N >::getEigenVectors(), UA5_1982_S875503::init(), and D0_2010_S8570965::init(). Definition at line 55 of file ParticleName.hh. Referenced by SLD_2004_S5693039::analyze(), OPAL_1998_S3780481::analyze(), and SLD_1999_S3743934::analyze().
Definition at line 87 of file Constants.hh.
Definition at line 86 of file Constants.hh. Definition at line 41 of file ParticleName.hh. Referenced by IdentifiedFinalState::acceptChLeptons(), MC_HJETS::init(), and ParticleNames::ParticleNames().
Definition at line 122 of file Units.hh. Referenced by CMS_2011_S9088458::analyze(), D0_2010_S8566488::analyze(), CMS_2011_S9120041::analyze(), ATLAS_2012_I1082936::analyze(), ATLAS_2010_S8894728::analyze(), CMS_2011_S9120041::finalize(), ATLAS_2010_S8894728::init(), ATLAS_2011_S8994773::init(), CMS_2011_S9120041::init(), ATLAS_2012_I1091481::init(), and LHCB_2011_I917009::init(). Definition at line 58 of file ParticleName.hh. Definition at line 13 of file Constants.hh.
A pre-defined value of Definition at line 50 of file MathHeader.hh. Referenced by _mapAngleM2PITo2Pi(), LHCF_2012_I1115479::analyze(), H1_1994_S2919893::analyze(), CDF_1988_S1865951::analyze(), ALICE_2010_S8706239::analyze(), CDF_2009_S8233977::analyze(), UA1_1990_S2044935::analyze(), STAR_2008_S7869363::analyze(), ATLAS_2010_S8591806::finalize(), ATLAS_2010_S8918562::finalize(), MC_HJETS::init(), MC_ZJETS::init(), MC_ZZJETS::init(), MC_WJETS::init(), MC_WWJETS::init(), MC_GENERIC::init(), mapAngle0To2Pi(), and mapAngleMPiToPi().
Initial value:
Definition at line 75 of file Constants.hh.
Definition at line 93 of file Constants.hh. Definition at line 54 of file ParticleName.hh. Referenced by SLD_2004_S5693039::analyze(), OPAL_1998_S3780481::analyze(), and SLD_1999_S3743934::analyze().
Definition at line 50 of file ParticleName.hh. Referenced by ParticleNames::ParticleNames(), and WFinder::project().
Definition at line 49 of file ParticleName.hh. Referenced by ParticleNames::ParticleNames(), and WFinder::project(). Definition at line 37 of file ParticleName.hh. Referenced by CMS_2011_S8978280::analyze(), and STAR_2006_S6860818::analyze(). Definition at line 38 of file ParticleName.hh. Definition at line 51 of file ParticleName.hh. Referenced by ParticleNames::ParticleNames(), InitialQuarks::project(), and ZFinder::project(). Generated on Fri Dec 21 2012 15:03:50 for The Rivet MC analysis system by ![]() |