CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Pages
Functions | Variables
MuScleFitUtils.cc File Reference
#include "MuScleFitUtils.h"
#include "DataFormats/HepMCCandidate/interface/GenParticle.h"
#include "SimDataFormats/Track/interface/SimTrack.h"
#include "DataFormats/Candidate/interface/LeafCandidate.h"
#include "DataFormats/Math/interface/LorentzVector.h"
#include "TString.h"
#include "TFile.h"
#include "TTree.h"
#include "TCanvas.h"
#include "TH2F.h"
#include "TF1.h"
#include "TF2.h"
#include <iostream>
#include <fstream>
#include <memory>
#include "MuonAnalysis/MomentumScaleCalibration/interface/Functions.h"

Go to the source code of this file.

Functions

Double_t Gaussian (Double_t *x, Double_t *par)
 
void likelihood (int &npar, double *grad, double &fval, double *xval, int flag)
 
Double_t lorentzianPeak (Double_t *x, Double_t *par)
 

Variables

double f [11][100]
 
double g [11][100]
 
TF1 * GL
 
TF2 * GL2
 
double isum
 
double mzsum
 

Function Documentation

Double_t Gaussian ( Double_t *  x,
Double_t *  par 
)

Definition at line 63 of file MuScleFitUtils.cc.

References create_public_lumi_plots::exp.

Referenced by MuScleFitUtils::fitReso().

63  {
64  return par[0]*exp(-0.5*((x[0]-par[1])/par[2])*((x[0]-par[1])/par[2]));
65 }
T x() const
Cartesian x coordinate.
void likelihood ( int &  npar,
double *  grad,
double &  fval,
double *  xval,
int  flag 
)

Definition at line 1701 of file MuScleFitUtils.cc.

References MuScleFitUtils::applyScale(), MuScleFitUtils::computeWeight(), gather_cfg::cout, MuScleFitUtils::debug, MuScleFitUtils::doScaleFit, reco::tau::disc::Eta(), MuScleFitUtils::iev_, MuScleFitUtils::invDimuonMass(), MuScleFitUtils::likelihoodInLoop_, cmsBatch::log, MuScleFitUtils::loopCounter, MuScleFitUtils::massProb(), MuScleFitUtils::massResolution(), MuScleFitUtils::minuitLoop_, MuScleFitUtils::normalizationChanged_, MuScleFitUtils::normalizeLikelihoodByEventNumber_, MuScleFitUtils::oldNormalization_, MuScleFitUtils::ReducedSavedPair, MuScleFitUtils::rminPtr_, MuScleFitUtils::SavedPair, and puppiForMET_cff::weight.

Referenced by pat::ElectronSelector::filter(), MuScleFitUtils::minimizeLikelihood(), and PFNuclearProducer::produce().

1701  {
1702 
1703  if (MuScleFitUtils::debug>19) std::cout << "[MuScleFitUtils-likelihood]: In likelihood function" << std::endl;
1704 
1705  const lorentzVector * recMu1;
1706  const lorentzVector * recMu2;
1707  lorentzVector corrMu1;
1708  lorentzVector corrMu2;
1709 
1710  // if (MuScleFitUtils::debug>19) {
1711  // int parnumber = (int)(MuScleFitUtils::parResol.size()+MuScleFitUtils::parScale.size()+
1712  // MuScleFitUtils::parCrossSection.size()+MuScleFitUtils::parBgr.size());
1713  // std::cout << "[MuScleFitUtils-likelihood]: Looping on tree with ";
1714  // for (int ipar=0; ipar<parnumber; ipar++) {
1715  // std::cout << "Parameter #" << ipar << " with value " << xval[ipar] << " ";
1716  // }
1717  // std::cout << std::endl;
1718  // }
1719 
1720  // Loop on the tree
1721  // ----------------
1722  double flike = 0;
1723  int evtsinlik = 0;
1724  int evtsoutlik = 0;
1725  // std::cout << "SavedPair.size() = " << MuScleFitUtils::SavedPair.size() << std::endl;
1726  if( MuScleFitUtils::debug>0 ) {
1727  std::cout << "SavedPair.size() = " << MuScleFitUtils::SavedPair.size() << std::endl;
1728  std::cout << "ReducedSavedPair.size() = " << MuScleFitUtils::ReducedSavedPair.size() << std::endl;
1729  }
1730  // for( unsigned int nev=0; nev<MuScleFitUtils::SavedPair.size(); ++nev ) {
1731  for( unsigned int nev=0; nev<MuScleFitUtils::ReducedSavedPair.size(); ++nev ) {
1732 
1733  // recMu1 = &(MuScleFitUtils::SavedPair[nev].first);
1734  // recMu2 = &(MuScleFitUtils::SavedPair[nev].second);
1735  recMu1 = &(MuScleFitUtils::ReducedSavedPair[nev].first);
1736  recMu2 = &(MuScleFitUtils::ReducedSavedPair[nev].second);
1737 
1738  // Compute original mass
1739  // ---------------------
1740  double mass = MuScleFitUtils::invDimuonMass( *recMu1, *recMu2 );
1741 
1742  // Compute weight and reference mass (from original mass)
1743  // ------------------------------------------------------
1745  if( weight!=0. ) {
1746  // Compute corrected mass (from previous biases) only if we are currently fitting the scale
1747  // ----------------------------------------------------------------------------------------
1749 // std::cout << "Original pt1 = " << corrMu1.Pt() << std::endl;
1750 // std::cout << "Original pt2 = " << corrMu2.Pt() << std::endl;
1751  corrMu1 = MuScleFitUtils::applyScale(*recMu1, xval, -1);
1752  corrMu2 = MuScleFitUtils::applyScale(*recMu2, xval, 1);
1753 
1754 // if( (corrMu1.Pt() != corrMu1.Pt()) || (corrMu2.Pt() != corrMu2.Pt()) ) {
1755 // std::cout << "Rescaled pt1 = " << corrMu1.Pt() << std::endl;
1756 // std::cout << "Rescaled pt2 = " << corrMu2.Pt() << std::endl;
1757 // }
1758 // std::cout << "Rescaled pt1 = " << corrMu1.Pt() << std::endl;
1759 // std::cout << "Rescaled pt2 = " << corrMu2.Pt() << std::endl;
1760  }
1761  else {
1762  corrMu1 = *recMu1;
1763  corrMu2 = *recMu2;
1764 
1765 // if( (corrMu1.Pt() != corrMu1.Pt()) || (corrMu2.Pt() != corrMu2.Pt()) ) {
1766 // std::cout << "Not rescaled pt1 = " << corrMu1.Pt() << std::endl;
1767 // std::cout << "Not rescaled pt2 = " << corrMu2.Pt() << std::endl;
1768 // }
1769  }
1770  double corrMass = MuScleFitUtils::invDimuonMass(corrMu1, corrMu2);
1771  double Y = (corrMu1+corrMu2).Rapidity();
1772  double resEta = (corrMu1+corrMu2).Eta();
1773  if( MuScleFitUtils::debug>19 ) {
1774  std::cout << "[MuScleFitUtils-likelihood]: Original/Corrected resonance mass = " << mass
1775  << " / " << corrMass << std::endl;
1776  }
1777 
1778  // Compute mass resolution
1779  // -----------------------
1780  double massResol = MuScleFitUtils::massResolution(corrMu1, corrMu2, xval);
1781  if (MuScleFitUtils::debug>19)
1782  std::cout << "[MuScleFitUtils-likelihood]: Resolution is " << massResol << std::endl;
1783 
1784  // Compute probability of this mass value including background modeling
1785  // --------------------------------------------------------------------
1786  if (MuScleFitUtils::debug>1) std::cout << "calling massProb inside likelihood function" << std::endl;
1787 
1788  // double prob = MuScleFitUtils::massProb( corrMass, resEta, Y, massResol, xval );
1789  double prob = MuScleFitUtils::massProb( corrMass, resEta, Y, massResol, xval, false, corrMu1.eta(), corrMu2.eta() );
1790  if (MuScleFitUtils::debug>1) std::cout << "likelihood:massProb = " << prob << std::endl;
1791 
1792  // Compute likelihood
1793  // ------------------
1794  if( prob>0 ) {
1795  // flike += log(prob*10000)*weight; // NNBB! x10000 to see if we can recover the problem of boundary
1796  flike += log(prob)*weight;
1797  evtsinlik += 1; // NNBB test: see if likelihood per event is smarter (boundary problem)
1798  } else {
1799  if( MuScleFitUtils::debug > 0 ) {
1800  std::cout << "WARNING: corrMass = " << corrMass << " outside window, this will cause a discontinuity in the likelihood. Consider increasing the safety bands which are now set to 90% of the normalization window to avoid this problem" << std::endl;
1801  std::cout << "Original mass was = " << mass << std::endl;
1802  std::cout << "WARNING: massResol = " << massResol << " outside window" << std::endl;
1803  }
1804  evtsoutlik += 1;
1805  }
1806  if (MuScleFitUtils::debug>19)
1807  std::cout << "[MuScleFitUtils-likelihood]: Mass probability = " << prob << std::endl;
1808  } // weight!=0
1809 
1810  } // End of loop on tree events
1811 
1812 // // Protection for low statistic. If the likelihood manages to throw out all the signal
1813 // // events and stays with ~ 10 events in the resonance window it could have a better likelihood
1814 // // because of ~ uniformly distributed events (a random combination could be good and spoil the fit).
1815 // // We require that the number of events included in the fit does not change more than 5% in each minuit loop.
1816 // bool lowStatPenalty = false;
1817 // if( MuScleFitUtils::minuitLoop_ > 0 ) {
1818 // double newEventsOutInRatio = double(evtsinlik);
1819 // // double newEventsOutInRatio = double(evtsoutlik)/double(evtsinlik);
1820 // double ratio = newEventsOutInRatio/MuScleFitUtils::oldEventsOutInRatio_;
1821 // MuScleFitUtils::oldEventsOutInRatio_ = newEventsOutInRatio;
1822 // if( ratio < 0.8 || ratio > 1.2 ) {
1823 // std::cout << "Warning: too much change from oldEventsInLikelihood to newEventsInLikelihood, ratio is = " << ratio << std::endl;
1824 // std::cout << "oldEventsInLikelihood = " << MuScleFitUtils::oldEventsOutInRatio_ << ", newEventsInLikelihood = " << newEventsOutInRatio << std::endl;
1825 // lowStatPenalty = true;
1826 // }
1827 // }
1828 
1829  // It is a product of probabilities, we compare the sqrt_N of them. Thus N becomes a denominator of the logarithm.
1830  if( evtsinlik != 0 ) {
1831 
1833  // && !(MuScleFitUtils::duringMinos_) ) {
1834  if( MuScleFitUtils::rminPtr_ == 0 ) {
1835  std::cout << "ERROR: rminPtr_ = " << MuScleFitUtils::rminPtr_ << ", code will crash" << std::endl;
1836  }
1837  double normalizationArg[] = {1/double(evtsinlik)};
1838  // Reset the normalizationArg only if it changed
1839  if( MuScleFitUtils::oldNormalization_ != normalizationArg[0] ) {
1840  int ierror = 0;
1841 // if( MuScleFitUtils::likelihoodInLoop_ != 0 ) {
1842 // // This condition is set only when minimizing. Later calls of hesse and minos will not change the value
1843 // // This is done to avoid minos being confused by changing the UP parameter during its computation.
1844 // MuScleFitUtils::rminPtr_->mnexcm("SET ERR", normalizationArg, 1, ierror);
1845 // }
1846  MuScleFitUtils::rminPtr_->mnexcm("SET ERR", normalizationArg, 1, ierror);
1847  std::cout << "oldNormalization = " << MuScleFitUtils::oldNormalization_ << " new = " << normalizationArg[0] << std::endl;
1848  MuScleFitUtils::oldNormalization_ = normalizationArg[0];
1850  }
1851  fval = -2.*flike/double(evtsinlik);
1852  // fval = -2.*flike;
1853  // if( lowStatPenalty ) {
1854  // fval *= 100;
1855  // }
1856  }
1857  else {
1858  fval = -2.*flike;
1859  }
1860  }
1861  else {
1862  std::cout << "Problem: Events in likelihood = " << evtsinlik << std::endl;
1863  fval = 999999999.;
1864  }
1865  // fval = -2.*flike;
1866  if (MuScleFitUtils::debug>19)
1867  std::cout << "[MuScleFitUtils-likelihood]: End tree loop with likelihood value = " << fval << std::endl;
1868 
1869 // #ifdef DEBUG
1870 
1871 // if( MuScleFitUtils::minuitLoop_ < 10000 ) {
1875  }
1876  // }
1877  // else std::cout << "minuitLoop over 10000. Not filling histogram" << std::endl;
1878 
1879  std::cout<<"MINUIT loop number "<<MuScleFitUtils::minuitLoop_<<", likelihood = "<<fval<<std::endl;
1880 
1881  if( MuScleFitUtils::debug > 0 ) {
1882  // if( MuScleFitUtils::duringMinos_ ) {
1883  // int parnumber = (int)(MuScleFitUtils::parResol.size()+MuScleFitUtils::parScale.size()+
1884  // MuScleFitUtils::parCrossSection.size()+MuScleFitUtils::parBgr.size());
1885  // std::cout << "[MuScleFitUtils-likelihood]: Looping on tree with ";
1886  // for (int ipar=0; ipar<parnumber; ipar++) {
1887  // std::cout << "Parameter #" << ipar << " with value " << xval[ipar] << " ";
1888  // }
1889  // std::cout << std::endl;
1890  // std::cout << "[MuScleFitUtils-likelihood]: likelihood value = " << fval << std::endl;
1891  // }
1892  std::cout << "Events in likelihood = " << evtsinlik << std::endl;
1893  std::cout << "Events out likelihood = " << evtsoutlik << std::endl;
1894  }
1895 
1896 // #endif
1897 }
static std::vector< int > doScaleFit
static unsigned int loopCounter
static int debug
static unsigned int normalizationChanged_
static double massProb(const double &mass, const double &rapidity, const int ires, const double &massResol)
reco::Particle::LorentzVector lorentzVector
Definition: GenMuonPair.h:9
static std::vector< std::pair< lorentzVector, lorentzVector > > ReducedSavedPair
static double massResolution(const lorentzVector &mu1, const lorentzVector &mu2)
static int minuitLoop_
static double computeWeight(const double &mass, const int iev, const bool doUseBkgrWindow=false)
static std::vector< std::pair< lorentzVector, lorentzVector > > SavedPair
static double invDimuonMass(const lorentzVector &mu1, const lorentzVector &mu2)
static lorentzVector applyScale(const lorentzVector &muon, const std::vector< double > &parval, const int charge)
static TMinuit * rminPtr_
static TH1D * likelihoodInLoop_
static double oldNormalization_
static int iev_
static bool normalizeLikelihoodByEventNumber_
tuple cout
Definition: gather_cfg.py:121
tuple log
Definition: cmsBatch.py:341
Double_t lorentzianPeak ( Double_t *  x,
Double_t *  par 
)

See header file for a class description

Author
S. Bolognesi - INFN Torino / T. Dorigo, M. De Mattia - INFN Padova Revised S. Casasso, E. Migliore - UniTo & INFN Torino

Definition at line 56 of file MuScleFitUtils.cc.

References alignCSCRings::e, Max(), and Pi.

Referenced by MuScleFitUtils::fitMass().

56  {
57  return (0.5*par[0]*par[1]/TMath::Pi()) /
58  TMath::Max(1.e-10,(x[0]-par[2])*(x[0]-par[2]) + .25*par[1]*par[1]);
59 }
const double Pi
T x() const
Cartesian x coordinate.
T Max(T a, T b)
Definition: MathUtil.h:44

Variable Documentation

double f[11][100]

Definition at line 78 of file MuScleFitUtils.cc.

Referenced by funct::SimplSumOrd< F, G, H >::prod0::a(), funct::SimplSumOrd< F, G, H >::prod1::a(), funct::RatioP1< F, G, H >::prod0::a(), funct::Product< ProductStruct< F, G >, H >::prod0::a(), funct::RatioP1< F, G, H >::prod1::a(), funct::Product< ProductStruct< F, G >, H >::prod1::a(), funct::RatioP2< F, G, H >::prod0::a(), funct::RatioP2< F, G, H >::prod1::a(), abcd(), abConnect(), LocalTrajectoryParameters::absdz(), edm::helper::Filler< Association< C > >::add(), pftools::SpaceManager::addEvolution(), SiPixelFedCablingTree::addFed(), DDQuery::addFilter(), GEMDigiModel::addLinks(), GroupedCkfTrajectoryBuilder::advanceOneLayer(), SiStripGainFromData::algoEndJob(), PedsFullNoiseAlgorithm::analyse(), ZMuPtScaleAnalyzer::analyze(), EcalSRCondTools::analyze(), JetResolutionDBReader::analyze(), EwkMuLumiMonitorDQM::analyze(), GctFibreAnalyzer::analyze(), HcalMonitorModule::analyze(), JetResolutionScaleFactorDBReader::analyze(), SiPixelHitEfficiencySource::analyze(), ZDCMonitorModule::analyze(), DumpSimGeometry::analyze(), HeavyFlavorValidation::analyze(), BTagPerformaceRootProducerFromSQLITE::analyze(), FFTJetPileupAnalyzer::analyze(), MuonTrackValidator::analyze(), ThirdHitPredictionFromCircle::angle(), apply(), npstat::ArrayND< Numeric, StackLen, StackDim >::apply(), FFTJetCorrectionProducer::applyCorrections(), ThreeThresholdAlgorithm::applyGains(), approx_erf(), npstat::ArrayND< Numeric, StackLen, StackDim >::ArrayND(), npstat::ArrayND< Numeric, StackLen, StackDim >::assign(), DTDigitizer::asymGausSmear(), HcalShapeIntegrator::at(), fastmath::atan2r(), QGLikelihoodDBWriter::beginJob(), ProtonTaggerFilter::beginJob(), TSGFromL1Muon::beginRun(), TrackerOfflineValidation::bookDirHists(), DQMStore::bookTransaction(), MagGeoBuilderFromDDD::bRod::bRod(), MagGeoBuilderFromDDD::bSector::bSector(), FWCaloRecHitDigitSetProxyBuilder::build(), FWPFCandidateDetailView::build(), FWTrackHitsDetailView::build(), FWConvTrackHitsDetailView::build(), MagGeoBuilderFromDDD::build(), funct::SimplSumOrd< F, G, H >::prod2::c(), funct::RatioP1< F, G, H >::prod2::c(), funct::Product< ProductStruct< F, G >, H >::prod2::c(), funct::RatioP2< F, G, H >::prod2::c(), SiPixelDigitizerAlgorithm::calcQ(), HLTEcalResonanceFilter::calcShowerShape(), HLTRegionalEcalResonanceFilter::calcShowerShape(), PFEGammaAlgo::calculate_ele_mva(), Quantile::calculateQ(), l1t::Stage2Layer2JetAlgorithmFirmwareImp1::calibFit(), edm::ExceptionCollector::call(), reco::HitPattern::call(), GenParticleProducer::chargeTimesThree(), RPCDCSSummary::checkDCSbit(), RPCDataCertification::checkFED(), HitPairGeneratorFromLayerPairForPhotonConversion::checkRZCompatibilityWithSeedTrack(), RectangularEtaPhiTrackingRegion::checkRZOld(), CmsShowEDI::clearPBFrame(), LaserSorter::closeOutStream(), Grid1D::closestNode(), CmsShowMain::CmsShowMain(), funct::SimplSumOrd< A, B, ProductStruct< C, D > >::combine(), funct::combine(), funct::RatioP1< A, B, Numerical< n > >::combine(), funct::Product< ProductStruct< F, G >, H >::combine(), funct::RatioP2< A, B, ProductStruct< C, D > >::combine(), TrackAssociatorByChi2Impl::compareTracksParam(), ForwardDetLayer::compatible(), GsfBetheHeitlerUpdator::compute(), EcalUncalibRecHitRatioMethodAlgo< C >::computeAmplitudeImpl(), FWGeoTopNode::ComputeBBox(), VolumeEnergyLossEstimator::computeElectrons(), TBPLayer::computeIndexes(), MagneticField::computeNominalValue(), EcalUncalibRecHitRatioMethodAlgo< C >::computeTime(), HBHENegativeFlagSetter::configFilter(), ConnectionManager::connect(), convert64(), convertPackedEtaToPackedY(), edm::ParameterSetConverter::convertParameterSets(), edm::copy_all(), npstat::ArrayND< Numeric, StackLen, StackDim >::copyRangeLoopFunct(), GsfBetheHeitlerUpdator::correctedFirstMean(), GsfBetheHeitlerUpdator::correctedFirstVar(), EcalClusterToolsT< noZS >::covariances(), StripCPE::Param::coveredStrips(), spu::create_file(), EveService::createEventNavigationGUI(), muonisolation::IsolatorByNominalEfficiency::cuts(), GaussianSumUtilities1D::d1LnPdf(), GaussianSumUtilities1D::d2LnPdf(), dd_html_frameset(), dd_html_menu(), dd_html_menu_frameset(), dd_to_html(), DDDefaultNumberingScheme::DDDefaultNumberingScheme(), BTagLikeDeDxDiscriminator::dedx(), HcalTimeSlewSim::delay(), FFTJetProducer::determinePileup(), FFTJetProducer::determinePileupDensityFromDB(), FWEveDigitSetScalableMarkerGL::DirectDraw(), LocalTrajectoryParameters::direction(), MuonTagger::discriminator(), ElectronTagger::discriminator(), npstat::HistoND< Numeric, Axis >::dispatch(), DumpGctDigis::doFibres(), DDNsGenerator::doit(), DDFrameGenerator::doit(), CmsShowTaskExecutor::doNextTaskImp(), RPCEventSummary::dqmEndLuminosityBlock(), PixelCPEBase::driftDirection(), DTDigitizer::driftTimeFromParametrization(), edm::JobReport::dumpFiles(), VVIObjFDetails::dzero(), VVIObjDetails::dzero(), sistripvvi::VVIObjDetails::dzero(), EcalSeverityLevelAlgo::EcalSeverityLevelAlgo(), Conv::elec(), EcalTBHodoscopeRawInfoDumper::endJob(), EcalTBTDCRawInfoDumper::endJob(), miscalibExample::endJob(), EcalSimpleTBAnalyzer::endJob(), EcalSimple2007H4TBAnalyzer::endJob(), PhiSymmetryCalibration::endJob(), fireworks::energyScaledBox3DCorners(), BinomialProbability::error(), MagGeoBuilderFromDDD::eSector::eSector(), fireworks::etScaledBox3DCorners(), ESRecHitSimAlgo::evalAmplitude(), fit::RootMinuitFuncEvaluator< Function >::evaluate(), fit::RootMinuitFuncEvaluator< Likelihood< Sample, PDF, Yield > >::evaluate(), edm::JobReport::eventReadFromFile(), edm::JobReport::eventWrittenToFile(), FWGUIManager::exportAllViews(), TFParams::f3deg(), HitQuadrupletGeneratorFromLayerPairForPhotonConversion::failCheckRZCompatibility(), EEDetId::fastValidDetId(), HiEgammaSCEnergyCorrectionAlgo::fBrem(), VVIObj::fcn(), VVIObjF::fcn(), sistripvvi::VVIObj::fcn(), HiEgammaSCEnergyCorrectionAlgo::fEta(), HiEgammaSCEnergyCorrectionAlgo::fEtEta(), PixelRecoUtilities::FieldAt0::FieldAt0(), MultipleScatteringX0Data::fileName(), XHistogram::fill(), big::bigStore::fill(), QcdUeDQM::fillChargedJetSpectra(), PhiSymmetryCalibration_step2::fillConstantsHistos(), PhiSymmetryCalibration_step2_SM::fillConstantsHistos(), PhiSymmetryCalibration_step2::fillHistos(), PhiSymmetryCalibration_step2_SM::fillHistos(), StripCPE::fillParams(), LRHelpFunctions::fillToBackgroundHists(), LRHelpFunctions::fillToSignalHists(), edm::AssociationMap< edm::OneToMany< reco::BasicJetCollection, reco::TrackCollection > >::find(), MSLayersAtAngle::findLayer(), reco::findMethod(), muonisolation::IsolatorByNominalEfficiency::findPath(), CSCXonStrip_MatchGatti::findXOnStrip(), SymmetryFit::fit(), CosmicMuonSmoother::fit(), SymmetryFit::fitfunction(), CSCFindPeakTime::fivePoleFitTime(), PhotonFix::fixedEnergy(), extend_argparse::FixedWidthFormatter(), EgammaSCEnergyCorrectionAlgo::fNCrystals(), HiEgammaSCEnergyCorrectionAlgo::fNCrystals(), edm::for_all(), fpeak_convoluted(), lumi::from_string(), HcalDbOmds::from_string(), root::helper::RootFunctionHelper< F, args, Tag >::fun(), root::function(), npstat::ArrayND< Numeric, StackLen, StackDim >::functorFill(), npstat::ArrayND< Numeric, StackLen, StackDim >::functorFillLoop(), FWEveViewManager::FWEveViewManager(), FWFFService::FWFFService(), FWGeometryTableViewManager::FWGeometryTableViewManager(), FWGUIEventFilter::FWGUIEventFilter(), FWLegoCandidate::FWLegoCandidate(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), FWTableViewManager::FWTableViewManager(), FWTriggerTableViewManager::FWTriggerTableViewManager(), EcalSimRawData::genFeData(), EcalSimRawData::genSrData(), funct::NthDerivative< n, X, F >::get(), funct::NthDerivative< 0, X, F >::get(), funct::ConstPrimitive< X, F, true >::get(), SiPixelClusterShapeCache::get(), edm::AssociationMap< edm::OneToMany< reco::BasicJetCollection, reco::TrackCollection > >::get(), EcalBarrelGeometry::getCells(), track_associator::getChi2(), SCRegressionCalculator< VarCalc >::getCorrectionWithErrors(), HitPairGeneratorFromLayerPairForPhotonConversion::getCot(), TouchableToHistory::getFilteredView(), WatcherStreamFileReader::getInputFile(), PhiSymmetryCalibration::getKfactors(), EcalLaserDbService::getLaserCorrection(), EcalTrivialConditionRetriever::getMappingFromConfiguration(), FWMagField::GetMaxFieldMag(), EcalMappingElectronicsHandler::getNewObjects(), popcon::EcalSRPHandler::getNewObjects(), popcon::EcalTPGFineGrainEBIdMapHandler::getNewObjects(), ConversionProducer::getTrackImpactPosition(), EcalClusterLocalContCorrection::getValue(), EcalClusterCrackCorrection::getValue(), CSCAnalogSignal::getValue(), GlobalTrajectoryParameters::GlobalTrajectoryParameters(), TIBRing::groupedCompatibleDetsV(), FWConfigurationManager::guessAndReadFromFile(), CmsAnnotation::Handle(), FWColorPopup::HandleButton(), HcalEEUSMonitor::HcalEEUSMonitor(), HelixBarrelCylinderCrossing::HelixBarrelCylinderCrossing(), HelixBarrelPlaneCrossing2OrderLocal::HelixBarrelPlaneCrossing2OrderLocal(), CSCMake2DRecHit::hitFromStripAndWire(), HitPairGeneratorFromLayerPairForPhotonConversion::hitPairs(), RectangularEtaPhiTrackingRegion::hits(), PixelTripletLargeTipGenerator::hitTriplets(), PixelTripletHLTGenerator::hitTriplets(), HLTCommonConfig::HLTCommonConfig(), IEEE32toDSP(), pat::strbitset::index(), SiTrivialInduceChargeOnStrips::induceVector(), ThirdHitCorrection::init(), PixelRecoLineRZ::initCot(), fireworks::Context::initEveElements(), PFEGammaAlgo::initializeProtoCands(), CandMatcherBase< C1, C2 >::initMaps(), reco::MustacheKernel::inMustache(), edm::JobReport::inputFileClosed(), edm::helper::Filler< Association< C > >::insert(), SimpleDiskBounds::inside(), DiskSectorBounds::inside(), Bounds::inside(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::inspectTrack(), funct::integral(), LinearGridInterpolator3D::interpolate(), SiStripTemplate::interpolate(), SiPixelTemplate::interpolate(), npstat::LinInterpolatedTableND< Numeric, Axis >::invertRatioResponse(), cond::persistency::iovSorter(), ParabolicParametrizedMagneticField::isDefined(), OAEParametrizedMagneticField::isDefined(), heppy::IsolationComputer::isoSumNeutralsWeighted(), edm::isTransientEqual(), PerigeeConversions::jacobianParameters2Cartesian(), PerigeeConversions::jacobianPerigee2Curvilinear(), JME::JetResolutionObject::JetResolutionObject(), FWGUIValidatingTextEntry::keyPressedInPopup(), StripCPEfromTrackAngle::legacyStripErrorSquared(), EvolutionECAL::LightCollectionEfficiency(), EvolutionECAL::LightCollectionEfficiencyWeighted(), GaussianSumUtilities1D::lnPdf(), HcalDetDiagPedestalMonitor::LoadDataset(), HcalDetDiagLaserMonitor::LoadDataset(), FWFFLooper::loadDefaultGeometryFile(), FFTJetPileupProcessor::loadFlatteningFactors(), MatacqProducer::loadOrbitOffset(), HcalPatternSource::loadPatternFile(), ClusterShapeHitFilter::loadPixelLimits(), HcalDetDiagLEDMonitor::LoadReference(), HcalDetDiagPedestalMonitor::LoadReference(), HcalDetDiagLaserMonitor::LoadReference(), SteppingHelixPropagator::loadState(), EcalClusterToolsT< noZS >::localCovariances(), PSimHit::localDirection(), RectangularStripTopology::localError(), PixelCPETemplateReco::localError(), CSCRadialStripTopology::localError(), TkRadialStripTopology::localError(), PixelCPEGeneric::localError(), StripCPEfromTemplate::localParameters(), StripCPE::localParameters(), StripCPEfromTrackAngle::localParameters(), TrapezoidalStripTopology::localPitch(), CSCRadialStripTopology::localPitch(), RectangularStripTopology::localPosition(), TrapezoidalStripTopology::localStripLength(), CSCRadialStripTopology::localStripLength(), TkRadialStripTopology::localStripLength(), GlobalTrajectoryParameters::magneticFieldInInverseGeV(), main(), MuonRPCDetLayerGeometryBuilder::makeBarrelLayers(), MuonRPCDetLayerGeometryBuilder::makeBarrelRods(), fireworks_root_gui::makeHorizontalFrame(), reco::MaskCollection< Object >::mask(), edm::EventSelector::maskTriggerResults(), funct::master(), SiStripRecHitMatcher::match(), CSCRadialStripTopology::measurementError(), TkRadialStripTopology::measurementError(), DQMStore::meBookerGetter(), DQMStore::meGetter(), JetPartonNamespace::UserPartonMixture::mixt(), LocalTrajectoryParameters::momentum(), edm::AssociationMap< edm::OneToMany< reco::BasicJetCollection, reco::TrackCollection > >::numberOfAssociations(), LRHelpFunctions::obsFitIncluded(), CaloSamples::offsetTime(), oldComputeElectrons(), GsiFTPStorageMaker::open(), HttpStorageMaker::open(), LocalStorageMaker::open(), DCacheStorageMaker::open(), XrdStorageMaker::open(), StormStorageMaker::open(), StormLcgGtStorageMaker::open(), RFIOStorageMaker::open(), GsfEleEffAreaPFIsoCut::operator()(), FreeFunctionSelector< T, f >::operator()(), GsfEleDeltaBetaIsoCut::operator()(), GsfEleDeltaBetaIsoCutStandalone::operator()(), TkClonerImpl::operator()(), OuterHitPhiPrediction::operator()(), BSpdfsFcn::operator()(), CandMatcherBase< C1, C2 >::operator()(), funct::GaussLegendreIntegrator::operator()(), funct::GaussIntegrator::operator()(), funct::operator<<(), reco::parser::operator<<(), operator<<(), cscdqm::LogCout::operator<<(), edm::LogWarning::operator<<(), edm::LogError::operator<<(), edm::LogSystem::operator<<(), edm::LogInfo::operator<<(), cms::operator<<(), edm::LogVerbatim::operator<<(), edm::LogPrint::operator<<(), edm::LogProblem::operator<<(), edm::LogImportant::operator<<(), edm::LogAbsolute::operator<<(), edm::LogDebug_::operator<<(), edm::LogTrace_::operator<<(), edm::edmmltest::LogWarningThatSuppressesLikeLogInfo::operator<<(), MSLayer::operator==(), edm::JobReport::outputFileClosed(), PhiSymmetryCalibration_step2_SM::outResidHistos(), PhiSymmetryCalibration_step2::outResidHistos(), npstat::BoxND< Numeric >::overlapFraction(), Phase2OTECRingedLayer::overlapInR(), TIDLayer::overlapInR(), pat::PackedCandidate::packVtx(), CSCFindPeakTime::parabolaFitTime(), GenParticlePruner::parse(), parseFFTJetScaleCalculator(), EcalTrigTowerConstituentsMapBuilder::parseTextMap(), PetrukhinFunc(), PFResolutionMapManager::PFResolutionMapManager(), ThirdHitPredictionFromCircle::phi(), CSCSegAlgoSK::phiAtZ(), CSCSegAlgoTC::phiAtZ(), InnerDeltaPhi::phiRange(), SiPixelTemplateReco::PixelTempReco2D(), SiPixelTemplateSplit::PixelTempSplit(), cond::PayLoadInspector< DataT >::plot(), plotMaker(), TwoTrackMinimumDistance::pointsHelixHelix(), reco::exprEvalDetails::popenCPP(), FWRPZView::populateController(), FWTriggerTableView::populateController(), HelixBarrelPlaneCrossing2OrderLocal::positionOnly(), FWFFService::postBeginJob(), InputTagDistributorService::preModule(), VariableHelperService::preModule(), TrackerOfflineValidation::prepareSummaryHists(), fireworks::prepareTrack(), HcalRawDataMonitor::processEvent(), HcalRecHitMonitor::processEvent_rechit(), DeDxHitInfoProducer::processHit(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), L1HLTJetsMatching::produce(), edm::ExpoRandomPGunProducer::produce(), MCTrackMatcher::produce(), PFJetsMatchedToFilteredCaloJetsProducer::produce(), GenTrackMatcher::produce(), BeamSpotOnlineProducer::produce(), L3TkMuonProducer::produce(), MatchedProbeMaker< T >::produce(), L1TMicroGMTInputProducer::produce(), GoodSeedProducer::produce(), EcalTrivialConditionRetriever::produceEcalAlignmentEB(), EcalTrivialConditionRetriever::produceEcalAlignmentEE(), EcalTrivialConditionRetriever::produceEcalAlignmentES(), EcalTrivialConditionRetriever::produceEcalSamplesCorrelation(), perftools::EdmEventSize::produceHistos(), TkClonerImpl::project(), tauImpactParameter::ErrorMatrixPropagator::propagateError(), Geant4ePropagator::propagateGeneric(), AnalyticalPropagator::propagateParametersOnCylinder(), AnalyticalPropagator::propagateParametersOnPlane(), gen::PtYDistributor::PtYDistributor(), EcalUncalibRecHitRecAnalFitAlgo< EBDataFrame >::pulseShapeFunction(), Histos::put(), SiPixelGenError::qbin(), SiStripTemplate::qbin(), SiPixelTemplate::qbin(), SiPixelTemplate::qbin_dist(), PixelRecoLineRZ::rAtZ(), edm::ValueMap< edm::Ref< std::vector< reco::PFCandidate >, reco::PFCandidate, edm::refhelper::FindUsingAdvance< std::vector< reco::PFCandidate >, reco::PFCandidate > > >::rawIndexOf(), hitfit::Defaults_Textrep::read_file(), TStorageFactoryFile::ReadBufferAsync(), DQMStore::readFile(), FWConfigurationManager::readFromFile(), reco::details::readGzipFile(), EcalFEtoDigi::readInput(), MuonResiduals5DOFFitter::readNtuple(), MuonResiduals6DOFFitter::readNtuple(), MuonResiduals6DOFrphiFitter::readNtuple(), PasswordReader::readPassword(), TkConvValidator::recalculateMomentumAtFittedVertex(), HcalSimpleRecAlgoImpl::recoHFTime(), MiniFloatConverter::reduceMantissaToNbits(), CmsShowNavigator::removeFilter(), PFEGammaAlgo::removeOrLinkECALClustersToKFTracks(), edm::JobReport::reportDataType(), edm::JobReport::reportFastCopyingStatus(), HcalRawDataMonitor::reset(), ViewerParameterGUI::reset(), CastorSimpleRecAlgo::resetTimeSamples(), EvolutionECAL::ResolutionConstantTermEM50GeV(), LA_Filler_Fitter::result(), edm::RootEmbeddedFileSequence::RootEmbeddedFileSequence(), fit::RootMinuit< Function >::RootMinuit(), LocalError::rotate(), LocalError::rotateCosSin(), PixelFitterByHelixProjections::run(), safe_atan2f(), DQMStore::save(), TkHistoMap::saveAsCanvas(), npstat::ArrayND< Numeric, StackLen, StackDim >::scanInPlace(), EcalClusterToolsT< noZS >::scLocalCovariances(), FWViewContextMenuHandlerGL::select(), reco::SelectInCollection< Object >::select(), reco::SelectIndecesInCollection< Object >::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), siStripClusterTools::sensorThicknessInverse(), VariableHelperService::set(), FWGeometryTableManagerBase::NodeInfo::setBit(), TrackInformation::setCaloIDChecked(), CmsShowMainBase::setConfigFilename(), CompositeTrajectoryFilter::setEvent(), UnbinnedLikelihoodFit::setFunction(), PFECALSuperClusterAlgo::setMajorityFraction(), hcalCalib::SetMaxProbeJetEmFrac(), hcalCalib::SetMaxTagJetEmFrac(), BscG4Hit::setPhiAtEntry(), FP420G4Hit::setPhiAtEntry(), TotemG4Hit::setPhiAtEntry(), BaseParticlePropagator::setPropagationConditions(), FWMET3DProxyBuilder::Arrow::setScale(), HcalPulseShape::setShapeBin(), CastorPulseShapes::Shape::setShapeBin(), HcalEEUSMonitor::setup(), HcalRawDataMonitor::setup(), FWEveView::setupEnergyScale(), sicif(), PhotonFix::sigmaEnergy(), SimHitPrinter::SimHitPrinter(), SiPixelTemplate::simpletemplate2D(), XHistogram::splitSegment(), FWFFLooper::startingNewLoop(), stringToNumber(), cscdqm::stringToNumber(), SiStripTemplateReco::StripTempReco1D(), SiStripTemplateSplit::StripTempSplit(), FWGUIManager::subviewIsBeingDestroyed(), MSLayersAtAngle::sum2RmRn(), SummaryPlotXmlParser::SummaryPlotXmlParser(), MSLayersAtAngle::sumX0D(), MSLayer::sumX0D(), SiStripTemplate::sxtemp(), SiPixelTemplate::temperrors(), MinPtTrajectoryFilter::test(), FWGeometryTableManagerBase::NodeInfo::testBit(), StripSubClusterShapeFilterBase::testLastHit(), edm::EventSelector::testSelectionOverlap(), TkStripMeasurementDet::testStrips(), root::tf1(), TFileAdaptor::TFileAdaptor(), TrackingParticle::threeCharge(), timeout::timed_out(), timeout::TimedOutFn(), GlobalTrajectoryParameters::transverseCurvature(), funct::trapezoid_integral(), reco::typeCode(), PFEGammaAlgo::unlinkRefinableObjectKFandECALMatchedToHCAL(), PFEGammaAlgo::unlinkRefinableObjectKFandECALWithBadEoverP(), HcalUnpacker::unpack(), unsafe_expf_impl(), spu::Untar(), edm::service::CondorStatusService::updateImpl(), HcalRawDataMonitor::UpdateMEs(), LocalTrajectoryParameters::updateP(), FWPFRhoPhiRecHit::updateScale(), root::helper::RootVarsAdapter< F, 1 >::value(), GsfEleDeltaBetaIsoCutStandalone::value(), GsfEleEffAreaPFIsoCut::value(), GsfEleDeltaBetaIsoCut::value(), root::helper::RootVarsAdapter< F, 2 >::value(), JetPartonNamespace::ParametrizationJetParton::value(), SiStripTemplate::vavilov2_pars(), SiPixelTemplate::vavilov2_pars(), SiStripTemplate::vavilov_pars(), SiPixelTemplate::vavilov_pars(), FWCaloRecHitDigitSetProxyBuilder::viewContextBoxScale(), FWPFCandidateWithHitsProxyBuilder::viewContextBoxScale(), VVIObjF::VVIObjF(), WatcherStreamFileReader::WatcherStreamFileReader(), sistrip::MeasureLA::write_report_text_ms(), edm::JobReport::JobReportImpl::writeInputFile(), VirtualJetProducer::writeJets(), edm::JobReport::JobReportImpl::writeOutputFile(), MSLayer::x0(), SiStripTemplate::xflcorr(), SiPixelTemplate::xflcorr(), geometryXMLparser.MuonGeometry::xml(), TkRadialStripTopology::xOfStrip(), SiStripTemplate::xsigma2(), SiPixelTemplate::xsigma2(), SiPixelTemplate2D::xysigma2(), SiPixelTemplate2D::xytemp(), SiPixelTemplate::yflcorr(), SiPixelTemplate::ysigma2(), edm::service::InitRootHandlers::~InitRootHandlers(), and TestPythiaDecays::~TestPythiaDecays().

double g[11][100]

Definition at line 79 of file MuScleFitUtils.cc.

TF1* GL
Initial value:
= new TF1 ("GL",
"0.5/3.1415926*[0]/(pow(x-[1],2)+pow(0.5*[0],2))*exp(-0.5*pow((x-[2])/[3],2))/([3]*sqrt(6.283185))",
0, 1000)

Definition at line 83 of file MuScleFitUtils.cc.

Referenced by MuScleFitUtils::massProb(), and MuScleFitBase::readProbabilityDistributionsFromFile().

TF2* GL2
Initial value:
= new TF2 ("GL2",
"0.5/3.1415926*[0]/(pow(x-[1],2)+pow(0.5*[0],2))*exp(-0.5*pow((x-y)/[2],2))/([2]*sqrt(6.283185))",
0, 200, 0, 200)

Definition at line 87 of file MuScleFitUtils.cc.

double isum
double mzsum

Definition at line 76 of file MuScleFitUtils.cc.