CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Pages
List of all members | Classes | Public Member Functions | Static Public Member Functions | Static Public Attributes
MuScleFitUtils Class Reference

#include <MuScleFitUtils.h>

Classes

struct  byPt
 
struct  massResolComponentsStruct
 

Public Member Functions

 MuScleFitUtils ()
 
virtual ~MuScleFitUtils ()
 

Static Public Member Functions

static lorentzVector applyBias (const lorentzVector &muon, const int charge)
 
static lorentzVector applyScale (const lorentzVector &muon, const std::vector< double > &parval, const int charge)
 
static lorentzVector applyScale (const lorentzVector &muon, double *parval, const int charge)
 
static lorentzVector applySmearing (const lorentzVector &muon)
 
static bool checkMassWindow (const double &mass, const double &leftBorder, const double &rightBorder)
 Method to check if the mass value is within the mass window of the i-th resonance. More...
 
static double computeWeight (const double &mass, const int iev, const bool doUseBkgrWindow=false)
 
static double deltaPhi (const double &phi1, const double &phi2)
 
static double deltaPhiNoFabs (const double &phi1, const double &phi2)
 Without fabs at the end, used to have a symmetric distribution for the resolution fits and variance computations. More...
 
static double deltaR (const double &eta1, const double &eta2, const double &phi1, const double &phi2)
 
static std::pair
< MuScleFitMuon, MuScleFitMuon
findBestRecoRes (const std::vector< MuScleFitMuon > &muons)
 
static std::pair< SimTrack,
SimTrack
findBestSimuRes (const std::vector< SimTrack > &simMuons)
 
static std::pair
< lorentzVector, lorentzVector
findGenMuFromRes (const reco::GenParticleCollection *genParticles)
 
static std::pair
< lorentzVector, lorentzVector
findGenMuFromRes (const edm::HepMCProduct *evtMC)
 
static std::pair
< lorentzVector, lorentzVector
findSimMuFromRes (const edm::Handle< edm::HepMCProduct > &evtMC, const edm::Handle< edm::SimTrackContainer > &simTracks)
 
static std::vector
< TGraphErrors * > 
fitMass (TH2F *histo)
 
static std::vector
< TGraphErrors * > 
fitReso (TH2F *histo)
 
static lorentzVector fromPtEtaPhiToPxPyPz (const double *ptEtaPhiE)
 
static double invDimuonMass (const lorentzVector &mu1, const lorentzVector &mu2)
 
static double massProb (const double &mass, const double &rapidity, const int ires, const double &massResol)
 
static double massProb (const double &mass, const double &resEta, const double &rapidity, const double &massResol, const std::vector< double > &parval, const bool doUseBkgrWindow, const double &eta1, const double &eta2)
 
static double massProb (const double &mass, const double &resEta, const double &rapidity, const double &massResol, double *parval, const bool doUseBkgrWindow, const double &eta1, const double &eta2)
 
static double massResolution (const lorentzVector &mu1, const lorentzVector &mu2)
 
static double massResolution (const lorentzVector &mu1, const lorentzVector &mu2, const std::vector< double > &parval)
 
static double massResolution (const lorentzVector &mu1, const lorentzVector &mu2, std::auto_ptr< double > parval)
 
static double massResolution (const lorentzVector &mu1, const lorentzVector &mu2, double *parval)
 
static double massResolution (const lorentzVector &mu1, const lorentzVector &mu2, const ResolutionFunction &resolFunc)
 
static void minimizeLikelihood ()
 
static double probability (const double &mass, const double &massResol, const double GLvalue[][1001][1001], const double GLnorm[][1001], const int iRes, const int iY)
 Computes the probability given the mass, mass resolution and the arrays with the probabilities and the normalizations. More...
 

Static Public Attributes

static const int backgroundFunctionsRegions
 
static BackgroundHandlerbackgroundHandler
 
static TH1D * backgroundProb_ = 0
 
static int BgrFitType = 0
 
static scaleFunctionBase
< std::vector< double > > * 
biasFunction = 0
 
static int BiasType = 0
 
static bool computeMinosErrors_
 
static int counter_resprob = 0
 
static double crossSection [6]
 
static CrossSectionHandlercrossSectionHandler
 
static int debug = 0
 
static bool debugMassResol_
 
static double deltaPhiMaxCut_ = 100.
 
static double deltaPhiMinCut_ = -100.
 
static std::vector< int > doBackgroundFit
 
static std::vector< int > doCrossSectionFit
 
static std::vector< int > doResolFit
 
static std::vector< int > doScaleFit
 
static bool duringMinos_ = false
 
static int FitStrategy = 1
 
static std::vector< std::pair
< MuScleFitMuon, MuScleFitMuon > > 
genMuscleFitPair
 
static std::vector< std::pair
< lorentzVector, lorentzVector > > 
genPair
 
static double GLNorm [6][1001]
 
static double GLValue [6][1001][1001]
 
static double GLZNorm [40][1001]
 
static double GLZValue [40][1001][1001]
 
static int goodmuon = 0
 
static int iev_ = 0
 
static TH1D * likelihoodInLoop_ = 0
 
static unsigned int loopCounter = 5
 
static struct
MuScleFitUtils::massResolComponentsStruct 
massResolComponents
 
static double massWindowHalfWidth [3][6]
 
static double maxMuonEtaFirstRange_ = 6.
 
static double maxMuonEtaSecondRange_ = 100.
 
static double maxMuonPt_ = 100000000.
 
static bool minimumShapePlots_
 
static double minMuonEtaFirstRange_ = -6.
 
static double minMuonEtaSecondRange_ = -100.
 
static double minMuonPt_ = 0.
 
static int minuitLoop_ = 0
 
static const double mMu2 = 0.011163612
 
static const unsigned int motherPdgIdArray [6] = {23, 100553, 100553, 553, 100443, 443}
 
static const double muMass = 0.105658
 
static int MuonType
 
static int MuonTypeForCheckMassWindow
 
static int nbins = 1000
 
static unsigned int normalizationChanged_ = 0
 
static bool normalizeLikelihoodByEventNumber_ = true
 
static double oldNormalization_ = 0.
 
static std::vector< double > parBgr
 
static std::vector< int > parBgrFix
 
static std::vector< int > parBgrOrder
 
static std::vector< double > parBias
 
static std::vector< double > parCrossSection
 
static std::vector< int > parCrossSectionFix
 
static std::vector< int > parCrossSectionOrder
 
static std::vector< int > parfix
 
static std::vector< int > parorder
 
static std::vector< double > parResol
 
static std::vector< int > parResolFix
 
static std::vector< double > parResolMax
 
static std::vector< double > parResolMin
 
static std::vector< int > parResolOrder
 
static std::vector< double > parResolStep
 
static std::vector< double > parScale
 
static std::vector< int > parScaleFix
 
static std::vector< double > parScaleMax
 
static std::vector< double > parScaleMin
 
static std::vector< int > parScaleOrder
 
static std::vector< double > parScaleStep
 
static std::vector< double > parSmear
 
static std::vector
< std::vector< double > > 
parvalue
 
static bool rapidityBinsForZ_ = true
 
static std::vector< std::pair
< lorentzVector, lorentzVector > > 
ReducedSavedPair
 
static std::vector< int > resfind
 
static bool ResFound = false
 
static double ResGamma [6] = {2.4952, 0.000020, 0.000032, 0.000054, 0.000317, 0.0000932 }
 
static double ResHalfWidth [6]
 
static double ResMass [6] = {91.1876, 10.3552, 10.0233, 9.4603, 3.68609, 3.0969}
 
static double ResMaxSigma [6]
 
static double ResMinMass [6] = {-99, -99, -99, -99, -99, -99}
 
static int ResolFitType = 0
 
static resolutionFunctionBase
< double * > * 
resolutionFunction = 0
 
static resolutionFunctionBase
< std::vector< double > > * 
resolutionFunctionForVec = 0
 
static TMinuit * rminPtr_ = 0
 
static std::vector< std::pair
< lorentzVector, lorentzVector > > 
SavedPair
 
static std::vector< std::pair
< MuScleFitMuon, MuScleFitMuon > > 
SavedPairMuScleFitMuons
 
static bool scaleFitNotDone_ = true
 
static int ScaleFitType = 0
 
static scaleFunctionBase
< double * > * 
scaleFunction = 0
 
static scaleFunctionBase
< std::vector< double > > * 
scaleFunctionForVec = 0
 
static bool separateRanges_ = true
 
static bool sherpa_ = false
 
static TH1D * signalProb_ = 0
 
static std::vector< std::pair
< lorentzVector, lorentzVector > > 
simPair
 
static smearFunctionBasesmearFunction = 0
 
static int SmearType = 0
 
static bool speedup = false
 
static bool startWithSimplex_
 
static const int totalResNum = 6
 
static bool useProbsFile_ = true
 
static double x [7][10000]
 

Detailed Description

Definition at line 48 of file MuScleFitUtils.h.

Constructor & Destructor Documentation

MuScleFitUtils::MuScleFitUtils ( )
inline

Definition at line 53 of file MuScleFitUtils.h.

virtual MuScleFitUtils::~MuScleFitUtils ( )
inlinevirtual

Definition at line 57 of file MuScleFitUtils.h.

Member Function Documentation

lorentzVector MuScleFitUtils::applyBias ( const lorentzVector muon,
const int  charge 
)
static

Definition at line 440 of file MuScleFitUtils.cc.

lorentzVector MuScleFitUtils::applyScale ( const lorentzVector muon,
const std::vector< double > &  parval,
const int  charge 
)
static

Definition at line 460 of file MuScleFitUtils.cc.

lorentzVector MuScleFitUtils::applyScale ( const lorentzVector muon,
double *  parval,
const int  charge 
)
static

Definition at line 480 of file MuScleFitUtils.cc.

lorentzVector MuScleFitUtils::applySmearing ( const lorentzVector muon)
static

Definition at line 410 of file MuScleFitUtils.cc.

bool MuScleFitUtils::checkMassWindow ( const double &  mass,
const double &  leftBorder,
const double &  rightBorder 
)
inlinestatic

Method to check if the mass value is within the mass window of the i-th resonance.

Definition at line 1098 of file MuScleFitUtils.cc.

double MuScleFitUtils::computeWeight ( const double &  mass,
const int  iev,
const bool  doUseBkgrWindow = false 
)
static

Definition at line 1105 of file MuScleFitUtils.cc.

static double MuScleFitUtils::deltaPhi ( const double &  phi1,
const double &  phi2 
)
inlinestatic

Definition at line 93 of file MuScleFitUtils.h.

static double MuScleFitUtils::deltaPhiNoFabs ( const double &  phi1,
const double &  phi2 
)
inlinestatic

Without fabs at the end, used to have a symmetric distribution for the resolution fits and variance computations.

Definition at line 101 of file MuScleFitUtils.h.

static double MuScleFitUtils::deltaR ( const double &  eta1,
const double &  eta2,
const double &  phi1,
const double &  phi2 
)
inlinestatic

Definition at line 108 of file MuScleFitUtils.h.

std::pair< MuScleFitMuon, MuScleFitMuon > MuScleFitUtils::findBestRecoRes ( const std::vector< MuScleFitMuon > &  muons)
static

Definition at line 308 of file MuScleFitUtils.cc.

std::pair< SimTrack, SimTrack > MuScleFitUtils::findBestSimuRes ( const std::vector< SimTrack > &  simMuons)
static

Definition at line 271 of file MuScleFitUtils.cc.

std::pair< lorentzVector, lorentzVector > MuScleFitUtils::findGenMuFromRes ( const reco::GenParticleCollection genParticles)
static

Definition at line 2266 of file MuScleFitUtils.cc.

Referenced by MuScleFitGenFilter::filter().

std::pair< lorentzVector, lorentzVector > MuScleFitUtils::findGenMuFromRes ( const edm::HepMCProduct evtMC)
static

Definition at line 2228 of file MuScleFitUtils.cc.

std::pair< lorentzVector, lorentzVector > MuScleFitUtils::findSimMuFromRes ( const edm::Handle< edm::HepMCProduct > &  evtMC,
const edm::Handle< edm::SimTrackContainer > &  simTracks 
)
static

Definition at line 2190 of file MuScleFitUtils.cc.

std::vector< TGraphErrors * > MuScleFitUtils::fitMass ( TH2F *  histo)
static

Definition at line 1909 of file MuScleFitUtils.cc.

std::vector< TGraphErrors * > MuScleFitUtils::fitReso ( TH2F *  histo)
static

Definition at line 2022 of file MuScleFitUtils.cc.

lorentzVector MuScleFitUtils::fromPtEtaPhiToPxPyPz ( const double *  ptEtaPhiE)
static

Definition at line 499 of file MuScleFitUtils.cc.

double MuScleFitUtils::invDimuonMass ( const lorentzVector mu1,
const lorentzVector mu2 
)
inlinestatic

Definition at line 516 of file MuScleFitUtils.cc.

double MuScleFitUtils::massProb ( const double &  mass,
const double &  rapidity,
const int  ires,
const double &  massResol 
)
static

Definition at line 2132 of file MuScleFitUtils.cc.

double MuScleFitUtils::massProb ( const double &  mass,
const double &  resEta,
const double &  rapidity,
const double &  massResol,
const std::vector< double > &  parval,
const bool  doUseBkgrWindow,
const double &  eta1,
const double &  eta2 
)
static

Definition at line 705 of file MuScleFitUtils.cc.

double MuScleFitUtils::massProb ( const double &  mass,
const double &  resEta,
const double &  rapidity,
const double &  massResol,
double *  parval,
const bool  doUseBkgrWindow,
const double &  eta1,
const double &  eta2 
)
static

Definition at line 870 of file MuScleFitUtils.cc.

static double MuScleFitUtils::massResolution ( const lorentzVector mu1,
const lorentzVector mu2 
)
static
double MuScleFitUtils::massResolution ( const lorentzVector mu1,
const lorentzVector mu2,
const std::vector< double > &  parval 
)
static

Definition at line 524 of file MuScleFitUtils.cc.

static double MuScleFitUtils::massResolution ( const lorentzVector mu1,
const lorentzVector mu2,
std::auto_ptr< double >  parval 
)
static
double MuScleFitUtils::massResolution ( const lorentzVector mu1,
const lorentzVector mu2,
double *  parval 
)
static

We use the following formula:

M = sqrt ( (E1+E2)^2 - (P1+P2)^2 )

where we express E and P as a function of Pt, phi, and theta:

E = sqrt ( Pt^2*(1+cotg(theta)^2) + M_mu^2 )
Px = Pt*cos(phi), Py = Pt*sin(phi), Pz = Pt*cotg(theta)

from which we find

M = sqrt( 2*M_mu^2 + 2*sqrt(Pt1^2/sin(theta1)^2 + M_mu^2)*sqrt(Pt2^2/sin(theta2)^2 + M_mu^2) - 2*Pt1*Pt2* ( cos(phi1-phi2) + cotg(theta1)*cotg(theta2) ) )

and derive WRT Pt1, Pt2, phi1, phi2, theta1, theta2 to get the resolution.

Definition at line 568 of file MuScleFitUtils.cc.

double MuScleFitUtils::massResolution ( const lorentzVector mu1,
const lorentzVector mu2,
const ResolutionFunction resolFunc 
)
static

This method can be used outside MuScleFit. It gets the ResolutionFunction that must have been built with the parameters.
TO-DO: this method duplicates the code in the previous method. It should be changed to avoid the duplication.

Definition at line 657 of file MuScleFitUtils.cc.

void MuScleFitUtils::minimizeLikelihood ( )
static

Definition at line 1138 of file MuScleFitUtils.cc.

double MuScleFitUtils::probability ( const double &  mass,
const double &  massResol,
const double  GLvalue[][1001][1001],
const double  GLnorm[][1001],
const int  iRes,
const int  iY 
)
static

Computes the probability given the mass, mass resolution and the arrays with the probabilities and the normalizations.

After the introduction of the rapidity bins for the Z the probability method works in the following way:

  • if passing iRes == 0, iY is used to select the rapidity bin
  • if passing iRes != 0, iY is used to select the resonance

Definition at line 739 of file MuScleFitUtils.cc.

Referenced by MuScleFitBase::ProbForIntegral::operator()().

Member Data Documentation

const int MuScleFitUtils::backgroundFunctionsRegions
static

Definition at line 146 of file MuScleFitUtils.h.

BackgroundHandler * MuScleFitUtils::backgroundHandler
static

Definition at line 158 of file MuScleFitUtils.h.

TH1D * MuScleFitUtils::backgroundProb_ = 0
static

Definition at line 169 of file MuScleFitUtils.h.

int MuScleFitUtils::BgrFitType = 0
static

Definition at line 141 of file MuScleFitUtils.h.

scaleFunctionBase< std::vector< double > > * MuScleFitUtils::biasFunction = 0
static

Definition at line 134 of file MuScleFitUtils.h.

int MuScleFitUtils::BiasType = 0
static

Definition at line 132 of file MuScleFitUtils.h.

bool MuScleFitUtils::computeMinosErrors_
static

Definition at line 264 of file MuScleFitUtils.h.

int MuScleFitUtils::counter_resprob = 0
static

Definition at line 198 of file MuScleFitUtils.h.

double MuScleFitUtils::crossSection[6]
static

Definition at line 121 of file MuScleFitUtils.h.

CrossSectionHandler * MuScleFitUtils::crossSectionHandler
static

Definition at line 154 of file MuScleFitUtils.h.

int MuScleFitUtils::debug = 0
static

Definition at line 113 of file MuScleFitUtils.h.

bool MuScleFitUtils::debugMassResol_
static

Definition at line 251 of file MuScleFitUtils.h.

double MuScleFitUtils::deltaPhiMaxCut_ = 100.
static

Definition at line 249 of file MuScleFitUtils.h.

double MuScleFitUtils::deltaPhiMinCut_ = -100.
static

Definition at line 248 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::doBackgroundFit
static

Definition at line 164 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::doCrossSectionFit
static

Definition at line 163 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::doResolFit
static

Definition at line 161 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::doScaleFit
static

Definition at line 162 of file MuScleFitUtils.h.

bool MuScleFitUtils::duringMinos_ = false
static

Definition at line 171 of file MuScleFitUtils.h.

int MuScleFitUtils::FitStrategy = 1
static

Definition at line 194 of file MuScleFitUtils.h.

std::vector< std::pair< MuScleFitMuon, MuScleFitMuon > > MuScleFitUtils::genMuscleFitPair
static

Definition at line 218 of file MuScleFitUtils.h.

std::vector< std::pair< lorentzVector, lorentzVector > > MuScleFitUtils::genPair
static

Definition at line 216 of file MuScleFitUtils.h.

double MuScleFitUtils::GLNorm
static

Definition at line 202 of file MuScleFitUtils.h.

Referenced by MuScleFitBase::ProbForIntegral::operator()().

double MuScleFitUtils::GLValue
static

Definition at line 201 of file MuScleFitUtils.h.

Referenced by MuScleFitBase::ProbForIntegral::operator()().

double MuScleFitUtils::GLZNorm
static

Definition at line 200 of file MuScleFitUtils.h.

Referenced by MuScleFitBase::ProbForIntegral::operator()().

double MuScleFitUtils::GLZValue
static

Definition at line 199 of file MuScleFitUtils.h.

Referenced by MuScleFitBase::ProbForIntegral::operator()().

int MuScleFitUtils::goodmuon = 0
static

Definition at line 197 of file MuScleFitUtils.h.

Referenced by ResolutionAnalyzer::fillMuonCollection().

int MuScleFitUtils::iev_ = 0
static

Definition at line 236 of file MuScleFitUtils.h.

TH1D * MuScleFitUtils::likelihoodInLoop_ = 0
static

Definition at line 167 of file MuScleFitUtils.h.

unsigned int MuScleFitUtils::loopCounter = 5
static

Definition at line 128 of file MuScleFitUtils.h.

MuScleFitUtils::massResolComponentsStruct MuScleFitUtils::massResolComponents
static

Definition at line 254 of file MuScleFitUtils.cc.

double MuScleFitUtils::massWindowHalfWidth
static

Definition at line 117 of file MuScleFitUtils.h.

double MuScleFitUtils::maxMuonEtaFirstRange_ = 6.
static

Definition at line 245 of file MuScleFitUtils.h.

double MuScleFitUtils::maxMuonEtaSecondRange_ = 100.
static

Definition at line 247 of file MuScleFitUtils.h.

double MuScleFitUtils::maxMuonPt_ = 100000000.
static

Definition at line 243 of file MuScleFitUtils.h.

bool MuScleFitUtils::minimumShapePlots_
static

Definition at line 265 of file MuScleFitUtils.h.

double MuScleFitUtils::minMuonEtaFirstRange_ = -6.
static

Definition at line 244 of file MuScleFitUtils.h.

double MuScleFitUtils::minMuonEtaSecondRange_ = -100.
static

Definition at line 246 of file MuScleFitUtils.h.

double MuScleFitUtils::minMuonPt_ = 0.
static

Definition at line 242 of file MuScleFitUtils.h.

int MuScleFitUtils::minuitLoop_ = 0
static

Definition at line 166 of file MuScleFitUtils.h.

const double MuScleFitUtils::mMu2 = 0.011163612
static

Definition at line 122 of file MuScleFitUtils.h.

Referenced by ResolutionAnalyzer::fillMuonCollection().

const unsigned int MuScleFitUtils::motherPdgIdArray = {23, 100553, 100553, 553, 100443, 443}
static

Definition at line 126 of file MuScleFitUtils.h.

const double MuScleFitUtils::muMass = 0.105658
static

Definition at line 123 of file MuScleFitUtils.h.

int MuScleFitUtils::MuonType
static

Definition at line 206 of file MuScleFitUtils.h.

int MuScleFitUtils::MuonTypeForCheckMassWindow
static

Definition at line 207 of file MuScleFitUtils.h.

int MuScleFitUtils::nbins = 1000
static

Definition at line 205 of file MuScleFitUtils.h.

unsigned int MuScleFitUtils::normalizationChanged_ = 0
static

Definition at line 228 of file MuScleFitUtils.h.

bool MuScleFitUtils::normalizeLikelihoodByEventNumber_ = true
static

Definition at line 223 of file MuScleFitUtils.h.

double MuScleFitUtils::oldNormalization_ = 0.
static

Definition at line 227 of file MuScleFitUtils.h.

std::vector< double > MuScleFitUtils::parBgr
static

Definition at line 184 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::parBgrFix
static

Definition at line 188 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::parBgrOrder
static

Definition at line 192 of file MuScleFitUtils.h.

std::vector< double > MuScleFitUtils::parBias
static

Definition at line 174 of file MuScleFitUtils.h.

std::vector< double > MuScleFitUtils::parCrossSection
static

Definition at line 183 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::parCrossSectionFix
static

Definition at line 187 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::parCrossSectionOrder
static

Definition at line 191 of file MuScleFitUtils.h.

std::vector<int> MuScleFitUtils::parfix
static

Definition at line 211 of file MuScleFitUtils.h.

std::vector<int> MuScleFitUtils::parorder
static

Definition at line 212 of file MuScleFitUtils.h.

std::vector< double > MuScleFitUtils::parResol
static

Definition at line 175 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::parResolFix
static

Definition at line 185 of file MuScleFitUtils.h.

std::vector< double > MuScleFitUtils::parResolMax
static

Definition at line 178 of file MuScleFitUtils.h.

std::vector< double > MuScleFitUtils::parResolMin
static

Definition at line 177 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::parResolOrder
static

Definition at line 189 of file MuScleFitUtils.h.

std::vector< double > MuScleFitUtils::parResolStep
static

Definition at line 176 of file MuScleFitUtils.h.

std::vector< double > MuScleFitUtils::parScale
static

Definition at line 179 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::parScaleFix
static

Definition at line 186 of file MuScleFitUtils.h.

std::vector< double > MuScleFitUtils::parScaleMax
static

Definition at line 182 of file MuScleFitUtils.h.

std::vector< double > MuScleFitUtils::parScaleMin
static

Definition at line 181 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::parScaleOrder
static

Definition at line 190 of file MuScleFitUtils.h.

std::vector< double > MuScleFitUtils::parScaleStep
static

Definition at line 180 of file MuScleFitUtils.h.

std::vector< double > MuScleFitUtils::parSmear
static

Definition at line 173 of file MuScleFitUtils.h.

std::vector< std::vector< double > > MuScleFitUtils::parvalue
static

Definition at line 209 of file MuScleFitUtils.h.

bool MuScleFitUtils::rapidityBinsForZ_ = true
static

Definition at line 234 of file MuScleFitUtils.h.

std::vector< std::pair< lorentzVector, lorentzVector > > MuScleFitUtils::ReducedSavedPair
static

Definition at line 215 of file MuScleFitUtils.h.

std::vector< int > MuScleFitUtils::resfind
static

Definition at line 193 of file MuScleFitUtils.h.

Referenced by MuScleFitGenFilter::MuScleFitGenFilter().

bool MuScleFitUtils::ResFound = false
static

Definition at line 114 of file MuScleFitUtils.h.

double MuScleFitUtils::ResGamma = {2.4952, 0.000020, 0.000032, 0.000054, 0.000317, 0.0000932 }
static

Definition at line 118 of file MuScleFitUtils.h.

double MuScleFitUtils::ResHalfWidth
static

Definition at line 204 of file MuScleFitUtils.h.

double MuScleFitUtils::ResMass = {91.1876, 10.3552, 10.0233, 9.4603, 3.68609, 3.0969}
static

Definition at line 119 of file MuScleFitUtils.h.

double MuScleFitUtils::ResMaxSigma
static

Definition at line 203 of file MuScleFitUtils.h.

double MuScleFitUtils::ResMinMass = {-99, -99, -99, -99, -99, -99}
static

Definition at line 120 of file MuScleFitUtils.h.

int MuScleFitUtils::ResolFitType = 0
static

Definition at line 135 of file MuScleFitUtils.h.

resolutionFunctionBase< double * > * MuScleFitUtils::resolutionFunction = 0
static

Definition at line 136 of file MuScleFitUtils.h.

resolutionFunctionBase< std::vector< double > > * MuScleFitUtils::resolutionFunctionForVec = 0
static

Definition at line 137 of file MuScleFitUtils.h.

TMinuit * MuScleFitUtils::rminPtr_ = 0
static

Definition at line 225 of file MuScleFitUtils.h.

std::vector< std::pair< lorentzVector, lorentzVector > > MuScleFitUtils::SavedPair
static

Definition at line 214 of file MuScleFitUtils.h.

std::vector< std::pair< MuScleFitMuon, MuScleFitMuon > > MuScleFitUtils::SavedPairMuScleFitMuons
static

Definition at line 217 of file MuScleFitUtils.h.

bool MuScleFitUtils::scaleFitNotDone_ = true
static

Definition at line 221 of file MuScleFitUtils.h.

int MuScleFitUtils::ScaleFitType = 0
static

Definition at line 138 of file MuScleFitUtils.h.

scaleFunctionBase< double * > * MuScleFitUtils::scaleFunction = 0
static

Definition at line 139 of file MuScleFitUtils.h.

scaleFunctionBase< std::vector< double > > * MuScleFitUtils::scaleFunctionForVec = 0
static

Definition at line 140 of file MuScleFitUtils.h.

bool MuScleFitUtils::separateRanges_ = true
static

Definition at line 241 of file MuScleFitUtils.h.

bool MuScleFitUtils::sherpa_ = false
static

Definition at line 231 of file MuScleFitUtils.h.

TH1D * MuScleFitUtils::signalProb_ = 0
static

Definition at line 168 of file MuScleFitUtils.h.

std::vector< std::pair< lorentzVector, lorentzVector > > MuScleFitUtils::simPair
static

Definition at line 219 of file MuScleFitUtils.h.

smearFunctionBase * MuScleFitUtils::smearFunction = 0
static

Definition at line 131 of file MuScleFitUtils.h.

int MuScleFitUtils::SmearType = 0
static

Definition at line 130 of file MuScleFitUtils.h.

bool MuScleFitUtils::speedup = false
static

Definition at line 195 of file MuScleFitUtils.h.

bool MuScleFitUtils::startWithSimplex_
static

Definition at line 263 of file MuScleFitUtils.h.

const int MuScleFitUtils::totalResNum = 6
static

Definition at line 116 of file MuScleFitUtils.h.

bool MuScleFitUtils::useProbsFile_ = true
static

Definition at line 238 of file MuScleFitUtils.h.

double MuScleFitUtils::x
static

Definition at line 196 of file MuScleFitUtils.h.